Maple Questions and Posts

These are Posts and Questions associated with the product, Maple

I have a list:
mylist := [x^4 + (-4*m - 7)*x^3 + (m + 4)*x^2 + (3*m - 5)*x, x^4 + (-4*m - 7)*x^3 + (m + 5)*x^2 + (5*m - 7)*x, x^4 + (-4*m - 7)*x^3 + (m + 5)*x^2 + (7*m - 5)*x, x^4 + (-4*m - 7)*x^3 + (2*m + 5)*x^2 + (3*m - 5)*x, x^4 + (-4*m - 7)*x^3 + (3*m + 1)*x^2 + (7*m - 10)*x, x^4 + (-4*m - 5)*x^3 + (2*m + 1)*x^2 + (7*m - 9)*x]

I use

L := map~(normal, mylist);

and get. 

L := [x^4 - (4*m + 7)*x^3 + (m + 4)*x^2 + (3*m - 5)*x, x^4 - (4*m + 7)*x^3 + (m + 5)*x^2 + (5*m - 7)*x, x^4 - (4*m + 7)*x^3 + (m + 5)*x^2 + (7*m - 5)*x, x^4 - (4*m + 7)*x^3 + (2*m + 5)*x^2 + (3*m - 5)*x, x^4 - (4*m + 7)*x^3 + (3*m + 1)*x^2 + (7*m - 10)*x, x^4 - (4*m + 5)*x^3 + (2*m + 1)*x^2 + (7*m - 9)*x].

I use seq to list L[i] and diff(L[i])

[seq([L[i], diff(L[i], x)], i = 1 .. nops(L))];

and get

[[x^4 - (4*m + 7)*x^3 + (m + 4)*x^2 + (3*m - 5)*x, 4*x^3 - 3*(4*m + 7)*x^2 + 2*(m + 4)*x + 3*m - 5], [x^4 - (4*m + 7)*x^3 + (m + 5)*x^2 + (5*m - 7)*x, 4*x^3 - 3*(4*m + 7)*x^2 + 2*(m + 5)*x + 5*m - 7], [x^4 - (4*m + 7)*x^3 + (m + 5)*x^2 + (7*m - 5)*x, 4*x^3 - 3*(4*m + 7)*x^2 + 2*(m + 5)*x + 7*m - 5], [x^4 - (4*m + 7)*x^3 + (2*m + 5)*x^2 + (3*m - 5)*x, 4*x^3 - 3*(4*m + 7)*x^2 + 2*(2*m + 5)*x + 3*m - 5], [x^4 - (4*m + 7)*x^3 + (3*m + 1)*x^2 + (7*m - 10)*x, 4*x^3 - 3*(4*m + 7)*x^2 + 2*(3*m + 1)*x + 7*m - 10], [x^4 - (4*m + 5)*x^3 + (2*m + 1)*x^2 + (7*m - 9)*x, 4*x^3 - 3*(4*m + 5)*x^2 + 2*(2*m + 1)*x + 7*m - 9]]

