MaplePrimes Questions

Hi!

I hope every one is ok.

I am running this code (see below)

m := 2;


X[0] := 14;
                              
Y[0] := 18;
                        
a := 1; b := 1; c := .1; d := 1;

alpha := 1;

for k from 0 to m do X[k+1] := GAMMA(k*alpha+1)*(a*X(k)-b*(sum(X(s)*Y(k-s), s = 0 .. k)))/GAMMA(k*alpha+1+1); Y[k+1] := GAMMA(k*alpha+1)*(-c*Y(k)+d*(sum(X(s)*Y(k-s), s = 0 .. k)))/GAMMA(k*alpha+1+1) end do

x := 0; y := 0

The following message pop out.

PLease HELP! HELP!.....

\

 

I can't get Simpson's Rule to work properly in Maple for f(x)=cos(e^-x)

According to Wolfram Alpha, I should be getting something like -0.5. Clearly that's not what I'm getting. Please help?

> f := proc (x) options operator, arrow; cos(6*exp(-x)) end proc;
x -> cos(6 exp(-x))

S := evalf(int(f(x), x = 0 .. 1));
                         -0.4411788573
S1 := evalf((1/6)*(1+0)*(f(0)+4*f(1)+f(2)));
                         -0.1215440391
S2 := evalf((1/12)*(1+0)*(f(0)+4*f(1)+2*f(2)+4*f(3)+f(4)));
                          0.3979663797
S-S1;
                         -0.3196348182
100*(S-S1)/S;
                          72.45016685
S-S2;
                         -0.8391452370
100*(S-S2)/S;
                          190.2052247

 

Mathematica does it simply like this

Can Maple do it similarily easily?  how?

Hi ,

I have recently got to know this software and its capabilities and was wondering if I can use it to start an initial systems design for an E-scooter as a first step (virtual validation). then feed this data to a designer which will design and cooperate with an engineer to realise the design again on this platform.

SO i have the range of my scooter , the weight it carries , the enviroment's average topography which i will be simplifying it at the first step to a 15% hill climb , and finally some dynamic/static restrictions... which i hope ican build upon . like adding chasis loads and analysis to data.

I want it to give me the cell number of the batteries , verify the loads and give me a electric-motor description . 

 

this was the road map.

 

Thank you for your kind replies .

Is there a way to change the numeric formatting of 'Scientific' to use a cdot instead of a cross to represent multiplication?

Hello! 

I got a set of data imported from excel which is of the size 2001x2. I've use DataPlot to plot the graph of this data but I can't seem to find a way to integrate it. I've used BSplineCurve to make the discreate values continious but I cant seem to integrate this new curve. Can someone please give me a solution or an alternative way to find an approximative way to find the area under the curve.

Thanks

Hello,

Say I have a rational function 

 

f:= q^4*(q^2+1)*((q^6+q^5-q^4-2*q^3+q+1)^6/q^13+(q^6+q^5-2*q^3-q^2+q+1)^6/q^25)/((1+q)^4*(-q^2+1)^2)

 

in a variable q, with big degrees in numerator and denominator. I happen to know that if I make a change of variable q=exp(Ix) this rational function can be written in the form

f(exp(Ix))=\sum_{k>0, n>=0} (coefficient(n,k)) sin^(2n-2)(kx/2), where this sum is finite.

I'm trying to find (1) what is the best way to simplify the rational function f and (2) how can I make the change of variable into these variables. 

I managed to put the rational function in terms of cos(x) and sin(x), however after a day of calculations the computer couldn't simplify the expression. 

For this I was using:  simplify(rationalize(convert(subs(q=exp(Ix),factor(rationalize(f))),trig)))

I appreciate any help.

Edit: Another way of getting this variables would be to force Maple to use multiple angle identities to write the powers of cosine(x) in terms of sin(kx). Is there any way to force this kind of simplification?

