Unanswered Questions

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

hi all

how can i solve this program?

restart;
I5:=evalf(int((x^2)/((x^4-2*x0*x^2+x0^2+1)^(3/2)),x=0..infinity)):
I6:=evalf((1/2)*int(1/(x^4-2*x0*x^2+x0^2+1)^(1/2),x=0..infinity)):
A:=f-evalf((-4/Pi)*((x0*I6-I5)/(x0*I5+I6)^(1/3))):
B:=solve(A,x0);

I am attempting to write a Gaussian elimination routine to solve a system Ax = b using loops, but I have been having trouble.  Any help would be mcuh appreciated.  Thanks!

I was looking for help on polynomial division using Maple via google. But I am having hard time deciphering this web page on quo command. Is this syntax supposed to work on some Maple version?

http://www.maplesoft.com/support/help/Maple/view.aspx?path=Task/QuoAndRemOfPolynomialDivision

 

 

I also do not understand how the polynomial and the divisor are "entered" without it being assigned to variables like this. I thought it was the browser, but  I tried both Chrome and Firefox and they both show the same page.

Is the above using some new Maple product? I am using Maple 2015 on windows and I get an errors trying to type the above on my Maple worksheet.

 

and plot  function I? This I is the area which I wrote at the paper.

Could you give me the code which can be used to solve the ODE by numerical method and plot I with respect to t?

I think I have write down everything clearly but if you feel confused please ask me.

I am eager to know the code. Thanks very much!

Need help for manipulating tensor with the physics package.

I ask some questions about this.  But each time, I am refer to the help pages.  If I ask again some help, it is because I can't not start with the information on the help file.  It is written for people that already know General Relativity (GR).

 

So this time, I have created a document (attach to this post) where I ask specific queations on manipulations.  My goal is to ccrreate a document that I will put on the Applications Center.  I promess that those who will help me on this will be cited in the document.  This way, I hope to create an introduction on how to use tensors for beginner like me.

 

Then, with this help, I am sure I will be able to better understand the help page of the packages.  I am doing this as someone who is starting to learn GR and have to be able to better understand the manipulations of tensor and getting the grasp of teh meaning of all those tensor.  For exemple, the concept of parallel transport on a curve surface.

 

Thank you in advance for all the troubling I give you with this demand.

 

Regards,Parallel_Transport.mw

 

 

 

 

 

 

 

--------------------------------------
Mario Lemelin
Maple 2015 Ubuntu 14.04 - 64 bits
Maple 2015 Win 7 - 64 bits messagerie : mario.lemelin@cgocable.ca téléphone :  (819) 376-0987

I am doing a Calculus assignment and I can't find the commands for certain things.

1.Given the function f(x) = ((x+1)^2) / (1+x^2)

i) The domain of continuity of f(x)

ii) The intervals of increase and decrease of f(x) by using test points.

 

2. Use the IVT to prove existence of a root to the equation x^3 +10x^2 -100x +50=0 in the interval [-20,10]. Use again the IVT to show that there is a 1st root in [-17,-15], a 2nd toot in [0,1] and a 3rd root in [ 5,6]. Find or approximate those roots with Maple. (the bolded is what I need help).

The following illustrates a way to edit code when in Standard Worksheet.  Is there a bettery way?Thanks in advance,

Les

Let

and f=

The elements of W are none zero. I want a procedure that return "true" if f is none zero w.r.t. W and return

"false" otherwise.

 

Hello i want to solve the differential equation but i have these problem i don't understand  why !?

restart;
with(LinearAlgebra):
with(student):
P:=180000:
Vt:=P/m;
m:=1.4787880*10^5-t*606.06:
g:=9.81:
T:=176:
pi:=evalf(Pi):

Euler_x := -(diff(lambda3(t), t)) = 0;
Euler_y := -(diff(lambda4(t), t)) = 0;
Euler_Vx := -lambda3(t)-(diff(lambda1(t), t)) = 0;
Euler_Vy := -lambda4(t)-(diff(lambda2(t), t)) = 0;
Euler_theta := lambda1(t)*sin(theta)-lambda2(t)*cos(theta) = 0;
transversalnost:=y(t)-lambda1(t)*Vt*cos(theta)-lambda2(t)*Vt*sin(theta)+lambda2(t)*g-lambda3(t)*Vx(t)-lambda4(t)*Vy(t)=0;

transversalnost:=eval(transversalnost,t=176);

sys:={Euler_x, Euler_Vx, Euler_y, Euler_Vy, theta=arctan(lambda2(t)/lambda1(t)), diff(Vx(t),t)=Vt*cos(theta), diff(Vy(t),t)=Vt*sin(theta)-g, diff(y(t),t)=Vy(t), diff(x(t),t)=Vx(t),x(0)=0, y(0)=0.302, lambda1(0)=0, lambda2(0)=0, lambda3(0)=0, lambda4(0)=0,transversalnost, x(176)=120};

