Unanswered Questions

This page lists MaplePrimes questions that have not yet received an answer

restart;
H := subs(p=diff(f(q,P,t), q), 1/(2*m)*p^2 + 1/2*m*w^2*q^2) = -diff(f(q,P,t), t);
H:=subs( f(q,P,t) = f1(q) + f2(t), H);
sol:=dsolve({rhs(H)=E,lhs(H)=E});
S:=rhs(sol[1][1]+sol[1][2]);
subs(m=1, diff(S,q));
p := (E, theta) -> -(1/2)*sqrt(-q^2*w^2+2*E)+(1/2)*q^2*w^2/sqrt(-q^2*w^2+2*E)-E*(sqrt(w^2)/sqrt(-q^2*w^2+2*E)+sqrt(w^2)*q^2*w^2/(-q^2*w^2+2*E)^(3/2))/(sqrt(w^2)*(1+w^2*q^2/(-q^2*w^2+2*E)));
lst := [seq(p((1/2)*E, theta), E=0..5),seq(-p((1/2)*E, theta), E=0 .. 5)]:
plot(lst, theta = -3*Pi..3*Pi, color = black, numpoints=1000);

 

i plot it circle in circle, should i substitute a value to q before plot?

i guess q is velocity, is it?

why substitute E with 1/2*E?

subs(q=1, subs(m=1, diff(S,q)));
p := (E, w) -> -(1/2)*sqrt(-w^2+2*E)+(1/2)*w^2/sqrt(-w^2+2*E)-E*(sqrt(w^2)/sqrt(-w^2+2*E)+sqrt(w^2)*w^2/(-w^2+2*E)^(3/2))/(sqrt(w^2)*(1+w^2/(-w^2+2*E)));
lst := [seq(p((1/2)*E, w), E=1..5),seq(-p((1/2)*E, w), E=1 .. 5)]:
plot(lst, w = -3*Pi..3*Pi, color = black, numpoints=1000);

Hi,

 

I am working on a Windows machine. In older Maple versions, decreasing the font size for the screen display (via zoom factor) also decreased the font size for the printout. But now the printout comes with a pretty large font size and does not change when using the zoom factor. It practically makes no sense anymore to print. How can I decrease the fonts for the printout to my liking?

Thanks.

heide

I run the following working maplet:

 

 

Where "muutujad" is a procedure I defined and which returns the three inputs in the form [TF1,TF2,TF3].

It works fine, but if I insert "theta" as input, it of course stays in the string form, not Θ. Even if I copy the symbol and paste it in the textfied, it doesn't accept the symbol. Is there any way I can convert the text input to actual symbol?

Hallo everybody,

I just started to use maple and I think I need some help from more experienced users.
I would like to transform the stationary Navier Stokes equations to toroidal coordinates.


The definition of my coordinate system is as follows:
x = -r * cos(sigma)
y = cos(Theta) * ( R + r * sin(sigma) )
z = sin(Theta) * ( R + r * sin(sigma) )


I tried to define the coordinate system and transform each term of the equation:

div( rho * CC) = -grad(p) + div(Tau)

I can transform the pressure gradient. However, I get an error for the divergence of the tensors.
Could someone please give me a hint on how to get the divergences?

Thanks!
Uwe



My code is printed below:

restart: with(plots): with(LinearAlgebra): with(VectorCalculus): with(linalg):

#torus defintion
x := -r*cos(sigma);
y := cos(Theta)*(R+r*sin(sigma));
z := sin(Theta)*(R+r*sin(sigma));
R := .35;
AddCoordinates(torus1[r, sigma, Theta], [cos(Theta)*(R+r*sin(sigma)), sin(Theta)*(R+r*sin(sigma)), -r*cos(sigma)]);
SetCoordinates(torus1[r, sigma, Theta]);

#pressure gradient
PressureGradient := Gradient(p(r, sigma, Theta, t));

