Maple 12 Questions and Posts

These are Posts and Questions associated with the product, Maple 12

If decimal place is 1 such as 123.1 as input matrix and output matrix is eigenvector

is there a easy way to see changes of eigenvector in graph ?

because 3 x 3 matrix has 9 elements 

and eigenvector each vector may not fix in place,

how do mathematician observe the perturbation in this case?

would like to find which changes can cause different in eigenvectors

 

I can calculate real number eigenvector with QR algorithm from rotation matrix

but this real number is just magnitude of complex number

what is the rotation matrix for calculating complex number?

what algorithm do maple use to calculate fraction eigenvector?

are complex decimal and complex fraction eigenvectors are two different algorithm?

with(LinearAlgebra):
A := Matrix([[1,2,3],[4,5,6],[7,8,9]]);
v, e := Eigenvectors(A):
evalf(e);
A := Matrix([[1,2,3+0*0.1],[4,5,6+0*0.1],[7,8,9+0*0.1]]);
v, e := Eigenvectors(A):
evalf(e);

Rayleigh's identity is listed below:


              infinity                                           
               -----                                             
                \                                                
                 )             2      /      2        1      1  \
                /        |f(k)|  = int||f(t)| , t = - - T .. - T|
               -----                  \               2      2  /
            k = -infinity                                        

 

sum(abs(f(k))^2, k = -infinity .. infinity) = int(abs(f(t))^2, t = -(1/2)*T .. (1/2)*T);

This identity is an extension from Parseval's theorem for the case where the function of interest is periodic.  The link below provides a worksheet that confirms for a finite series that Rayleigh's identity is valid to within so many significant figures as the frequency parameter, k, increases for CASE 1.  However, for CASE 2 concurrence between the integral and the finite series is not that great.  I suspect I have an error somewhere that is causing the discrepancy.  I thought it might be useful if I get other sets of eyes on this to help isolate the discrepancy.  How I came up with Ck for CASE 2 I can create another worksheet with that derivation if requested.

Rayleighs_identity.mw

Appreciate any useful feedback

 

in maple 12,

i follow https://en.wikipedia.org/wiki/Eigenvalue_algorithm

it said QR return eigenvector but after compare with eigenvector function, they are not the result from eigenvector function

with(LinearAlgebra):
M := Matrix([[1,2,3],[4,5,6],[7,8,9]]);
A := HessenbergForm(M);
Q1, R1 := QRDecomposition(A);

Q1, R1 := QRDecomposition(M);

v, e := Eigenvectors(M);
v, e := evalf(Eigenvectors(M));
 

in maple 2015

if start from GivensRotationMatrix , how many times of 

GivensRotationMatrix in order to calculate the result of QR decomposition?

can this QR decomposition calculate the result of eigenvector?

MAPLE will evaluate the 1st integral below, but not the 2nd.  Is it possible to get MAPLE to do the evaluation?  I know it can be done numerically, but what about analytically?

int(sin(Pi*x*n/T), x);

 

int(sin(Pi*x*n/T), x)

int(sin(Pi*x*n/T)*cos(Pi*x*n/T)/(sin(Pi*x/T)*cos(Pi*x/T)), x);

int(sin(Pi*x*n/T)*cos(Pi*x*n/T)/(sin(Pi*x/T)*cos(Pi*x/T)), x)

I have 6 parameters, say p1 - p6, which enter my Monte Carlo Code and computes a 1-D Array of floats of size 1000 . I have an experimental array of floats of the same size. My code outputs an array which is the difference of these two arrays. The objective function is the sum of the sqares of the elements in this output array. I have initial guess for the parameters: p1i - p6i. I need to find the values of the 6 parameters which minimize the objective function.

Obviously I do not have an explicit mathematical form for the objective function and nor its Jacobian.

Could some one please help me in this task.  Thanks in advance. 

I have a spike train which is a series of time points, for example saved as a vector of floats. Could someone tell me how I can plot this spike train as a series of vertical bars at each of these time points ?

I would also like to know how to plot a series of spike trains one above the other[i.e. the raster plot] if I start with a 2-D matrix of floats where each row correspond to one spike train.

Thanks in advance.

  

This should be a simple problem, but I am having trouble resolving a contradiction in integral evaluation that is included in the results below.  Instead of butting my head further perhaps someone can point out my probable error.

