Maple 2015 Questions and Posts

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

If I enter the following I do not get the residue... how do I make the residue command work?

 

is it possible to express rational number into fraction in terms of power of 2

input

2.142857143

output

(2^3+2^2+2+1)/(1+2+2^2)

ode1a := diff(y1(tt),tt) = round(rhs(odeparm1[1][1]))*y1(tt) + round(rhs(odeparm1[1][2]))*y2(tt) + round(rhs(odeparm1[1][3]))*y3(tt);
ode2a := diff(y2(tt),tt) = round(rhs(odeparm1[1][4]))*y1(tt) + round(rhs(odeparm1[1][5]))*y2(tt) + round(rhs(odeparm1[1][6]))*y3(tt);
ode3a := diff(y3(tt),tt) = round(rhs(odeparm1[1][7]))*y1(tt) + round(rhs(odeparm1[1][8]))*y2(tt) + round(rhs(odeparm1[1][9]))*y3(tt);
sys := subs(y3(tt)=1,[ode1a,ode2a]);
print(DEplot(sys, [y1(tt), y2(tt)], tt = 0 .. 16, y1 = -16 .. 16, y2 = -16 .. 16, color = magnitude, title = `Stable Limit Cycles`, arrows = curve, dirfield = 800, axes = none));

 

how to mirror the vector field graph mathematically?

mirror the graph about x=0 this line,

so that the graph looked flip

i find curl can do, but how to do ?

 

restart;
with(VectorCalculus):
SetCoordinates('cartesian'[x(t), y(t), z(t)]);
Curl((x(t),y(t),z(t)),(Diff(x(t),t) - a11*x(t) - a12*y(t) - a13*z(t),Diff(x(t),t) - a21*x(t) - a22*y(t) - a23*z(t),Diff(x(t),t) - a31*x(t) - a32*y(t) - a33*z(t)));
Error, (in VectorCalculus:-SetCoordinates) coordinate system `cartesian[x(t), y(t), z(t)]` does not exist
Error, (in Vector) dimension parameter is required for this form of initializer

 

Hello everybody

I'm using discrete distributions from the Statistics package and I found a rather strange result.

In short the theoritical values of some statistics of a NegativeBinomial(1, P) Random Variable (P being the probability of success equal to 1e-4) are correctly computed, but their empirical estimators computed from a sample of this RV are roughly wrong.

For NegativeBinomial(1, P) is similar to Geometric(P) I asked Maple to compute the theoritical values of some statistics of Geometric(P) and next to assess their empirical values from a sample of Geometric(P).
Some discrepancies still remain but they can be explained by statistical fluctuations.

Could you please look to the attached file (an error on my part is still possible) and help me to fix this ?

Thanks in advance


PS : the histogram of Sample(NegativeBinomial(K, P), AnySizeYouWant) is obviously wrong (it should look like a decreasing exponential) 


 

Download NegativeBinomial.mw

Dear all,

I'm trying to plot dispersion curves in Maple but I'm having some trouble. The code is attached as a file also.

f1  is my main function and I want to plot Vx with regard to f as all the rest are known variables, but I'm not able to do so.

I hope that someone can tell me why do I have this error.

Thanks in advance!

