Maple 17 Questions and Posts

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

I have written a code that computes the fourier-bessel series of a function over the period [a,b].
When I wanted to get some numerical results, I noticed that it takes lots of time for maple to numerically compute the coefficients of the series. Each coefficient of the series is expressed in terms of some integrals that I was expecting maple to compute them in few seconds, however, when  I want to compute "N=100" terms of the series, it takes lots of time.

I was wondering if there is any way to boost up the numerical computation time. I will appreciate any help.

Below you can find my code.

Example_2.mw

Many many thanks for your attentions! :)

can maple 17 make serial communication with arduino such as i wan to get data from accelerometer then the data will display in maple 17

Hi! I'm trying to solve a system of four non-linear equations in Maple 17 but it doesn't work.

Equations are: F, Fw, Ft, Fk and varibles are T,w,k,ki.

Parametars are Mn=10, Ms=2, alfa=0.2 and Tf=(k*T^(alfa)/Mn)^(1/alfa).

Solutions must be positive. 

This is maple script:

restart;
> assume (w>0):
> assume (T>0):
> assume (k>0):
> assume (ki>0):
> assume (Mn>0):
> assume (Ms>0):
> assume (Tf>0):
> assume (alfa>0):


> Gp:=1/exp(sqrt(w*I));

> Cf:=((T*w*I+1)/(Tf*w*I+1));

> Cpi:=(k*w*I+ki)/(w*I);

> L:=Cf*Cpi*Gp;
> L:=evalc(L):
> F:=subs(Ms=2,Tf=(k*T^(alfa)/Mn)^(1/alfa),evalc(abs(1+L)^2-1/Ms^2));
> F:=subs(Mn=10,alfa=0.2,evalc(F));

> Fw:=diff(F,w):
> Fk:=diff(F,k):
> Ft:=diff(F,T):
> fsolve({F,Fw,Fk,Ft},{w,k,ki,T});

Thanks in advance for any help. Dragoslav

I have some lengthy formulas in the maple. I don't want to waste time on rewritting them in a word document.
Is there a way to import those equations in a clean and tidy form to a word document or the mathtype program or something else! :)

1-Suppose that after applying the command "factor(f)" the "f "takes the form:

f=(BesselJ(0,r))*(A very lengthy term)

Is there a way to force maple to show f like below:

f=(A very lengthy term)*(BesselJ(0,r))


2-Suppose f is written as follows:

f=a*b*x+a*b*y

Can you suggest a way (without using "op" command) to write f as:

f=a*(b*x+b*y)

I have used the command "op" in a code that I have written with Maple 17. When I restart the maple server and run the whole code again, the result of the "op" command changes! why is this happening?

I tried to get the limit for this sqrt(-2*cos(alpha)*cos(alpha+d)+2-2*sin(alpha+d)*sin(alpha))/d, from right side

input

limit(sqrt(-2*cos(alpha)*cos(alpha+d)+2-2*sin(alpha+d)*sin(alpha))/d, d = 0, right);

return

sqrt(-signum(-2+2*cos(alpha)^2+2*sin(alpha)^2))*infinity;

when tried for next time

limit(combine(sqrt(-2*cos(alpha)*cos(alpha+d)+2-2*sin(alpha+d)*sin(alpha))/d), d = 0, right);

return

1

note that the expression evaluated is the same, but returns different answers, is there somebody know why or how to avoid maple to return wrong answers

I am trying to find a way to take the rows of a matrix and put them in a sequence.  For example if i have the matrix 

M:=Matrix(3,[[1,1,1],[2,2,2],[3,3,3]]);

I want to rewrite it as S:= {111222333}.  

Sorry if this is not clear.  I know how to create a sequence, but I want to be able to use the Matrix and output a sequence without manually inputing the numbers.  

Thank you in advance for your help.  

RandomCompositions:= proc(n::posint, k::posint)
local
C,
Compositions:= [seq(C-~1, C= combinat:-composition(n+k, k))],
Rand:= rand(1..nops(Compositions))
;
()-> Compositions[Rand()]
end proc:

R:= RandomCompositions(9,6):
n:= 2^13:
S:= 'R()' $ n:

 

I want to compile statistics each number in a sequence cannot  occur  over twice.

The sequences that do not fit the rule above must be ommitted.

The statistic is  Fermi-Dirac statistics.

confused the Bose-Einstein condensation and Fermi-Dirac statistics.

But the theory is right.