ans:=dsolve(sys, numeric, output=listprocedure):

Error, (in dsolve/numeric/bvp/convertsys) unable to convert to an explicit first-order system

thanks for your help

 

Download 1234.mw

Hi everyone,

 

I'm trying to solve the following eqauation but Maple gives me the answer (( RootOf(mexp(-_Z*(m-1))*d^2-theta+_Z*theta-theta*c*t__kj) ))

 

The equation is:

solve(mexp(-(m-1)*t__ij)*d^2-theta+theta*t__ij-theta*(sum(t__kj, k = 1 .. c))-m*eta*(diff((1-1/exp(t))^m, t)) = 0, t__ij);

 

Could you please help me??

 

What is the meaning rootOF? Is there any explicit solution to that equation??

 

Thank you for your help

Hi everyone,

I'm trying to solve the following equation and unfortunately I get this error ( Error, (in Engine:-Dispatch) invalid subscript selector ) each time I try. Could you please help me??

I will be thankful for your great help.

solve(m*exp(-(m-1)*tij)*d2-θ+θ*tij-θ*(Σ(tkj, k = 1 .. c))-m*η*(1-exp(-tij))(m-1) = 0, tij)

Good Day Everybody, I m new to maple and would like to translate the following for loop from Matlab to Maple. The FromMatlab Translater didnt work for this expression related to the matrix Q, A, B D and A1. Any help would be greatly appreciated.

Related Matlab Code:

...

Q(3,3)=2*Q(3,3);

 for i=1:length(R)

    T(1,1)=cos(R(i))^2; 

    T(2,2)=cos(R(i))^2; 

    T(1,2)=sin(R(i))^2; 

    T(2,1)=sin(R(i))^2; 

    T(3,1)=-sin(R(i))*cos(R(i)); 

    T(3,2)=sin(R(i))*cos(R(i)); 

    T(1,3)=2*sin(R(i))*cos(R(i)); 

    T(2,3)=-2*sin(R(i))*cos(R(i)); 

    T(3,3)=cos(R(i))^2-sin(R(i))^2;

    T1(1,1)=cos(R(i)); 

    T1(1,2)=-sin(R(i)); 

    T1(2,1)=sin(R(i)); 

    T1(2,2)=cos(R(i));

    

    Qk(:,:,i)=inv(T)*Q*T; 

    Qk(:,3,i)=Qk(:,3,i)/2; 

    Qk1(:,:,i)=inv(T1)*Q1*T1;

    A=A+Qk(:,:,i)*(h(i+1)-h(i)); 

    B=B+.5*Qk(:,:,i)*(h(i+1)^2-h(i)^2); 

    D=D+1/3*Qk(:,:,i)*(h(i+1)^3-h(i)^3); 

    A1=A1+Qk1(:,:,i)*(h(i+1)-h(i));

end

Thanks a lot in advance.

a system of monomials, which has 5 equations for 5 variables , have more than one solutions,

first solution is my wanted solution,

how to eliminate other unwanted solutions?

whether

1. add more equations to eliminate unwanted solutions? how to do?

or

2. edit existing system to eliminate unwanted solutions? how to do?

    a.  add extra terms to some equations?

 

what is the cause that make it having more than one solutions?

can this reason help to edit existing system?

 

i succeed with adding extra equation,a1+a2+a3+a4+a5-(6+s) =0  in 3 variables case, it calculate very fast within 1 second.

but when calculating 5 variables, it evaluating a very very long time, what is the problem

 

without extra equation a1+a2+a3+a4+a5+a6+a7-(1+2+3+4+5+s), it get result within 1 second, but after adding this extra equation, it is like dead loop,

my surface computer run with large fans noise and very hot.

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, w) -> -(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, w), E=0..5),seq(-p((1/2)*E, w), E=0 .. 5)]:
plot(lst, w= -3*Pi..3*Pi, color = black, numpoints=1000);

Q is the new coordinate which is diff(S,E)

t0 is the time when argument of solve(subs(m=1, diff(S,E))=0, t) vanish
initialq := solve(solve(subs(m=1, diff(S,E))=0, t)=0, q);

after find the initial value, how to plot with new coordinate?

dsolve({H, q=0}, f(q,P,t));

 

i try another way to do

 

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]);
p2 := subs(m=1, diff(S,q));

initialq := solve(solve(subs(m=1, diff(S,E))=0, t)=0, q);

H := subs(p=p2, 1/(2*m)*p^2 + 1/2*m*w^2*q^2) = -diff(f(t), t);
H := subs(w=theta(t), H);
sol := dsolve({H, q=0}, numeric, range = 0 .. 30);
odeplot(sol, [t, theta(t)], refine = 2);


Error, (in dsolve/numeric/process_input) invalid specification of initial conditions, got q = 0

 

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