Maple Questions and Posts

These are Posts and Questions associated with the product, Maple

Lamba is meant to be reserved for liouville function plotting some data i just realized it isn't that, so if the people that make the numtheory package please unprotec lamba in the future, or protec it but changed its proc assignment to the liouville function
function that would really sweet thanks

I wanted to have 3 graphs in 1 coordinate system. The Maple command I used was,

restart;
g := x -> (10*x)/(3+x);

f := x -> (10*x)/(5+x);

h := x -> (8*x)/(5+x);

plots:-display(
  plot( [g(x),f(x), h(x)], x=0..30, color=[red,blue, green], legend = ["k=3,c=10", "k=5, c=10","k=5,c=8"]));


Warning, unable to evaluate 1 of the 3 functions to numeric values in the region; see the plotting command's help page to ensure the calling sequence is correct

 

The error comes up. only f(x) and h(x) were shown. How do I fix this? Thank you.

 

I 'm solving asystem of equations and one of the result are Hfloat what does it means and how i convert it to number???

how to find skin friction value below code

 

restart

PDEtools[declare]((U, W, T, C)(y), prime = y):

R1 := .1; R0 := .1; m := .1; a := .1; Ha := .1; Nt := .1; Nb := .1; Pr := 6.2; Le := .6; Bi := 1; Ec := .1; k := 1; r := .1; A := 1;

sys := diff(U(y), `$`(y, 2))+(R1*(diff(U(y), y))-2*R0*W(y))*exp(a*T(y))-a*(diff(U(y), y))*(diff(T(y), y))-Ha = 0, diff(W(y), `$`(y, 2))+(R1*(diff(W(y), y))+2*R0*U(y))*exp(a*T(y))-a*(diff(W(y), y)) = 0, diff(T(y), `$`(y, 2))+R1*Pr*(diff(T(y), y))+Pr*Ec*exp(-a*T(y))*((diff(U(y), y))*(diff(U(y), y))+(diff(W(y), y))*(diff(W(y), y)))+Pr*Ha*Ec*((U(y)+m*W(y))*(U(y)+m*W(y))+(W(y)-m*U(y))*(W(y)-m*U(y)))/(m^2+1)^2+Nb*(diff(T(y), y))*(diff(C(y), y))+Nt*(diff(T(y), y))*(diff(T(y), y)) = 0, diff(C(y), `$`(y, 2))+Pr*Le*R1*(diff(C(y), y))+Nt*(diff(C(y), `$`(y, 2)))/Nb = 0:

ba := {sys, C(0) = 0, C(1) = 1, T(1) = 0, U(0) = 0, U(1) = 0, W(0) = 0, W(1) = 0, (D(T))(0) = Bi*(T(0)-1)}:

r1 := dsolve(ba, numeric, output = Array([0., 0.5e-1, .10, .15, .20, .25, .30, .35, .40, .45, .50, .55, .60, .65, .70, .75, .80, .85, .90, .95, 1.00])):

with(plots); 

p1u := odeplot(r1, [y, U(y)], 0 .. 1, numpoints = 100, labels = ["y", "U"], style = line, color = green); 

plots[display]({p1u})

restart; with(plots);
G := 1; M := .1; R := 1; P := .72; alpha := .1; phi := 1; K := 1; n := 2; beta := 1;
                               1
                              0.1
                               1
                              0.72
                              0.1
                               1
                               1
                               2
                               1
ode1 := {(1+(4/3)*R)*(diff(theta(x), x, x))+(1/2)*P*f(x)*(diff(theta(x), x))+alpha*theta(x) = 0, n*(diff(f(x), x, x))^(n-1)*(diff(f(x), x, x, x))+f(x)*(diff(f(x), x, x))/(n+1)+G*theta(x)-M*(diff(f(x), x)) = 0, f(0) = 0, theta(10) = 0, (D(f))(0) = beta*K*((D@@2)(f))(0), (D(f))(10) = 1, (D(theta))(0) = -phi*(1-theta(0))};
 /7  d  / d          \                     / d          \
{ - --- |--- theta(x)| + 0.3600000000 f(x) |--- theta(x)|
 \3  dx \ dx         /                     \ dx         /

                         / d  / d      \\ / d  / d  / d      \\\
   + 0.1 theta(x) = 0, 2 |--- |--- f(x)|| |--- |--- |--- f(x)|||
                         \ dx \ dx     // \ dx \ dx \ dx     ///

     1      / d  / d      \\                  / d      \      
   + - f(x) |--- |--- f(x)|| + theta(x) - 0.1 |--- f(x)| = 0,
     3      \ dx \ dx     //                  \ dx     /      

  f(0) = 0, theta(10) = 0, D(f)(0) = @@(D, 2)(f)(0),

                                           \
  D(f)(10) = 1, D(theta)(0) = -1 + theta(0) }
                                           /
