MaplePrimes Questions

Hi guys;

can one please show me how to plot graphs in on layout. i want like soundalgekar2004-deka.pdf using this code

variable.mw
 

restart

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

diff(diff(diff(f(eta), eta), eta), eta)-(diff(theta(eta), eta))*(diff(diff(f(eta), eta), eta))/(theta(eta)-R)-(1/2)*(theta(eta)-R)*f(eta)*(diff(diff(f(eta), eta), eta))/R = 0

(1)

ode2 := diff(theta(eta), eta, eta)-N*pr*(diff(f(eta), eta))*theta(eta)+(1/2)*pr*f(eta)*(diff(theta(eta), eta)) = 0

diff(diff(theta(eta), eta), eta)-N*pr*(diff(f(eta), eta))*theta(eta)+(1/2)*pr*f(eta)*(diff(theta(eta), eta)) = 0

(2)

bcs1 := f(0) = 0, (D(f))(0) = 1, (D(f))(38) = 0;

f(0) = 0, (D(f))(0) = 1, (D(f))(38) = 0

(3)

fixedparameter := [pr = 0.2e-1, N = 1];

[pr = 0.2e-1, N = 1]

(4)

ode3 := eval(ode1, fixedparameter);

diff(diff(diff(f(eta), eta), eta), eta)-(diff(theta(eta), eta))*(diff(diff(f(eta), eta), eta))/(theta(eta)-R)-(1/2)*(theta(eta)-R)*f(eta)*(diff(diff(f(eta), eta), eta))/R = 0

(5)

bcs2 := theta(38) = 0, theta(0) = 1;

theta(38) = 0, theta(0) = 1

(6)

ode4 := eval(ode2, fixedparameter);

diff(diff(theta(eta), eta), eta)-0.2e-1*(diff(f(eta), eta))*theta(eta)+0.1000000000e-1*f(eta)*(diff(theta(eta), eta)) = 0

(7)

L := [2, 10, 15];

[2, 10, 15]

(8)

``

for k to 3 do sol_All := dsolve(eval({bcs1, bcs2, ode3, ode4}, R = L[k]), [f(eta), theta(eta)], numeric, output = listprocedure); Y_sol || k := rhs(sol_All[5]); YP_sol || k := -rhs(sol_All[6]); ftheta || k := rhs(sol_All[3]); pftheta || k := -rhs(sol_All[4]) end do:

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

2, [HFloat(1.0000000000000002), HFloat(0.07429586344532203)]

 

10, [HFloat(1.0000000000000007), HFloat(0.06509471738660902)]

 

15, [HFloat(0.9999999999999997), HFloat(0.06453272061469233)]

(9)

NULL

NULL

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

 plot( [ seq((ftheta||j)(eta), j = 1..3)],
         eta = 0 .. 6,
         labels = [eta, f(eta)],
         axes = boxed
      );
  plot( [ seq((pftheta||j)(eta), j = 1..3)],
         eta = 0 .. 6,
         labels = [eta, fprime(eta)],
         axes = boxed
      );

 

 

 

 

NULL

``


 

Download variable.mw

 

3.mw Here is my maple code that shows the animation for different values in b. The equation this is referring to is given in the code. I have done (b) and (c), and the animation is in the code, but I am not sure where for what value of b for the behavior changes, any tips on what to look for would be really helpful.

However, I am primarily concerned with (d) as I am not sure how to demonstrate periodic behaviour with dsolve. Thanks for the help!   

Hi, 
So I am trying to use Maple to find the integer points in a region(s) bounded buy a set of inequalities. But for a specific set of inequalities, in four variables,
inequalities:= [-a1-a2+a3+a4 <= 2, a1+a2 <= 3, -2*a1 <= -1, -2*a2 <= -1, -2*a3 <= -1, -2*a4 <= -1, -a1+a2+a3-a4 <= 4, -a1+a2-a3+a4 <= 4, a1-a2+a3-a4 <= 4, a1-a2-a3+a4 <= 4]; in four variables, vars :=[a1,a2,a3,a4];

I am getting the following error
Error, (in solver) invalid input: LinearMultivariateSystemInternal expects its 1st argument, eqns, to be of type ({list, set})({`<`, `<=`, `=`}), but received {a1-a2 = 0, -11/2+a1 <> 0}

