Maple 16 Questions and Posts

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

How to get logarithm expression using Maple command?

For example, enter log[2](x^2-3x+5)+x^3-1-log[3](x-1)

Output [x^2-3x+5,x-1]

Thank you very much for your help.

In this paper (see the footnote on the page), the authors pointed out:

We use -v16 as it is faster than the -v2019 for real root isolation on our benchmarks.

Since I don't have Maple 16 at present, I cannot confirm such an assertion personally. However, I'd like to ascertain if old Maple 16 (released in 2012) is still faster in that specialized realm now (i.e., in 2023). Is there any benchmark test that supports this claim (or tells an opposite story instead?)?

Note. Here I just try to justify the authors' statement (which has caused confusion). Incidentally, will this library be a part of Maple in some future version? (I find that some recent papers provide new "powerful"—in accordance with their "Experiment" sections—Maple packages to tackle difficult problems efficaciously, but such functionalities are not built into the Maple kernel as yet. (In fact, if Maple is a single integrated all-in-one technical platform, then I will no longer need to change tools and formats at each stage. :) ))

  How do you transform vector expression (*) into [M,A] – 3[M,B] = 7[M,C] using Maple command?

 

  Thank you for your help !

Good day everyone, please I'm soliciting help on how to solve PDE in Maple. I know how to solve ODE but I don't know how to go about PDE. The problem I want to solve is attached as an attachment. If epsilon is zero, then the problem reduces to ODE which can easily be solved, but epsilon is not supposed to be zero. please I need your help, thank you in anticipation.

PDE.pdf

ans:=6 *a[0]+2 *k^2 *b[1]*x^2 *y+k^2 *b[1] *y *lambda+6* k^2 *b[2]* x^3 *y-c *b[1] *x* y-2* c* b[2] *x^2 *y-c *b[2] *y *lambda+(6 *b[2]^2 *x^4 *lambda)/(lambda^2 *sigma+mu^2)+(6 *b[2]^2 *x^2 *lambda^2)/(lambda^2 *sigma+mu^2)+(6 *b[1]^2 *lambda* x^2)/(lambda^2 *sigma+mu^2)-12 *a[0] *b[2] *x *y-12* (a[1] . x)* b[2] *x* y-12* (a[2] . (x^2)) *b[2] *x* y+(6 *b[1]^2 *lambda^2)/(lambda^2 *sigma+mu^2)+k^2 *(a[1] . (-2 *x* (mu* y-x^2-lambda)-mu *x* y))+2 *k^2* (a[2] . ((mu* y-x^2-lambda)^2+x* (-2 *x (mu* y-x^2-lambda)-mu *x* y)))+c (a[1] . (mu *y-x^2-lambda))+2 *c (a[2] . (x *(mu *y-x^2-lambda)))+5* k^2 *b[2] *x *y *lambda-(c *b[2] *lambda^2 *mu)/(lambda^2 *sigma+mu^2)+(12 *b[1] *lambda *b[2] *x^3)/(lambda^2 *sigma+mu^2)+(12 *b[1] *lambda^2 *b[2] *x)/(lambda^2 *sigma+mu^2)-(12 *b[1]^2 *lambda *mu* y)/(lambda^2 *sigma+mu^2)+(k^2 *b[1] *lambda^2 *mu)/(lambda^2* sigma+mu^2)-12 *a[0] *b[1] *y-12* (a[1] . x) *b[1] *y-12* (a[2] . (x^2)) b[1] *y-6 *a[0]^2-12 *a[0] *(a[1] . x)-12 *a[0]* (a[2] . (x^2))-6* (a[1] . x)^2-12* (a[1] . x) *(a[2] . (x^2))-6* (a[2] . (x^2))^2-(2 *k^(2)* b[1] *lambda* mu^2 *y)/(lambda^2 *sigma+mu^2)+(k^2 *b[1] *lambda *mu *x^2)/(lambda^2 *sigma+mu^2)+(6* k^2 *b[2] *lambda *mu *x^3)/(lambda^2 *sigma+mu^2)+(6* k^2 *b[2] *lambda^2 *mu *x)/(lambda^2 *sigma+mu^2)+(2* c *b[2] *lambda *mu^2* y)/(lambda^2 *sigma+mu^2)-(c *b[2] *lambda* mu* x^2)/(lambda^2 *sigma+mu^2)-(12 *b[2]^2 *x^2 *lambda* mu* y)/(lambda^2 *sigma+mu^2)-(12* k^2 *b[2] *lambda* mu^2 *x *y)/(lambda^2 *sigma+mu^2)-(24 *b[1] *lambda *b[2] *x *mu* y)/(lambda^2 *sigma+mu^2)+6* (a[1] . x)+6* (a[2] . (x^2))+6 *b[2] *x *y+6 *b[1] *y;


P1 := coeff(coeff(ans, x, 4), y, 0);


Error, unable to compute coeff

Sometime, answer is coming sometine not.

2. Also, if one wants to substitute the value of x^2=t^2+5, in x^3 then why it is giving the ans.

Thank you very much!

ishak.mw
 

restart