dsol := dsolve(ode1, numeric, method = bvp[midrich], range = 0 .. 10);
Error, (in dsolve/numeric/bvp) initial Newton iteration is not converging

 

Hello,

I need a little help...

what I want to do, if i have 3 equations  with multiple variables and i want to get derivative of some of these variables wrt other variables while setting others as constants

here in the example

1st i thought the last equation should have partial m / partial f ... how can i get that

2nd if ,another problem, i wanted to set z as a constant so it won't consider getting its derivative, how do i get that

diff_test.mw

f1 := x = y+z

x = y+z

(1)

f2 := y = 2*f^2+3

y = 2*f^2+3

(2)

f3 := z = 22*f^3+33*f+m

z = 22*f^3+33*f+m

(3)

implicitdiff({f1, f2, f3}, {x, y, z}, x, f)

66*f^2+4*f+33

(4)

NULL


Download diff_test.m

 

hope i was clear in my explanation. thank you

 

Hello,

So my questions is fairly simple but I am not sure if Maple can do this. I want to create a Matrix full of partial derivatives (Jacobian), but computing this Jacobian is maxing out my RAM. So I would like to create each row (or column) of the Jacobian seperately and save each row (or column) in a Matrix that has already been saved to a file. Basically I would like to store values in a file (in a loop) without overwriting the file.

Hi every body:

I have to obtain Amax where is the maximum value of the f(t) function at steady state but at first i don't know steady sate what's the mean and the second i don't know how to obtain it with maple. help me plz. tnx. 

f:=(t)->A*sin(x*t)

A := -6000.*x^3*((5.925123867*10^87*I)*x+5.830850605*10^88*x^2+1.752916719*10^90)/((4.241561702*10^89*I)*x^4-2.669934485*10^90*x^5-(3.812926555*10^90*I)*x^2+7.038145625*10^91*x^3+3.174301659*10^89*I-8.376628660*10^90*x)

Sin.mw

I am looking for advice as to avoiding or identifying what may elude to the cause of the error "Error, (in simplify/do) invalid simplification command" in circumstances where i have simply enclosed an expression with simplify(expression), and in most cases an error is not returned.

 

Thankyou in advance

how to find the closed form solution from the given expression in maple?

u = 140-(1/239500800)*x*t^12+(1/479001600)*x^2*t^12-119*t+40*x-(1/4435200)*t^11-(1/19958400)*x*t^11+(1/39916800)*x^2*t^11-(5/72576)*t^9-(1/60480)*x*t^9+(1/120960)*x^2*t^9+(1/2016)*t^8+(1/10080)*x*t^8-(1/20160)*x^2*t^8-(23/2520)*t^7-(1/420)*x*t^7+(1/840)*x^2*t^7+(23/360)*t^6-(1/144)*x^2*t^6+(1/72)*x*t^6-(7/12)*t^5+(1/12)*x^2*t^5-(1/6)*x*t^5+(19/6)*t^4-(3/8)*x^2*t^4+(3/4)*x*t^4-(95/6)*t^3+(5/2)*x^2*t^3-5*x*t^3+54*t^2-7*x^2*t^2+14*x*t^2+21*x^2*t-42*x*t-42*exp(-t)*x+21*exp(-t)*x^2-21*exp(-t)*t-(1/39916800)*t^12-140*exp(-t)-20*x^2

Ah yep so i have been trying to arrange this so that it returns the number of iterations required to reach a single digit value but like everything i do this week completely useless 

 


 

 

restart

unprotect(delta):

delta := proc (x, y) options operator, arrow; piecewise(x = y, 1, x <> y, 0) end proc

then the j th summand of the first digital root of 'a' in base 'b'. can be expressed as:

d := proc (a, b, j) options operator, arrow; sum((delta(j, k)-b*delta(j, k+1))*floor(a*b^(k-floor(ln(a)/ln(b))-1)), k = 1 .. floor(ln(a)/ln(b))+1) end proc:

R[0] := proc (a, b) options operator, arrow; sum(sum((delta(m, k)-b*delta(m, k+1))*floor(a*b^(k-floor(ln(a)/ln(b))-1)), k = 1 .. floor(ln(a)/ln(b))+1), m = 1 .. floor(ln(a)/ln(b))+1) end proc

proc (a, b) options operator, arrow; sum(sum((delta(m, k)-b*delta(m, k+1))*floor(a*b^(k-floor(ln(a)/ln(b))-1)), k = 1 .. floor(ln(a)/ln(b))+1), m = 1 .. floor(ln(a)/ln(b))+1) end proc

(1)

DigitalRoot := proc (a, b, N) options operator, arrow; foldl(R[0], R[0](a, b), seq(b, k = 1 .. N)) end proc