#left hand side
c := vector(3, ([Cr, Ctheta, Cx])(r, sigma, Theta, t));
rhoCC := rho*multiply(c, transpose(c));
LHS := Divergence(rhoCC)

Question regarding solving the equation systems. 

See maple file for equations. 

 

Equation_questions_.mw

Are there any examples of network solutions such as mine systems in Maple.
I wrote in the Maple system of partial differential equations describing the process of filtration combustion.
I'm a novice. I do not quite understand how to solve it.
Online a lot of "simple" examples. I need something very similar to my case.

Model03.mw

Dear collagues

Hi,

I write a code to solve a system of ODE. It solve the ODES in a wide range of parameters but as I decrease NBT below 0.5, it doesnt converge. I do my best but I couldn't find the answer. Would you please help me? Thank you

Here is my code and it should be run for 0.1<NBT<10. the value of NBT is input directly in res1.

restart:
EPSILONE:=1000:
Digits:=15:

a[mu1]:=5.45:
b[mu1]:=108.2:
a[k1]:=1.292:
b[k1]:=-11.99:




rhop:=4175:
rhobf:=998.2:
mu1[bf]:=9.93/10000:
k1[bf]:=0.597:

rhost(eta):=1-phi(eta)+phi(eta)*rhop/rhobf;
k:=unapply(k1[bf]*(1+a[k1]*phi(eta)+b[k1]*phi(eta)^2),eta);


eq1:=(diff(u(eta), eta))*a[mu1]*(diff(phi(eta), eta))+2*(diff(u(eta), eta))*b[mu1]*phi(eta)*(diff(phi(eta), eta))+((diff(u(eta), eta))+(diff(u(eta), eta))*a[mu1]*phi(eta)+(diff(u(eta), eta))*b[mu1]*phi(eta)^2)/(eta+EPSILONE)+diff(u(eta), eta, eta)+(diff(u(eta), eta, eta))*a[mu1]*phi(eta)+(diff(u(eta), eta, eta))*b[mu1]*phi(eta)^2+1-phi(eta)+phi(eta)*rhop/rhobf:
eq2:=(1+a[k1]*phi(eta)+b[k1]*phi(eta)^2)*(diff(T(eta), eta))/(eta+EPSILONE) + (a[k1]*(diff(phi(eta), eta))+2*b[k1]*phi(eta)*(diff(phi(eta), eta)))*(diff(T(eta), eta))+(1+a[k1]*phi(eta)+b[k1]*phi(eta)^2)*(diff(T(eta), eta, eta));
eq3:=diff(phi(eta),eta)+phi(eta)/(N_bt*(1+gama1*T(eta))^2)*diff(T(eta),eta):

eq2:=subs(phi(0)=phi0,eq2):
eq3:=subs(phi(0)=phi0,eq3):


eval(dsolve({eq3,phi(1)=phiv},phi(eta)),(T)(1)=1):
Phi:=normal(combine(%)):
Teq:=isolate(eval(eq2,Phi),diff(T(eta),eta)):
ueq1:=eval(eq1,Phi)=0:
ueq2:=subs(Teq,ueq1):


lambda:=0;
Ha:=0;
N_bt:=cc*NBT+(1-cc)*0.8;
kratio:=k1[p]/k1[bf]:






GUESS:=[T(eta) =0.0001*eta, u(eta) =0.1*eta, phi(eta) = 0.3*(eta-1)^4];
res1 := dsolve(subs(NBT=0.48,gama1=0.2,phiv=0.06,{eq1,eq2,eq3,u(0)=lambda*D(u)(0),D(u)(1)=0,T(0)=0,phi(1)=phiv,T(1)=1}), numeric,method=bvp[midrich],maxmesh=4000,approxsoln=GUESS, output=listprocedure,continuation=cc):
G0,G1,G2:=op(subs(subs(res1),[phi(eta),u(eta),diff(T(eta),eta)])):