restart;
f1 := (C33*Rp*kzp+C13*kx)*(Rm*kx+kzm)*sin(kzp*h)*cos(kzm*h)-(C33*Rm*kzm-C13*kx)*(Rp*kx+kzp)*sin(kzm*h)*cos(kzp*h)=0;
Rp := (-C11*kx^2-C55*kzp^2+omega^2*rho)/((C55+C13)*kx*kzp);
Rm := (-C11*kx^2-C55*kzm^2+omega^2*rho)/((C55+C13)*kx*kzm);
kzp := sqrt(((-M+sqrt(M^2-4*N))*(1/2))*kx^2);
kzm := sqrt(((-M-sqrt(M^2-4*N))*(1/2))*kx^2);
M := (C11*C33/rho^2-2*C55*C13/rho^2+C13^2-omega^2*(C33+C55)/(rho*kx^2))*rho^2/(C33*C55);
N := (omega^2/kx^2-C11/rho)*(omega^2/kx^2-C55/rho)*rho^2/(C33*C55);
C11 := 0.435e10;
C13 := 0.259e10;
C55 := 0.112e10;
C33 := 0.108e11;
rho := 923;
h := 0.7e-2*(1/2);
kx := omega/Vx;
omega := 2*Pi*f;
f1;
plot(f1, f = 10 .. 0.100e6);
Error, (in plot) unexpected options: [(.4633081900*(-0.1717311166e12*f^2/Vx^2-0.2210791386e11*(...

Asim_dispers.mw

From clues:
a1 := subs(y=n,1/y!*x^y); # diff make it equal to the left term
a2 := subs(y=n-1,1/y!*x^y);
simplify(factor(a1 - a2));
 
To find limit of below
nterm := sum(tanh(product(sum(kk, kk=1..jj),jj=1..y))*1/y!*x^y, y=n..n);
n2term := sum(tanh(product(sum(kk, kk=1..jj),jj=1..y))*1/y!*x^y, y=(n+1)..(n+1));
simplify(factor(n2term - nterm));
simplify(limit((subs(x=x+h, n2term)-n2term)/h, h=0)) = nterm;
 
question is to find a limit make n2term equal nterm after calculation

unknown := sum(exp(product(sum(kk, kk=1..jj),jj=1..y))*1/y!*x^y, y=0..infinity):
evalf(subs(x=1, unknown));
plot(unknown, x=-3..3, numpoints = 5);
 

Dear friends!

Hope you would be fine. I want to solve the following system of ODEs

restart; L := 1; with(plots); Digits := 30;

a[1] := 0; a[2] := 1; a[3] := 2; a[4] := .2; a[5] := 4; a[6] := 6;

S := 1; Pr := 6.2; a := 1; a1 := 1; a2 := 1; lambda := 1; delta := 1; Bi := 1; A := 1; B := 1;

HA := [a[1], a[2], a[3]];

Eq1 := diff(F(eta), eta, eta, eta)+a*(a1*((F(eta)+G(eta))*(diff(F(eta), eta, eta))-(diff(F(eta), eta))^2)-M1*(diff(F(eta), eta))) = 0;

Eq2 := diff(G(eta), eta, eta, eta)+a*(a1*((F(eta)+G(eta))*(diff(G(eta), eta, eta))-(diff(G(eta), eta))^2)-M1*(diff(G(eta), eta))) = 0;

Eq3 := (A+B)*(diff(H(eta), eta, eta))+a2*Pr*(F(eta)+G(eta))*(diff(H(eta), eta)) = 0;

IC1 := F(0)+G(0)=0, (D(F))(0) = 1+delta*((D@@2)(F))(0), (D(G))(0) = lambda+delta*((D@@2)(G))(0), (D(H))(0) = -Bi*(1-H(0)), (D(F))(L) = 0, (D(G))(L) = 0, H(L) = 0;

params := {B111 = .2};
associated with the above (mentioned as red) boundary conditions. The problem which I faced in first condition i.e., F(0)+G(0)=0 because its combine condition for F(eta) and G(eta) which should be use for both function. The rest part of my program is below:

for k to nops(HA) do;

P || k := plots:-odeplot(dsolve(eval({Eq1, Eq2, Eq3, IC1}, `union`(params, {M1 = .5, phi = HA[k]})), numeric), [[eta, diff(F(eta), eta)]], linestyle = [solid, solid, solid, solid][k], color = [red, green, blue, red][k], labels = [eta, f], thickness = 3) end do;

f1 := plots:-display(P || (1 .. nops(HA)));

display(f1, axes = boxed, size = [380, 310], title = "Ethylene glycol/Cu: M = 2, S = -5", titlefont = ["Arial", 12, bold]);

Please fix my problem ASAP. I also attach the maple file. Thanks in advance.

Help.mw

g3 := tanh(x+1);
a:=eval(diff(g3,x$n)/n!, x=0) assuming n>=0:
tanhx := sum(a*x^n, n=0..infinity):
tanhx2 := subs(x^n=subs(_C1=0, subs(t=n!, g2))*x^n, tanhx):
diff(tanhx2, x) - tanhx2;
 

would like to find a operator to make it equalt to itself , a new differential operator for new transcendental function tanhx2

g3 := 2*(1+exp(4*x))/(exp(4*x)-1);
a:=eval(diff(g3,x$n)/n!, x=0) assuming n>=0:
hello := sum(a*x^n, n=0..infinity):

it run a very long time like endless
 

Dears,

I have seen a Mathematica code which I would like to have it in Maple, since I do not know that program. Let f(z) an analytic function, say f(z):=1+2^{z+1}+3^{z}. To find the roots of f(z) in a regingion, we can use in Maple the command "Analytic" (of the package "RootFinding"). However, in Mathematica is used the following:

L = 20; Monitor[zeros = Flatten@Table[N[z /. Solve[f[z] ⩵ 0 && k L ≤ Re[z] ≤ k L + L && -10 < Im[z] < 10, z], 25],{k, 300}],k];

What means the "N[z/. Solve..." instruction? Also, the following command:

SortBy[zeros, Re]; 

Can be "translated" to Maple?

 

Many thaks in advance for your comments!

With Regards,

G.

Hi there,

The command

           dsolve(MyOde, numeric, range=MyRange, method=rosenbrock, output=piecewise)

returns a list of solution pieces which is not sufficiently dense according to how I intend to use it.


Is there a possibility to impose the "number of pieces" or the positions of the "breaks" in this command ?

Thanks in advance for any suggestion.

 

my problem is how to put the third order IVP in derivate code for solving third order problems

the problem is y'''+2y"-9y'-18y=18x^2-18x+22

 

Digits := 18;
with(LinearAlgebra);
f := proc (n) -----;

derivative

g := proc (n)----- ;

please i need to know to to reresent it in the f := proc (n) and g := proc (n) where g := proc (n) is the derivative of f(x).

please any help 

Hi everybody,

 

I want to plot many curves in the form of a table.

For instance, let    p := plot(x, x=0..1, labels=[x*Unit('m'), y*Unit('m')]):

The command   plots:-display(p)  returns a plot  with labels x [[m]] and y [[m]], just as expected.

But the commands (remember I have several plots)
                             plots:-display(<p>);                              # and the generalization plots:-display(<p | p>)
                             DocumentTools:-Tabulate([p]);           # and the generalizationDocumentTools:-Tabulate([p,p])
both provide labels  x Units:-Unit('m') and  y Units:-Unit('m')

Is there a way to fix this and obtain plots withe the expected labels ?

Thank to all of you for yout help

 i need a help on how to find the local truncation error of a hybird block method of three order IVP. here is the one of the discrete methods i need to find the local truncation error. please any solution should put here thanks 

First 25 26 27 28 29 30 31 Last Page 27 of 71