Also, upon checking the inequalities by hand, I am sure that the region mentioned in the error doesnt come up. as based on the inequalities, it is not possible to have -11/2+a1 > 0. But though I could be wrong about my manual inequality analysis, the error is still suprising and worrying. 
Another point to note is that if I do a variable change, as
t1 := a1-a2;
t2 := a1+a2;
r1 := a3-a4;
r2 := a3+a4;
Then with new variables the inequalities are solved without any errors.

I am working with Maple2018 for this problem. 

Any help or insight into the root of this problem would be a lot of help. 


 

Hello! I need to solve a system of vector equations (a system with vectors, not a linear system). The coordinates of the vectors are not given. (It is a system of kinetostatic equations, I must to define reaction forces as functions of vectors of external forces.

I'm using the differential operator D to differentiate variables and look at the structure of the equations, i.e. turn things like

D[1]u-vt+v^2=0 into

D[1,2](u)-D[2](v)*t+v*D[1](t)+2*v*D[2](v)=0

However, it is assumed that this is a commutative operator, i.e. D[1,2]=D[2,1]. Can I use an option to have it not commute, or should I look into using the DETools package?

Thanks,

Mike

restart;
with(LinearAlgebra):

C:=proc(k,M) local N,P,m,L,T,j,Ld,n,i; 
N:=2^(k-1)*M:
P[0]:= t -> 1:
P[1]:= t -> t:
for m from 2 to M-1 do
   P[m]:= unapply(expand((2*m-1)*t*P[m-1](t)/m - (m-1)*P[m-2](t)/m), t)
end do: 
L:=proc(n,m) local a,b; 
  a := (2*n-2)/2^k; 
  b := 2*n/2^k; 
  return piecewise(a <= t and t <= b, P[m](2^k*t-2*n+1)*sqrt(((m+1)/2)*2^k))
end proc:
T := Vector(N):
for j from 1 to N do T[j] := (j-1/2)/N end do; 
Ld := unapply(Vector(N),t):
for n from 1 to 2^(k-1) do 
  for m from 0 to M-1 do
i := n+2^(k-1)*m:
Ld(t)[i] := L(n,m)
     end do
end do:

return Ld(t):  
end proc:
A:=t->C(2,3);
A(0);
A(0.5);
A(0.3);

Ld is piecewise function depends on t. I want to calculate Ld(0)=A(0), Ld(0.5)=A(0.5) etc.  

What is the problem?

 

with(Physics);
Setup(mathematicalnotation = true):
Setup(dimension = 3, coordinates = (X = [x, y, t]), metric = -ut^2*(dx^2)+ut^2*(dy^2)+(-ux^2-uy^2+1)*(dt^2)+2*ux*ut*dx*dt+2*uy*ut*dy*dt):
              ut := Physics:-diff(u(X), t)
ux := diff(u(x, y, t), x);
                  ux := Physics:-diff(u(X), x)
uy := diff(u(x, y, t), y);
                  uy := Physics:-diff(u(X), y)
Define(S[mu, nu] = 1/(d-2)*(Ricci[mu, nu]-1/(2*d-2)*Ricci[`~alpha`, alpha]*g_[mu, nu]));
             Defined objects with tensor properties
Define(C[mu, nu, rho] = D_[nu](S[rho, mu])-D_[rho](S[nu, mu]));
             Defined objects with tensor properties
g_[];
Physics:-g_[mu, nu] = 

 
C[mu, nu, rho, nonzero];
          [Length of output exceeds limit of 1000000]
utt := diff(u(x, y, t), t, t);
               utt := Physics:-diff(u(X), t $ 2)
uxx := diff(u(x, y, t), x, x);
               uxx := Physics:-diff(u(X), x $ 2)
uyy := diff(u(x, y, t), y, y);
               uyy := Physics:-diff(u(X), y $ 2)
uxt := diff(u(x, y, t), x, t);
                uxt := Physics:-diff(u(X), t, x)
uyt := diff(u(x, y, t), y, t);
                uyt := Physics:-diff(u(X), t, y)
utt = ut*ut*(1/(-ux^2-uy^2+1))*(uxx+uyy)-2*ut*(1/(-ux^2-uy^2+1))*(ux*uxt+uy*uyt);
Basically here the cotton tensor exceeds the output limit in maple, however I am supposed to be showing how the cotton tensor vanishes, the last part of the code is me trying to input a relation of u_tt to various other derivatives of u in the hope that the cotton tensor can be simplified from this equation but nothing has changed as a result, can anyone help me? 

restart;
PDE := diff(y(x,t), x,x,x,x)+(diff(y(x, t), t,t))=0;  
# Initial/boundary conditions 
  BCs:=y(0,t) = 0, y(1,t) = 0,D[1](y)(0,t)=0,D[1](y)(1,t)=0;

  ICs:=y(x,0) =0, D[2](y)(x,0)=1 ;
  num_solution := pdsolve(PDE, {BCs,ICs}, numeric); 
  num_solution :-plot3d(x=0..1, t=0..1);

1st Question:How to plot the 2D at point x=0.5?

 

2nd Question: How to use PDEplot?

How to use a Lyapunov function to prove the stability of a system of differential equations and then check the stability? My initial thoughts were to use a contour plot?

I havev to calculate the intersection of three planes and need to plot them, when I try to plot them I get this error:

Error, (in plot3d) bad range arguments: (Vector(3, {(1) = -4*_t2[3], (2) = 3*_t2[3], (3) = _t2[3]})) = -8 .. 8, y = -20 .. 20

This is my code so far:

with(LinearAlgebra);
A := <1, 1, -2|3, 4, -7|-5, -8, 13>
b := <0,0,0>

x := LinearSolve(A, b)
P1 := x+3*y;
P2 := x+4*y;
P3 := -2*x-7*y;
plot3d([P1, P2, P3], x = -8 .. 8, y = -20 .. 20, plotlist = true, color = [blue, red, green]);
Error, (in plot3d) bad range arguments: (Vector(3, {(1) = -4*_t2[3], (2) = 3*_t2[3], (3) = _t2[3]})) = -8 .. 8, y = -20 .. 20

Hello,

I will buy some books for improving Maple.

Especially, I'm looking for the good books with Maple code for solving differential equations (Analytical and numerical solutions for Both Ordinary and Partial Differential equations).

 

Book Language: English.

Best regards.

Hello,

I am currently doing this thing:

unapply(piecewise(x>37-0.25*t and x<37+0.25*t,-(11*sin(t/2+1.145)-10)*((x-37)^2)+(-3.5*sin(t)+ 1),10),x);

(It is used with "for t from 0 to 8 do *things* end do", hence why I use "t")

The problem I have is I don't want this (over) complicated function to go over y=10, but the conditions I tried were not working that well.

I saw on the Help page that it should be possible, but my attempts were unsuccessful...

Maple 2018.2 generates wrong latex in this example. In Latex a space in command name is important. So "\tau L" is not the same as "\tauL".  Since in the later case, Latex will complain that there is no command "\tauL"

Maple generates "\tauL" in the latex, when it should be "\tau L" in the following example, so the latex fails to compile because there is no command called "\tauL" in Latex.

Here is screen shot showing the problem and the Maple command to reproduce it

 

 

restart;
interface(showassumed=0);
pde :=  diff(u(x,t),t)=k*diff(u(x,t),x$2)+(exp(-c*t)*sin(2*Pi*x/L));
ic  :=  u(x,0)=f(x);
bc  :=  D[1](u)(0,t)=0, D[1](u)(L,t)=0;
sol:=pdsolve({pde,ic,bc},u(x,t)) assuming L>0,t>0,k>0;

latex(sol)

Any chance Maplesoft could fix this?

Possible workaround for now is to use something like "\newcommand{\tauL}{\tau L}" in preamble for this specific case.

 

How could this be set up in Maplesim?  A vibration signal is imparted on the box and we want to observe the behavior of the sprung object inside the box.

Hello,

 

Assume we have the following "intervals" (I am not sure what is its formal name in Maple)

 

C :=[0,1/11],[1/11,1/9],[1/9, 1/7],[1/3,1/2],[1/2,1]

 

How can we get the "union" of these intervals? That is to say, obtain  [0,1/7],[1/3,1] 

 

Many thanks in advance for your comments and suggestions.

 

 

First 749 750 751 752 753 754 755 Last Page 751 of 2426