masst:=evalf(int((1-G0(eta)+G0(eta)*rhop/rhobf)*G1(eta), eta = 0..1));
heatt:=(1+a[k1]*G0(0)+b[k1]*G0(0)^2)*G2(0);

plots:-odeplot(res1,[[eta,T(eta)]],0..1,legend=[T],color=["Black"],linestyle=Solid,axes=boxed,thickness=3);
plots:-odeplot(res1,[[eta,u(eta)]],0..1,legend=[u],color=["Black"],linestyle=Solid,axes=boxed,thickness=3);
plots:-odeplot(res1,[[eta,phi(eta)]],0..1,legend=[phi],color=["Black"],linestyle=Solid,axes=boxed,thickness=3);

>
>

 

Thank you

 

Amir

 Maple code when open saved maple sheet?

and keep it can run code and show latest result after open

i mean user can not extend or find code or display code in maple sheet , just can run result

Dear all,

I'm having a bit of trouble figuring out some error messages in the Maple debugger. When I debug some procedures I'm getting error messages like "Error, invalid input: %1 expects its %-2 argument, %3, to be of type %4, but received %5". Since the procedure calls a lot of other procedures I have to check every single one of them, to see, which one gives me the error message. It would be easier if I would know, what procedure/type hides behind the variables %1,... Is there a way to check this from within the debugger?

Thanks a lot.

Why have there been so many old Posts and Questions moving to the top of the Active Conversations stack the past two days, even though they have no new activity? This makes MaplePrimes very difficult to use! Please make it so that the Active Conversations stack is sorted by the actual time of the most-recent addition to the thread.

Im working on an assignment involving a rocket being launched vertically from rest. 
I have a eq. of motion that looks like this: v(t)=vs*ln(-m0/(r*t-m0))-g*t

Now Im supposed to implement the air resistance, and write an expression for the total force on the rocket. After that creating a plot displaying the speed v(t) as a function of time for both, with and without air resistance. 

All constants are known including CD, rho and A for the dragforce. 

I would be grateful if anyone could help me with this!

Thanks

Hello altogether,

I want to plot the numerical result of an ODE, which seems to be pretty simple at first sight, but the difficulty is that the boundaries are depending on the solution.

The following pseudo-code describes what I want to have, but it doesn't work. This code fills the RAM pretty fast and you will have to kill the process.

Free-boundary_prob.mw

Is it possible to calculate a solution to this problem numerically (or even analytically) and if yes, how?

Since I am new here, I am sorry for any bad-to-read maple code or any noob errors I have made. I would be very thankful, for any response and help.

Greetings

butterflyfart

sys := [(diff(c(t), t))*(diff(a(t), t))*(diff(b(t), t))+(diff(c(t), t))*t^2, (diff(c(t), t))*(diff(a(t), t))*t+(diff(c(t), t))*t*(diff(b(t), t)), (diff(c(t), t))*(diff(a(t), t))*(diff(b(t), t))+(diff(c(t), t))*(diff(a(t), t))*t+(diff(c(t), t))*t^2]
DEplot(sys, [a(t), b(t), c(t)], t = 0 .. 2, a = -15 .. 15, b = -15 .. 15, c = -15 .. 15, color = magnitude, title = `Stable Limit Cycles`, arrows = curve, dirfield = 800, axes = none);
odeplot(sys, [t, a(t), b(t), c(t)], -4 .. 4, color = orange);

with(RegularChains);
with(ConstructibleSetTools);
source1 := PolynomialRing([a, b, c, d]);
target1 := PolynomialRing([e1, e2, e3, e4]);
source1list := [eq2a, eq3a, eq4a, 0];
target1list := [eq2b, eq3b, eq4b, eq5b];
cs := PolynomialMapPreimage(target1list, source1list, source1, target1)

return
cs := constructible_set

then i type
Elements(constructible_set)

it return 

Elements(constructible_set)

 since source has less number of variables, in order to use this function

i add a dummy variable d to this and use 0 for the fourth equation

First 185 186 187 188 189 190 191 Last Page 187 of 334