How can I insert L'(2), L''(2) and solve the systems L'(2) = 0 and L''(2) > 0 to get the solutions m?
like this
[seq([L[i], diff(L[i], x), solve([L'(2) = 0,L''(2)>0],m) ], i = 1 .. nops(L))]

I also tried
[seq([L[i], diff(L[i], x), eval(diff(L[i], x), x = 2), solve([eval(diff(L[i], x), x = 2) = 0], m)], i = 1 .. nops(L))]

to obtain 
[[x^4 - (4*m + 7)*x^3 + (m + 4)*x^2 + (3*m - 5)*x, 4*x^3 - 3*(4*m + 7)*x^2 + 2*(m + 4)*x + 3*m - 5, -41 - 41*m, {m = -1}], [x^4 - (4*m + 7)*x^3 + (m + 5)*x^2 + (5*m - 7)*x, 4*x^3 - 3*(4*m + 7)*x^2 + 2*(m + 5)*x + 5*m - 7, -39 - 39*m, {m = -1}], [x^4 - (4*m + 7)*x^3 + (m + 5)*x^2 + (7*m - 5)*x, 4*x^3 - 3*(4*m + 7)*x^2 + 2*(m + 5)*x + 7*m - 5, -37 - 37*m, {m = -1}], [x^4 - (4*m + 7)*x^3 + (2*m + 5)*x^2 + (3*m - 5)*x, 4*x^3 - 3*(4*m + 7)*x^2 + 2*(2*m + 5)*x + 3*m - 5, -37 - 37*m, {m = -1}], [x^4 - (4*m + 7)*x^3 + (3*m + 1)*x^2 + (7*m - 10)*x, 4*x^3 - 3*(4*m + 7)*x^2 + 2*(3*m + 1)*x + 7*m - 10, -58 - 29*m, {m = -2}], [x^4 - (4*m + 5)*x^3 + (2*m + 1)*x^2 + (7*m - 9)*x, 4*x^3 - 3*(4*m + 5)*x^2 + 2*(2*m + 1)*x + 7*m - 9, -33 - 33*m, {m = -1}]]

I need to extract the list of all powers present in multivariable polynomial. For example, for x+y+x^2y^2+y^d I want to get the list [(1,0),(0,1),(2,2),(0,d)]. How to perform this?

Hello Everyone;

I need help to solve the following system using rk-4 method

restart;
NULL;
NULL;
C := 1.0;
gK := 36.0;
gNa := 120.0;
gL := 0.3;
VK := -77.0;
VNa := 50.0;
VL := -54.0;
III := 20;
alpha_n := 0.01*(v(t) + 55.0)/(1 - exp(-1.0/10.0*v(t) - 11.0/2.0));
beta_n := 0.125*exp((-v(t))/80.0 + (-1)*13.0/16.0);
alpha_m := 0.1*(v(t) + 40.0)/(1 - exp(-1.0/10.0*v(t) - 4.0));
beta_m := 4.0*exp(-1.0/18.0*v(t) - 65.0/18.0);
alpha_h := 0.07*exp((-1)*(v(t) + 65.0)/20.0);
beta_h := 1/(1.0 + exp((-v(t) + 35.0)/10.0));

dsys1 := {diff(h(t), t) = alpha_h*(1 - h(t)) - beta_h*h(t), diff(m(t), t) = alpha_m*(1 - m(t)) - beta_m*m(t), diff(n(t), t) = alpha_n*(1 - n(t)) - beta_n(t), diff(v(t), t) = III - gK*n(t)^4*(v(t) - VK) - gNa*m(t)^3*h(t)*(v(t) - VNa) - gL*(v(t) - VL), h(0) = 0.9996937394, m(0) = 0.02890553447, n(0) = 0.2445865495, v(0) = -70};

HPM.mw

  • Please help me
  • How do I write Homotopy Perturbation method for a partial differential equation for this question in Maple?

Download HPM.mw

 

modifed_practice.mw

Impact of Shape-Dependent Hybrid Nanofluid on Transient Efficiency of a Fully W
et Porous Longitudinal Fin

dear sir please help me to solve the graph i given reference pdf also. i have implimented the code but getting error in ploting 

Thank you

Using the SingularValues command with any output type specified causes this error

Error, (in sanity) invalid input: LinearAlgebra:-SingularValues expects value for keyword parameter output to be of type {list(identical(U,S,Vt,list)), identical(U,S,Vt,list)}, but received [U, S, Vt]

Below is a minimal example to trigger the error. Is there something wrong about how I am calling the function?

restart:
with(LinearAlgebra):

sanity := proc()
  local A,U,S,Vt;
  A :=RandomMatrix(3,10);
  U,S,Vt := SingularValues(A, output=['U','S','Vt']);
end proc:

sanity();

Dear Maple experts,

I have a system of several nonlinear equaitons. My code can solve it for a given parameter. But when I want to plot it, it takes too much time with no results. So, I decided to plot it for several given points. I get the answer for the points individually, but I don't know how to apply this to 'plot' command. Would you please help?

restartNULL

with(plots); with(RealDomain)

NULL

c := 1; cr := 0.3e-1*c; u := 5; sExp := 0.6e-1*c; s := .65*c; v := 3*c

NULL

NULL

FirmModelPartial1 := proc (alpha, beta, delta) local L1s, qs, ps, prs, hs, `&kappa;s`, `&lambda;__1s`, `&lambda;__2s`, `&lambda;__3s`, q, p, pr, h, kappa, `&lambda;__1`, `&lambda;__2`, `&lambda;__3`, FirmpfSiS, RecpfSiS, UnsoldSiS, EnvironSiS, p0, OldSoldPrim, xi, prof1, prof2, L1, L2, E1, E2, E3, E4, E5, E6, E7, E8, E9, E10, E11, E12; prof1 := (ps-c)*qs+((1/2)*beta^2*`&kappa;s`^2/(u*(1-alpha))-(1/2)*(qs+beta*`&kappa;s`)^2/u)*(ps-s)+hs*prs*(beta*`&kappa;s`-(1/2)*beta^2*`&kappa;s`^2/(u*(1-alpha))); L1s := prof1+`&lambda;__1s`*(1-sExp/prs-hs)+`&lambda;__2s`*(qs-`&kappa;s`)+`&lambda;__3s`*(qs-alpha*beta*`&kappa;s`/(1-alpha)); E1 := qs*(diff(L1s, qs)) = 0; E2 := hs*(diff(L1s, hs)) = 0; E3 := `&lambda;__1s`*(1-sExp/prs-hs) = 0; E4 := `&lambda;__2s`*(qs-`&kappa;s`) = 0; E5 := `&lambda;__3s`*(qs-alpha*beta*`&kappa;s`/(1-alpha)) = 0; E6 := qs = alpha*u*(v-ps)/(v-s); E7 := prs = ps-delta*v; E8 := `&kappa;s` = (beta*prs*(1-hs)+sExp*(1-beta))/(beta^2*(prs*(1-hs)-sExp)/(u*(1-alpha))+2*cr); p, q, pr, h, kappa, `&lambda;__1`, `&lambda;__2`, `&lambda;__3` := (eval([ps, qs, prs, hs, `&kappa;s`, `&lambda;__1s`, `&lambda;__2s`, `&lambda;__3s`], solve({0 <= qs-alpha*beta*`&kappa;s`/(1-alpha), 0 <= qs-`&kappa;s`, 0 <= 1-sExp/prs-hs, 0 <= `&lambda;__1s`, 0 <= `&lambda;__2s`, 0 <= `&lambda;__3s`, diff(L1s, qs) <= 0, diff(L1s, hs) <= 0, c < ps, (1/2)*beta*`&kappa;s`/(u*(1-alpha)) < 1, sExp+delta*v < ps, E1, E2, E3, E4, E5, E6, E7, E8}, [ps, qs, prs, hs, `&kappa;s`, `&lambda;__1s`, `&lambda;__2s`, `&lambda;__3s`])[1]))[]; xi := kappa/q; FirmpfSiS := max(0, eval(prof1, [ps = p, qs = q, prs = p-delta*v, hs = h, `&kappa;s` = kappa])); RecpfSiS := ((1-h)*pr-sExp)*(beta*kappa-(1/2)*beta^2*kappa^2/(u*(1-alpha)))+(sExp-cr)*kappa; UnsoldSiS := (1/2)*(q+beta*kappa)^2/u-(1/2)*beta^2*kappa^2/(u*(1-alpha)); EnvironSiS := q+UnsoldSiS; return p, q, FirmpfSiS, RecpfSiS, EnvironSiS, h, UnsoldSiS, h, xi end proc

NULL

NULL

FirmModelPartial1(.1, .2, .1)[3]

Error, (in FirmModelPartial1) invalid subscript selector

 

NULL

FirmModelPartial1(.2, .2, .1)[3]

Error, (in FirmModelPartial1) invalid subscript selector

 

FirmModelPartial1(.3, .2, .1)[3]

.2200894743

(1)

NULL

FirmModelPartial1(.4, .2, .1)[3]

.2892440018

(2)

FirmModelPartial1(.5, .2, .1)[3]

.3801240291

(3)

FirmModelPartial1(.6, .2, .1)[3]

.4921660779

(4)

FirmModelPartial1(.7, .2, .1)[3]

.6227094789

(5)

FirmModelPartial1(.8, .2, .1)[3]

.7668402612

(6)

FirmModelPartial1(.9, .2, .1)[3]

.9161921261

(7)
 

plot('FirmModelPartial1(alpha, .2, .2)[3]', alpha = .1 .. .90, adaptive = false, sample = [.1, .2, .3, .4, .5, .6, .7, .8, .9])

 

Download Reza_Tchno_(v3).mw

Besdies, it seems for some points there is no feasible solution. So, there is no need to have plot for them.

I attach the code. Thank you so much!

dS/dt=qnv-alpha_1*S*H-mu_sh*S

dH/dt=lamda_h-alpha_1*S*H-mu_h*H

dI/dt=alpha_1*S*H-beta_1*I-mu_i*I

dS/dt=beta_1*I-delta_1*S-mu_s*S

DATA:

q=0.75; n=15;v=20; alpha_You1=0.001; S=2000; H=3000; mu_sh=0.000000000012; lambda=3000;mu_h=0.94; beta_1=0.125; I=0; mi_i=0.95; delta_1=0.0975; S=0; mu_s=0.029

Good day all,

please I am new Maple user, i used the same code to solve boundary layer flow. Itried to use the same code in solving nanofluid but the solution is not coverging at some point. But the author i want to compared my results with had solution at those points.

Is there any way i can get solution of this model at this with these values?. Please i need your help. Thank you in advance

secod_code.mw

NULL

restart

with*plots; ode1 := (1+1/bet)*(diff(f(eta), eta, eta, eta))-(diff(f(eta), eta))^2+f(eta)*(diff(f(eta), eta, eta))+Gr*(theta(eta)+lambda1*theta(eta)^2)+Gc*(phi(eta)+lambda2*phi(eta)^2)-M*(diff(f(eta), eta)) = 0

(1+1/bet)*(diff(diff(diff(f(eta), eta), eta), eta))-(diff(f(eta), eta))^2+f(eta)*(diff(diff(f(eta), eta), eta))+Gr*(theta(eta)+lambda1*theta(eta)^2)+Gc*(phi(eta)+lambda2*phi(eta)^2)-M*(diff(f(eta), eta)) = 0

(1)

ode2 := (diff(theta(eta), eta, eta))*(1+(4*R*(1/3))*(theta(eta)+CT)^3)/Pr+4*R*(theta(eta)+CT)^2*(diff(theta(eta), eta))^2+f(eta)*(diff(theta(eta), eta))+Nb*(diff(phi(eta), eta))*(diff(theta(eta), eta))+Nt*(diff(theta(eta), eta))^2-de*(f(eta)*(diff(f(eta), eta))*(diff(theta(eta), eta))+f(eta)^2*(diff(theta(eta), eta, eta))) = 0

(diff(diff(theta(eta), eta), eta))*(1+(4/3)*R*(theta(eta)+CT)^3)/Pr+4*R*(theta(eta)+CT)^2*(diff(theta(eta), eta))^2+f(eta)*(diff(theta(eta), eta))+Nb*(diff(phi(eta), eta))*(diff(theta(eta), eta))+Nt*(diff(theta(eta), eta))^2-de*(f(eta)*(diff(f(eta), eta))*(diff(theta(eta), eta))+f(eta)^2*(diff(diff(theta(eta), eta), eta))) = 0

(2)

ode3 := diff(phi(eta), eta, eta)+Pr*Le*(diff(phi(eta), eta))*f(eta)+Nt*(diff(theta(eta), eta, eta))/Nb-Pr*Le*dc*(f(eta)*(diff(f(eta), eta))*(diff(phi(eta), eta))+f(eta)^2*(diff(phi(eta), eta, eta))) = 0

diff(diff(phi(eta), eta), eta)+Pr*Le*(diff(phi(eta), eta))*f(eta)+Nt*(diff(diff(theta(eta), eta), eta))/Nb-Pr*Le*dc*(f(eta)*(diff(f(eta), eta))*(diff(phi(eta), eta))+f(eta)^2*(diff(diff(phi(eta), eta), eta))) = 0

(3)

bcs1 := f(0) = 0, (D(f))(0) = 1+xi*((D^2)(f))(0), (D(f))(6) = 0, theta(6) = 0, phi(0) = 1+`&varsigma;`*(D(phi))(0), theta(0) = 1+Zeta*(D(theta))(0), phi(6) = 0

f(0) = 0, (D(f))(0) = 1+xi*(D(f))(0)^2, (D(f))(6) = 0, theta(6) = 0, phi(0) = 1+varsigma*(D(phi))(0), theta(0) = 1+Zeta*(D(theta))(0), phi(6) = 0

(4)

NULL

 

L := [0., .1, .4, 1]

[0., .1, .4, 1]

(5)

 
  

NULL


  for k to 10 do
      sol_All := dsolve
                 ( eval
                   ( {bcs1, ode1, ode2,ode3},
                     [xi= L[k],R=1, CT=0.2, Gr=0.5, Gc=0.5, lambda1=0.2, lambda2=0.2, Pr=0.72, Nb=0.5,  Le=1, dc=0.2, de=0.2, Nt=0.5, Zeta=0.5, varsigma=0.5, M=1.5, bet=1.5]
                   ),
                   [f(eta), theta(eta),phi(eta)],
                   numeric,
                   output = listprocedure
                 );
      Y_sol || k := rhs(sol_All[5]);
      YP_sol || k := -rhs(sol_All[6]);

feta || k := rhs(sol_All[4]);
      fpeta || k := rhs(sol_All[3]);

phieta || k := rhs(sol_All[8]);
      phipeta || k := rhs(sol_All[7])
  end do:

Error, (in dsolve/numeric/bvp) initial Newton iteration is not converging

 

for k to 10 do L[k], [(Y_sol || k)(0), (YP_sol || k)(0)] end do

0., [Y_sol1(0), YP_sol1(0)]

 

.1, [Y_sol2(0), YP_sol2(0)]

 

.4, [Y_sol3(0), YP_sol3(0)]

 

1, [Y_sol4(0), YP_sol4(0)]

 

Error, invalid subscript selector

 

for k to 10 do L[k], [(feta || k)(0)] end do

0., [feta1(0)]

 

.1, [feta2(0)]

 

.4, [feta3(0)]

 

1, [feta4(0)]

 

Error, invalid subscript selector

 

NULL

Error, mismatched or missing bracket/operator

"for k  from 1 to  10 do L[k], ([phieta ||k(0),phipeta||k(0)]); od; "

 

NULL

  plot( [ seq((Y_sol||j)(eta), j = 1..6)],
         eta = 0 .. 6,
         labels = [eta, theta(eta)],
         axes = boxed
      );
plot( [ seq((YP_sol||j)(eta), j = 1..6)],
         eta = 0 .. 8,
         labels = [eta, thetaprime(eta)],
         axes = boxed
      );

 plot( [ seq((feta||j)(eta), j = 1..6)],
         eta = 0 .. 8,
         labels = [eta, f(eta)],
         axes = boxed
      );
  plot( [ seq((fpeta||j)(eta), j = 1..6)],
         eta = 0 .. 5,
         labels = [eta, fprime(eta)],
         axes = boxed
      );
plot( [ seq((phipeta||j)(eta), j = 1..6)],
         eta = 0 .. 5,
         labels = [eta, phiprime(eta)],
         axes = boxed
      );

plot( [ seq((phieta||j)(eta), j = 1..6)],
         eta = 0 .. 5,
         labels = [eta, phi(eta)],
         axes = boxed
      );

Warning, expecting only range variable eta in expression Y_sol1(eta) to be plotted but found name Y_sol1

 

 

Warning, expecting only range variable eta in expression YP_sol1(eta) to be plotted but found name YP_sol1

 

 

Warning, expecting only range variable eta in expression feta1(eta) to be plotted but found name feta1

 

 

Warning, expecting only range variable eta in expression fpeta1(eta) to be plotted but found name fpeta1

 

 

Warning, expecting only range variable eta in expression phipeta1(eta) to be plotted but found name phipeta1

 

 

Warning, expecting only range variable eta in expression phieta1(eta) to be plotted but found name phieta1

 

 

Hello Everyone;

Can anybody help me to solve the analytical solution of the following ODE?
AAS := C*diff(y(t), t) + (-B0*y(t)^3 - B1*y(t)^2 - B2*y(t) - B3);y[0] := 1

C,B0,B1,B2 are constants.

How did Maple arrive at the following, implicit solution,

MSimplicitesolution := (-9*y(x)*(-y(x)*x^2)^(1/3)*6^(2/3)*x^2 + 16*_C1*x^(8/3) - 24*x^2 + 6)/(16*x^(8/3)) = 0, 

to the following 'ode',

ODE:= (2/3)*(int[(y'(x)*(x^2)/((x^2) -1)]) =int(-sqrt [2*y(x)])?

'odeadvisor' suggested y=G(x,y'(x), but I could not see how this could be implimented with this equation.

(Unfortunately, I am unable to download the Maple worksheet onto this sheet at this time.  Any assitance

would be appreciated.                

I want to write the expresstion x^3 + (-m - 1)*x^2 + (-4*m - 3)*x in the form x^3 - (m-1) x^2 - (4m + 3). I tried
collect(expand(x^3 + (-m - 1)*x^2 + (-4*m - 3)*x), x)

I get x^3 + (-m - 1)*x^2 + (-4*m - 3)*x

Why is Maple not calculating 'sqrt' and continuously showing 'Evaluating'?


 

restart

with(LinearAlgebra); with(PDEtools); with(DifferentialGeometry)

with(plots)

with(Physics)

q := (31.00000000*exp(-4.976*t+2.*x)*exp((-2.488+.8336000001*I)*t+(1.+.2*I)*x)-3.000000000*exp(-4.976*t+2.*x)*exp((2.488+.8336000001*I)*t+(-1.+.2*I)*x)+(94.0*I)*exp(I*(.8336*t+.2000*x))*exp(-4.976*t+2.*x))/((11.50000000*I)*exp(-2.488*t+x)+132.44*exp(-4.976*t+2.*x)-(104.5000000*I)*exp(-7.464*t+3.*x)-5.25*exp(-9.952*t+4.*x)+.25)

(31.00000000*exp(-4.976*t+2.*x)*exp((-2.488+.8336000001*I)*t+(1.+.2*I)*x)-3.000000000*exp(-4.976*t+2.*x)*exp((2.488+.8336000001*I)*t+(-1.+.2*I)*x)+(94.0*I)*exp(I*(.8336*t+.2000*x))*exp(-4.976*t+2.*x))/((11.50000000*I)*exp(-2.488*t+x)+132.44*exp(-4.976*t+2.*x)-(104.5000000*I)*exp(-7.464*t+3.*x)-5.25*exp(-9.952*t+4.*x)+.25)

(1)

assume(x::real); assume(t::real)

q1 := simplify(subs({I = -I}, q))

(-(94.*I)*exp(-I*(.8336*t+.2000*x))+31.*exp((-2.488-.8336000001*I)*t+(1.-.2*I)*x)-3.*exp((2.488-.8336000001*I)*t+(-1.-.2*I)*x))*exp(-4.976*t+2.*x)/(-(11.50000000*I)*exp(-2.488*t+x)+132.44*exp(-4.976*t+2.*x)+(104.5000000*I)*exp(-7.464*t+3.*x)-5.25*exp(-9.952*t+4.*x)+.25)

(2)

q2 := simplify(sqrt(q*q1))

NULL

NULL


 

Download q_sqrt.mw

Help me please?

ElzakiTransform := proc(f, t) int(f*exp(-t/v)*v, t = 0 .. infinity); end proc;
f := e^(n*t);
result := ElzakiTransform(f, t);
result;

Is this true?

First 52 53 54 55 56 57 58 Last Page 54 of 2097