You will see in both cases I have a triangle signal with a slope of (-1).  However in the 2nd case I have linked the period T to the slope parameter alpha.  If I assign alpha=1 then the results of the 2 integrals should = 1/4, but the 2nd one does not.

Appreciate any feedback.


 

plot(piecewise(-1 < x and x < 0, 0, 0 < x and x < 1, 1-x), x = -2 .. 2, linestyle = solid, thickness = 5, scaling = constrained, title = "Asymmetric Triangle Wave", titlefont = [COURIER, 18])

 

n := 0; 1; T := 2; 1; a[0] := (int(0*exp(-I*(2*Pi*n*t/T)), t = -(1/2)*T .. 0)+int((1-t)*exp(-I*(2*Pi*n*t/T)), t = 0 .. (1/2)*T))/T

1/4

(1)

restart

alpha := 1; T := 2/alpha; plot(piecewise(x < 0, 0, 0 < x and x < (1/2)*T, -alpha*x+1), x = -T .. T, linestyle = solid, thickness = 5, scaling = constrained, title = "Asymmetric Triangle Wave", titlefont = [COURIER, 18])

 

  n=0 term:n := 0; 1; alpha := 1; 1; T := 2; 1; a[0] := (int(0*exp(-I*(2*Pi*n*t/T)), t = -(1/2)*T .. 0)+int((1-alpha*T)*exp(-I*(2*Pi*n*t/T)), t = 0 .. (1/2)*T))/T

-1/2

(2)

``


 

Download integral_contradiction.mw

I am seeking the limit of a series representation of a waveform to within so many significant figures.  Unfortunately, as the series contains more & more terms the demands on computation memory become a problem.  Perhaps there is a method within MAPLE I am not familiar with that can possibly circumvent this problem?

Below is the link to my worksheet.  The presumed theoretical limit is supposed to be 0.0894945 (this is based on what I have read)  (perhaps it may be wrong).  So far I have 3 of the sig figs agree, but would like to take it further.  Is this possible with different MAPLE commands than what I am currently employing?  Currently, MAPLE crashes if I venture beyond 100000 terms in the series.

seeking_the_limit.mw

I was recently cleaning up a worksheet to make things more succinct.  In that process I modified how I expressed the series coefficients, Ck.  What seemed to be an innocous change apparently upset MAPLE to the point it cannot process my results.  In the abbreviated worksheet link below I process the results in the previous manner, Ck1, as opposed to my current modification, Ck2.

In the previous manner the results are generated under 3 minutes.  After modifying the expression for Ck, MAPLE cannot seem to process the results at all.  As far as I can tell the Ck1 & Ck2 concur.  So I am perplexed.  Can anyone see what is wrong?  The only thing I can think of is that sin(2*pi*k/T*x) in the denominator might cause the problem.  However, the sin term is cancelled out by the same sin term in S4.

Ck_modification.mw

I originally posted this question @ Reconciling roots of a series  However, I got no responses.  I have done further work on the problem & attempted to delete my original posting to initiate this one.    I did not see the option to delete Reconciling roots of a series.  So if any website moderator can delete the original & leave this one stand that would be helpful.  The results in this posting are more illuminating.

I have an infinite series that is function of


                                   /2 Pi k x\
                               sin|--------|
                                     \   T    / where k is the frequency parameter that is an integer value from 1 to m.  The series is also linearly dependent on the coefficient, Ck.  However, Ck is nonlinear with respect to k.  3 other parameters are undefined, a0, N, & tau.  Taking the derivative of the series removes the constant a0 & the factor (2 Pi k)/T comes out of the sin term & the sin term bcomes a cos term.  N is a positive integer & tau is a real #, generally between 0 & 1.

The derivative of the series can be evaluated since Ck falls of by 1/k^2 which renders the factor (2 Pi k)/T to (2 Pi)/T.  All is well & MAPLE seems to confirm that by the result (5).  I then attempt to find the roots of the derivative after defining the values for m, a0, N, & tau with both the solveRootFinding:-Analytic commands.  The results from the 2 do not seem to coincide.

I then repeat the process with chek2.  Now there seems to be some overlap in the results.  But as I pointed out in Reconciling roots of a series in the case of chek the series parameters m, a0, N, & tau have not been assigned values.  In the case of chek2 those parameters do have assigned values; hence, the solution characteristics are different for the solve command, but not for RootFinding:-Analytic.