I have a polynomial p in two variables x and y, and I want to extract all the coefficients of p. For example, let p:=x^3+2*x*y^2-2*y^2+x, and I want to obtain the coefficient vector [1,0,0,1,0,2,0,0,-2,0], where 1,0,0,1,0,2,0,0,-2,0 are respectively the coefficients of x^3, x^2, x^2*y,x,x*y,x*y^2,y^0,y,y^2,y^3. In general, let 

p(x,y)=sum(sum(c_*{i, j}*x^(n-i)*y^j, j = 0 .. i), i = 0 .. n)

=c_{0,0}x^n

+c_{1,0}x^{n-1}+c_{1,1}x^{n-1}y

+c_{2.0}x^{n-2}+c_{2,1}x^{n-2}y+c_{2,2}x^{n-2}y^2

+\dots

+c_{n,0}+c_{n,1}y+c_{n,2}y^2+\dots+c_{n,n}y^{n}.

It is possible that some coefficients c_{i,j} are equal to 0. How to obtain the coefficient vector [c_{i,j},i=0..n,j=0..i] of p(x,y)?

Thanks a lot.

RandomCompositions:= module()
local
Compositions, Rand,
ModuleApply:= proc(n::posint, k::posint)
local C;
Compositions:= [seq(C-~1, C= combinat:-composition(n+k, k))];
Rand:= rand(1..nops(Compositions));
()-> Compositions[Rand()]
end proc
;
end module:
R:= RandomCompositions(8,6):
n:= 3:
S:= 'R()' $ n;
map(lhs=rhs/n, Statistics:-Tally(op~([S])));

[0 = 7/3, 1 = 5/3, 2 = 4/3, 5 = 1/3, 6 = 1/3]

plot([S],x=0..8,style=point);

I have  plot problem .

I want to plot the statistics result,but it runs error.

 

 

RandomCompositions:= module()
local
Compositions, Rand,

RandomCompositions:= module()
local
Compositions, Rand,
ModuleApply:= proc(n::posint, k::posint)
local C;
Compositions:= [seq(C-~1, C= combinat:-composition(n+k, k))];
Rand:= rand(1..nops(Compositions));
()-> Compositions[Rand()]
end proc;

end module:
R:= RandomCompositions(8,6):
seq(R(),i=1..10);

[0, 0, 2, 6, 0, 0], [1, 0, 0, 3, 4, 0], [0, 3, 3, 2, 0, 0],[1, 2, 4, 0, 1, 0], [0, 4, 0, 1, 3, 0],

[2, 0, 1, 4, 1, 0],[2, 0, 1, 1, 3, 1], [1, 0, 4, 2, 1, 0], [1, 3, 0, 2, 0, 2],[2, 0, 3, 2, 1, 0]

with(Statistics):
Tally(R());
[0 = 1, 1 = 4, 4 = 1]

I want to count the 0 to 8 respectively summation,and divide by i.

 But the  seq command  R() isn't conform  with Tally command R() .

Thanks.

 

Hello.

I am trying to extract all the coefficients of a linear equation by calling coeffs function.

eq := 1.2*a[2]+1.3*a[3]+1.1*a[1]+1.0

1.2*a[2]+1.3*a[3]+1.1*a[1]+1.0

(1)

 

vars := [seq(a[i], i = 1 .. 3)]

[a[1], a[2], a[3]]

(2)

coeffs(eq, vars)

1.0, 1.2, 1.3, 1.1

(3)

``


I expected I receive the coefficients in the same order as in vars variable, but I was wrong. How to extract coefficients in the order I need?

Download test.mw

 


Dear users,

In my attached file I have two PDES, (PDE1 and PDE2). PDE1 is a function of v(t) and w(x,t) and PDE2 is also a function of v(t) and w(x,t). I can solve PDE2 if I say v(t) is 1 for example and you can see the plot. But what if I put v(t) back in PDE2 and want to find v(t) and w(x,t) from PDE1 and PDE2 together? 

Many Thanks,

Baharm31

 

Define PDE Euler-Bernoulli Beam

 

NULL

restart:

Parametrs of piezoelectric and cantilever beam

 

``

Ys := 70*10^9: # Young's Modulus structure

Yp := 11.1*10^10: # Young's Modulus pieazo

ha := -0.00125: # Position

hb := 0.001: # Position

hc := 0.0015: # Position

d31 := -180*10^(-12): # Piezoelectric constant

b := 0.01: #Width of the beam

tb := 0.002:

epsilon33 := 15.92*10^(-9):

hp :=0.00025: # Position

hpc := 0.00125: # Position