Suppose i have a message X encrypted using RSA with public code (n,e) and ascii (Here we treat the message as an array so don't worry about block-length) how would one go about writing a procedure that given a public key (n,e) with small n and a ciphertext message x will decrypt x. I have been looking online to see how we can get maple to take ascii into consideration but to no avail any help would be appreciated

Guys

I can't seem to work out how the cylinder in my animation won't extend to of the bottom of the sphere initially. and how to make it stop at the maximum volume coordinates.

cylinder_in_sphere_ani.mw

 

 

Dear friends! I am facing problem to solve the below system of ODEs numerically please find the mistake and correct it.

alpha := -1; R := 2; m := 2; Pr := 7; Le := 1.25; Nt := .2; Nb := .2; g := .5; K1 := .1; Q := .5

Eq1 := eta^3*(diff(F(eta), eta, eta, eta, eta))+alpha*(eta^4*(diff(F(eta), eta, eta, eta))+eta^3*(diff(F(eta), eta, eta))-eta^2*F(eta))-2*eta^2*(diff(F(eta), eta, eta, eta))+3*eta*(diff(F(eta), eta, eta))-3*(diff(F(eta), eta))+eta*R*(diff(F(eta), eta))^2-3*eta*R*F(eta)*(diff(F(eta), eta, eta))+3*R*F(eta)*(diff(F(eta), eta))+3*eta^2*R*F(eta)*(diff(F(eta), eta, eta, eta))-eta^2*(diff(F(eta), eta))*(diff(F(eta), eta, eta))-M^2*(eta^3*(diff(F(eta), eta, eta))-eta^2*(diff(F(eta), eta))); Eq2 := eta*(diff(G(eta), eta, eta))+alpha*Pr*eta^2*(diff(G(eta), eta))+R*Pr*F(eta)*(diff(G(eta), eta))+Nb*eta*(diff(G(eta), eta))*(diff(H(eta), eta))+Nt*eta*(diff(G(eta), eta))^2+diff(G(eta), eta)+Q*Pr*eta*G(eta) = 0; Eq3 := eta*(diff(H(eta), eta, eta))+alpha*Le*Pr*eta^2*(diff(H(eta), eta))+R*Le*Pr*F(eta)*(diff(H(eta), eta))+Nt*eta*(diff(G(eta), eta, eta))/Nb+Nt*(diff(G(eta), eta))/Nb+diff(H(eta), eta)-g*Le*Pr*eta*H(eta)-Le*Pr*K1*eta = 0;

IC1 := F(0) = 0, F(1) = 1, (D(F))(0) = 0, (D(F))(1) = 0, (D(G))(0) = 0, G(1) = 1, (D(H))(0) = 0, H(1) = lambda; dsys1 := {Eq1, Eq2, Eq3, IC1}; dsol1 := dsolve(dsys1, numeric, continuation = lambda, range = 0 .. 1);

dsol1x := subs(dsol1, F(eta));

dsol1y := subs(dsol1, G(eta)); dsol1z := subs(dsol1, H(eta));
 

With my best regards and sincerely.

Muhammad Usman

School of Mathematical Sciences 
Peking University, Beijing, China

Hi all

I have 4 - 2a and (2x^2 - 2x + sqrt(2))^2. How to factor it become 2(2-a) and 2(sqrt(2)x^2 - sqrt(2)x + 1)^2 ?

Thanks you very much.

 

Hello people,

I am looking to use Maple and its loops, to develop the tensorial expressions in index notations such as this one:

My Sigma[11] is supposed to be a summation of the terms obtained when i then j are vary throughout the values, 1, 2 3 

 

Thanks

Hi,

I am looking for a way of exporting a large number of Maple files (*.mw) into text files (*.txt) automatically. Here are two questions:

  • Is there a ready-made tool allowing to do this?
  • If not, is it possible to export a maple file to text from the command line interface?

Thanks!

Samuel

Hey guys,

I have this (6x1) matrix:

And I wish to factor a vector of the recurring terms out of it, this particular vector:

So that I end up with a (6x6) Matrix multiplied to that vector.

 

Thank you

I get no output from the following

deqv := m*v(s)*(diff(v(s), s)) = m*g-k*v(s)^2

I have to write

solv := `assuming`([dsolve({deqv, v(0) = v__0}, v(s), implicit)], [v__0 > 0])

in order to get

-g*m/k-exp(-2*k*s/m)*(-g*m/k+v__0^2)+v(s)^2 = 0

and then I have to write my own function

It should be a piece of cake for maple to solve this!

Staffan

 


 

 

 

 

 

First 1015 1016 1017 1018 1019 1020 1021 Last Page 1017 of 2428