with*plots; -1; ode1 := diff(f(eta), eta, eta, eta)+(1/2)*f(eta)*(diff(f(eta), eta, eta)) = 0

diff(diff(diff(f(eta), eta), eta), eta)+(1/2)*f(eta)*(diff(diff(f(eta), eta), eta)) = 0

(1)

ode2 := (diff(theta(eta), eta, eta))/pr+3*N*f(eta)*(diff(theta(eta), eta))/(6*N+8) = 0

(diff(diff(theta(eta), eta), eta))/pr+3*N*f(eta)*(diff(theta(eta), eta))/(6*N+8) = 0

(2)

bcs1 := f(0) = 0, (D(f))(0) = S, (D(f))(16) = 1-S;

f(0) = 0, (D(f))(0) = S, (D(f))(16) = 1-S

(3)

fixedparameter := [pr = 1];

[pr = 1]

(4)

ode3 := eval(ode2, fixedparameter);

diff(diff(theta(eta), eta), eta)+3*N*f(eta)*(diff(theta(eta), eta))/(6*N+8) = 0

(5)

ode4 := eval(ode1, fixedparameter);

diff(diff(diff(f(eta), eta), eta), eta)+(1/2)*f(eta)*(diff(diff(f(eta), eta), eta)) = 0

(6)

bcs2 := theta(16) = 0, (D(theta))(0) = -a*(1-theta(0));

theta(16) = 0, (D(theta))(0) = -a*(1-theta(0))

(7)

 

L := [1, 5, 10]

[1, 5, 10]

(8)

 
  