YI := b*(Ys*(hb^3- ha^3)+Yp*(hc^3-hb^3))/3: # Bending stiffness of the composit cross section

cs := 0.564: # The equivqlent coefficient of strain rate damping

ca := 0: # Viscous air damping coefficient

Ibeam := (b * tb^3 )/12: # The equivalent moment of inertia

m := 0.101: # Mass of the structure

upsilon := - Yp*d31*b*(hc^2-hb^2)/(2*hp): # Coupling term

lb := 0.57:# Length of the structure (Cantilever Beam)

lp := 0.05:# Length of the Piezoelectric

R:= 10000: # Shunted resistor

Electrical circuit equation

 

PDE1:=(epsilon33 * b*lp / hp) * diff(v(t), t) + (v(t)/R)+ int(d31*Yp*hpc*b* diff(w(x, t),$(x, 2))*diff(w(x, t), t),x = 0..lp)=0;

0.3184000000e-7*(diff(v(t), t))+(1/10000)*v(t)+int(-0.2497500000e-3*(diff(diff(w(x, t), x), x))*(diff(w(x, t), t)), x = 0 .. 0.5e-1) = 0

(1.1.1.1)

``

 

PDE Equation

 

fn := 3.8:# Direct Excitation frequency;

wb(x,t) := 0.01*sin(fn*2*Pi*t):#Direct Excitation;

plot(wb(x,t),t = 0 .. 0.25*Pi,labels = [t,wb], labeldirections = ["horizontal", "vertical"], labelfont = ["HELVETICA", 15], linestyle = [longdash], axesfont = ["HELVETICA", "ROMAN", 10], legendstyle = [font = ["HELVETICA", 10], location = right],color = black);

 

 

FunctionAdvisor(definition, Dirac(n,x));

[Dirac(n, x) = (1/2)*(Int((I*_k1)^n*exp(I*_k1*x), _k1 = -infinity .. infinity))/Pi, `with no restrictions on `(n, x)]

(1.2.1)

 

PDE2 := YI*diff(w(x, t),$(x, 4))+ cs*Ibeam*diff(w(x, t),$(x, 4))*diff(w(x, t), t)+ ca* diff(w(x, t), t) + m * diff(w(x, t),$(t, 2))+ upsilon*v(t)*(Dirac(1,x) -Dirac(1,x-lp) ) =-m*diff(wb(x, t),$(t, 2))-ca*diff(wb(x, t), t);#PDE

1.567812500*(diff(diff(diff(diff(w(x, t), x), x), x), x))+0.3760000000e-11*(diff(diff(diff(diff(w(x, t), x), x), x), x))*(diff(w(x, t), t))+.101*(diff(diff(w(x, t), t), t))+0.4995000000e-3*Dirac(1, x)-0.4995000000e-3*Dirac(1, x-0.5e-1) = 0.583376e-1*sin(7.6*Pi*t)*Pi^2

(1.2.2)

tmax := 0.3:

xmin := 0:

xmax := lb:

N := 20:#NUMBER OF NODE POINT

bc1 := dw(xmin, t) = 0:

bc2 := dw(xmax, t) = 0:

bc3 := w(xmin, t) = 0:

ic1 := wl(x, 0) = 0:

Maple's pdsolve command

 

 

 

bcs := { w(x,0)=0 , D[2](w)(x,0)=0 , w(0, t) = rhs(bc1), D[1](w)(0, t)= rhs(bc1), D[1,1](w)(lb,t) = rhs(bc2), D[1,1,1](w)(lb,t) = rhs(bc2)}; # Boundary conditions for PDE2.

{w(0, t) = 0, w(x, 0) = 0, (D[1](w))(0, t) = 0, (D[2](w))(x, 0) = 0, (D[1, 1](w))(.57, t) = 0, (D[1, 1, 1](w))(.57, t) = 0}

(2.1)

PDES := pdsolve(PDE2, bcs, numeric, time = t, range = 0 .. xmax, indepvars = [x, t], spacestep = (1/1000)*xmax, timestep = (1/1000)*tmax);

 

module () local INFO; export plot, plot3d, animate, value, settings; option `Copyright (c) 2001 by Waterloo Maple Inc. All rights reserved.`; end module

(2.2)

PDES:-plot3d(t = 0 .. tmax, x = 0 .. xmax, axes = boxed, orientation = [-120, 40], shading = zhue, transparency = 0.3);

 

 

NULL


Download Euler-Bernoulli_Beam-last_version.mw

First 31 32 33 34 35 36 37 Last Page 33 of 61