In a different problem, but somewhat related someone pointed out the superior computational performance of the RootFinding:-Analytic as opposed to the solve command.  The results here if I interpret them correctly suggest that the solve command can be WRONG altogether.  Can this be explained in a concise & coherent manner that most users can follow?  Also, solve can produce an analytic expression as opposed the RootFinding:-Analytic command.  Is there a way to use the RootFinding package to produce an analytical result?  In the case presented below I suppose the analytic result for solutions to chek would be JUNK?

reconcile_solns.mw

I employed the sort command to sort through 10 solutions to a series of order 10.  However, I do not follow the logic of the output.  So I attempted to sort by ascending order by the magnitude, but I am getting errors which I am having trouble circumnavigating.  Can show me how to sort my solutions properly?

The worksheet is in my reply below.

1.

with(Groebner):
K := {r-x^4,u-(x^3)*y,v-x*y^3,w-y^4};
G := Basis(K, 'tord', degrevlex(r,u,v,w));
R1 := eliminate(G, {r,u,v,w}); # eliminate is the reverse of Basis
Ga := Basis({a*G[1],a*G[2],a*G[3],a*G[4],a*G[5],a*G[6],a*G[7],a*G[8],a*G[9],a*G[10],a*G[11],a*G[12],a*G[13],a*G[14], (1-a)*K[1], (1-a)*K[2], (1-a)*K[3], (1-a)*K[4]}, 'tord', deglex(a,r,u,v,w));
Ga := remove(has, Ga, [x,y,a]);
eliminate(Ga, [r,u,v,w]);

how to eliminate Ga to find back K ?

2.

A1A2 and A3A4 parallel
A(0,0), B(u1,0), D(u2,u3), C(x1,x2), E(x3,x4)
#BC = A1A2
xx1 := u1:
xx2 := x1:
yy1 := 0:
yy2 := x2:
#AD = A3A4
xx3 := 0:
xx4 := u2:
yy3 := 0:
yy4 := u3:
eq1 := (xx2 - xx1)*(yy4 - yy3) - (yy2 - yy1)*(xx4 - xx3);
(x1-u1)*u3-x2*u2;
#CD = A1A2
xx1 := x1:
xx2 := u2:
yy1 := x2:
yy2 := u3:
#AB = A3A4
xx3 := 0:
xx4 := u1:
yy3 := 0:
yy4 := 0:
eq2 := (xx2 - xx1)*(yy4 - yy3) - (yy2 - yy1)*(xx4 - xx3);
-(u3-x2)*u1;
with(LinearAlgebra):
#E is on the same line of AC
xx1 := x3:
yy1 := x4:
xx2 := 0:
yy2 := 0:
xx3 := x1:
yy3 := x2:
eq3 := Determinant(Matrix([[xx1,yy1,1],[xx2,yy2,1],[xx3,yy3,1]]));
-x3*x2+x1*x4;
#E is on the same line of BD
xx1 := x3:
yy1 := x4:
xx2 := u1:
yy2 := 0:
xx3 := u2:
yy3 := u3:
eq4 := Determinant(Matrix([[xx1,yy1,1],[xx2,yy2,1],[xx3,yy3,1]]));
-x3*u3+u1*u3-u1*x4+u2*x4;
 

sol := eliminate({eq1,eq2,eq3,eq4},[x1,x2,x3,x4]);

with(Groebner):
K := {(rhs(sol[1][1])-lhs(sol[1][1])),(rhs(sol[1][2])-lhs(sol[1][2])),(rhs(sol[1][3])-lhs(sol[1][3])),(rhs(sol[1][4])-lhs(sol[1][4]))};
G := Basis(K, 'tord', degrevlex(x1,x2,x3,x4));
R1 := eliminate(G, {x1,x2,x3,x4}); # eliminate is the reverse of Basis
Ga := Basis({a*G[1],a*G[2],a*G[3],a*G[4], (1-a)*K[1], (1-a)*K[2], (1-a)*K[3], (1-a)*K[4]}, 'tord', deglex(a,x1,x2,x3,x4));
Ga := remove(has, Ga, [u1,u2,u3,u4,a]);

From Question1, is it possible to find from sol to eq1, eq2, eq3 and eq4 ?

For example

if x*y*z+ x*y^2

after filter 

x*y*z

First 7 8 9 10 11 12 13 Last Page 9 of 32