``


  for k to 10 do
      sol_All := dsolve
                 ( eval
                   ( {bcs1, bcs2, ode3, ode4},
                     [N= L[k],a=1,S=1]
                   ),
                   [f(eta), theta(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])
  end do:

Error, invalid subscript selector

 

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

1, [HFloat(0.8022978364702027), HFloat(0.19770216352979716)]

 

5, [HFloat(0.7250508085648081), HFloat(0.27494919143519203)]

 

10, [HFloat(0.7099202264181006), HFloat(0.29007977358189907)]

 

Error, invalid subscript selector

 

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

1, [HFloat(-0.4437495989448031)]

 

5, [HFloat(-0.4437495983315978)]

 

10, [HFloat(-0.4437495982077529)]

 

Error, invalid subscript selector

 

``

  plot( [ seq((Y_sol||j)(eta), j = 1..16)],
         eta = 0 .. 10,
         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 .. 8,
         labels = [eta, fprime(eta)],
         axes = boxed
      );

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

 

 

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

 

 

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

 

 

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

 

 

NULL

``

NULL


 

Download ishak.mw

Good day every one;

please im soliciting for a help on how to plot my Nusselt number and Skin friction.

The attached is plotting against the dependent variable (eta) but i want skin friction (f  ' ' ) against N or Pr not against eta 

thank you for your help in aticipation

Hi
when I use this package, maple makes error like bellow. what is the problem ? thank u

Hello everyone

Please help me about IntegrationTools:-Change does not transform x to u

IntegrationTools:-Change(int(3*x*sqrt(x+8), x)) 

I want to convert that primitive to a primitive like this: (2/3)*(Int(u^2*(u^2-8), u)) and Error, (in IntegrationTools:-Change) invalid boolean expression: 1
 

Please help me

Help_integrationTools.mw

Hi,

It might be a really silly question, but I am wondering is it possible to simplify expression like this

a^2+b^2+2*a*b+c^2. Just by looking it we know that we can write it in the form of (a+b)^2+c^2. This is the basic exmaple I come up with. I have very lengthy expressions in maple, which can be factorize like this, but factor command will not work as it will try to factorize entire expression. So I am wondering is it doable in maple or I have to do it manually by collecting terms and check whether they can be factorize or not.

Thanks in Advance.

With Regards

sunit

Hi every one

I'm having some plots in maple, but the layout is not pretty enough, I want export in to MATLAB. Does some one please have an idea on how I can go about it?.

I'm using Maple 16

Thank you in anticipation

Can anyone help me to find a solution to psi[2](r,phi) for the attached partial differential equation pde[0]?


I want to find a general solution to a partial differential equation by assuming that I know one solution, called psi[1], and trying to find another solution psi[2] by assuming that the general solution in the form of psi= psi[1]*psi[2]. I want to restrict the second solution to be in the form of psi[2](r*sin(phi)) so that it satisfies the PDE, and is a function of r times sin(phi). The latter makes error as the maple identifies that the function psi[2](r*sin(phi)) depends on only one variable r*sin(phi). Could you please help me to find a solution for psi[2] in the form psi[2]=f(r*sin(phi))?

 

Also, I have trouble with defining the operator Do in the attached file.  When it operates on psi[2](r * sin(phi)), maple gives D(D(psi[2]))(r*sin(phi)). It is not clear for me that whether this derivative is with respect to r or phi. I need is to define Do in a way so that the derivatives are correctly taken with respect to different separate variables.

 

Thank you for your help,

Ahmad

PDEs_KnownSolutoin.mw

Can anyone help me to solve the attached system of PDEs with a given expression for the HINT such as HINT = F[1](t)*F[2](r*sin(phi))

I am not able to set such an arbitray HINT function for system of PDEs.

SysPDE_HINT.mw

 

Thank you,

Ahmad

I am currently working on a project that generates a set of matrices and I want to find their eigenvalues, but using the inbuilt Maple engine takes too long. The problem is that whenever I try to use the Matlab[eig] command I get the error:

Error, (in Matlab:-setvar) unable to store '-3.*Re(X)' when datatype=float[8]
I found out that solving symbolic matrices in MATLAB requires first defining symbols with the "sym" command but I've been unable to do that in Maple.

Hi,

This might be a very silly question but it is troubling me a little bit and that's why I need to post it. During the combination of symbolic and numerical comutation this '1.0' is appearing as a coefficient for the variables whose coeffecient is just '1'. It's quite annoying as sometimes if I have to collect coefficient of a variable for an example exp(I*omega*t) then I have to write exp(1.I*omega*t), so chances of making mistake is higher. Please find the attached worksheet for this. In eq(4), you can easily see that for x[3](t) and x[1](t) this '1.0' appears in front of the variables.

I really appreciate  if someone can help me out of this.

With Regards

Sunitquestion.mw
 

restart

with(LinearAlgebra):

par := {a = 2.5, alpha = 2, k_r = .5, k_rc = .2, k_rq = .2, kappa = 0.1e-2, mu_k = .35, mu_s = .44, omega = .766620580157922, sigma_0 = 110, sigma_1 = 1.37, sigma_2 = 0.823e-1, x_s3 = -1.04003626422324936017819852700633621040584050594846801927800, zeta = 0.904504977553123318334601762827181333680096702957228781770315e-1}:

f := proc (v_r) options operator, arrow; mu_k+(mu_s-mu_k)*exp(-a*v_r) end proc:

NULL

g_exp1 := taylor(1/f(v_rv+x21), x21 = 0, 4):

for k to 4 do g_coeff[k] := taylor(subs(v_r = v_rv, coeff(g_exp1, x21, k-1)), epsilon = 0, 3) end do:

g0 := eval(subs(par, coeff(g_coeff[1], epsilon, 0))):

g1 := eval(subs(par, coeff(g_coeff[2], epsilon, 0))):

g2 := eval(subs(par, coeff(g_coeff[3], epsilon, 0))):

g3 := eval(subs(par, coeff(g_coeff[4], epsilon, 0))):

NULL

``

eq[1] := subs(par, diff(x[1](t), t)-x[2](t)):

eq[2] := subs(par, diff(x[2](t), t)+2*zeta*x[2](t)+x[1](t)+k_r*(x[1](t)-x[3](t))+2*kappa*(x[2](t)-x[4](t))+k_rq*(x[1](t)-x[3](t))^2+k_rc*(x[1](t)-x[3](t))^3)

diff(x[2](t), t)+.1829009955*x[2](t)+1.5*x[1](t)-.5*x[3](t)-0.2e-2*x[4](t)+.2*(x[1](t)-x[3](t))^2+.2*(x[1](t)-x[3](t))^3

(1)

eq[3] := subs(par, diff(x[3](t), t)-x[4](t))

diff(x[3](t), t)-x[4](t)

(2)

eq[4] := subs(par, diff(x[4](t), t)+2*kappa*alpha*(x[4](t)-x[2](t))+k_r*alpha*(x[3](t)-x[1](t))-k_rq*alpha*(x[3](t)-x[1](t))^2+k_rc*alpha*(x[3](t)-x[1](t))^3+alpha*(sigma_0*x[5](t)+sigma_1*v_r*(1-sigma_0*x[5](t)*(g_0+g_1*x[4](t)+g_2*x[4](t)^2+g_3*x[4](t)^3))+sigma_2*v_r))

diff(x[4](t), t)+0.4e-2*x[4](t)-0.4e-2*x[2](t)+1.0*x[3](t)-1.0*x[1](t)-.4*(x[3](t)-x[1](t))^2+.4*(x[3](t)-x[1](t))^3+220*x[5](t)+2.74*v_r*(1-110*x[5](t)*(g_0+g_1*x[4](t)+g_2*x[4](t)^2+g_3*x[4](t)^3))+.1646*v_r

(3)

eq[5] := subs(par, diff(x[5](t), t)-v_r*(1-sigma_0*x[5](t)*(g_0+g_1*x[4](t)+g_2*x[4](t)^2+g_3*x[4](t)^3)))

diff(x[5](t), t)-v_r*(1-110*x[5](t)*(g_0+g_1*x[4](t)+g_2*x[4](t)^2+g_3*x[4](t)^3))

(4)

``


 

Download question.mw

 

How to convert expression below to LaTex:  $\lim _{x \rightarrow 2} \frac{2}{x+3}$

And How to convert expression below to LaTex:  $\int_{2}^{3} \frac{1}{x^{2}+2} d x$

file test: newLaTex.mw

1 2 3 4 5 6 7 Last Page 1 of 40