proc (a, b, N) options operator, arrow; foldl(R[0], R[0](a, b), seq(b, k = 1 .. N)) end proc

(2)

MAIN BASIC EXAMPLE

SELECT THE NUMBER:

a := 345346462

345346462

(3)

 

 

SELECT THE NUMBER BASE FOR WHICH YOU WISH TO REPRESENT a:

b := 10

10

(4)

The output will be the digits of the  base b representation of a, (or the coefficients of it's p-adic expansion?):

seq(d(a, b, j), j = 1 .. floor(ln(a)/ln(b))+1)

3, 4, 5, 3, 4, 6, 4, 6, 2

(5)

DigitalRoot(a, b, 0), DigitalRoot(a, b, 1), DigitalRoot(a, b, 2)

37, 10, 1

(6)

n := 0:

37

 

0

(7)

``

``


Sorry EDIT its ok i got it old_garbage_2015002.mw

Download old_garbage_2015.mw

Dear Users!

Hope you would be fine. In the following maple code, I want to write the derivative of psi in term of psi like it did manually in red portion. For higher M and k it very hard to do it manully. It there any command to fix my problem for any value of k and M.

restart; k := 2; M := 4;

with(linalg); with(LinearAlgebra);

printlevel := 2;

for i while i <= 2^(k-1) do

for j from 0 while j <= M-1 do

psi[M*i+j-M+1] := simplify(2^((1/2)*k)*sqrt(GAMMA(j+1)*(j+alpha)*GAMMA(alpha)^2/(Pi*2^(1-2*alpha)*GAMMA(j+2*alpha)))*(sum((-1)^i1*GAMMA(j-i1+alpha)*(2*(2^k*x-2*i1+1))^(j-2*i1)/(GAMMA(alpha)*factorial(i1)*factorial(j-2*i1)), i1 = 0 .. floor((1/2)*j))));

`&psi;&psi;`[M*i+j-M+1] := simplify(diff(psi[M*i+j-M+1], x))

end do

end do; r := 2^(k-1)*M;

VV := Vector[column](r, proc (i) options operator, arrow; psi[i] end proc);

DV := Vector[column](r, proc (i) options operator, arrow; `&psi;&psi;`[i] end proc);

``&psi;&psi;`[2] := 8*sqrt((alpha+1)*(1/2))*sqrt(2)*sqrt(alpha*GAMMA(alpha)^2*4^alpha/GAMMA(2*alpha))/sqrt(Pi) = 8*sqrt((alpha+1)*(1/2))*psi[1];

`&psi;&psi;`[3] := 16*sqrt((2+alpha)*(alpha+1)/(1+2*alpha))/sqrt(2)*(2*sqrt(2)*sqrt((alpha+1)*GAMMA(alpha)^2*4^alpha/GAMMA(1+2*alpha))*alpha*(4*x+1)/sqrt(Pi)) = 16*sqrt((2+alpha)*(alpha+1)/(1+2*alpha))*psi[2]/sqrt(2)

I am waiting your response. Thanks

I'm working with tensors using the DifferentialGeometry package (not yet checked out the Physics package since I plan on working with Lie algebras), and in particular I'm computing the Riemann tensor of a metric.

Raising the first index of CurvatureTensor(g), the Riemann tensor has the symmetries of a symmetric product of two 2-forms, and this is how I would like to present it, identifying terms like dw1dw2dw1dw2 with terms like dw1dw2dw2dw1 with the appropriate sign. Ideally I would arrive at an expression that is written in terms of (dw1^dw2) (dw1^dw2) (etc.) basis elements, provided that my tensor has these symmetries.

Is there some readily available functionality to do this, or a simple, standard method in Maple?

Hello everyone,

I have a project that uses several machines to make a computation. I wrote a package (called here "package") with procedures, "proc".  I wrote several .mpl files structured as:

read "package.mpl":

W:= Read("file1.mpl"):    #I wrote a procedure to read and assign to a variable. This is not the problem.

Export("output.mpl", proc(W));

The situation is as follows: in all but one of my machines, this works fine, and proc(W) is exported correctly. However, in this ugly duckling (which is running the GUI version of Maple18), maple prints as an output, in blue:

Export("output.mpl",...)

and in place of ... it gives the answer expected. But it does not export automatically. I can, of course, manually correct this, but this is not optimal. Moreover, if the output is too big, there will be display issues.

Help? Any light is appreciated, thanks.

Marcelo

PS: I do not expect an answer for the PS; but I also do not know how to make my package "official", in the sense that I always read the .mpl file with all the procedures. Is there a way to call it like the LinearAlgebra and so on and use the package:-proc syntax? 

First 124 125 126 127 128 129 130 Last Page 126 of 2218