Maple Questions and Posts

These are Posts and Questions associated with the product, Maple

solve_assume.mw

dear experts

the above solution violates my assumption phi should be between -1.57 and +1.57. why?

 

Hi Maple users and experts!

I have some systems of non linear equations. Maple's "solve" is often able to give explicit solutions. However, I'm actually not very interested in the solutions but rather in knowing whether or not a unique solution exists. Is there a way to determine this with maple?

Thanks!

- John

Hellow,

 any one know how to solve the second order differential equation using finite element method (Using Linear shape functions)

Hi,

I'm dealing with an iterated function (logistic map) where f(x)=s*x*(1-x) where the s is a general parameter between 1 and 4 inclusive, and it's fourth return map, or f(f(f(f(x)))) or f^[4](x).

h:x->f(f(f(f(x))))

What I'm trying to do hinges on evaluating this:

solve(h(x)=x,x);

a

DoExist := proc(tau, n)

if rtable_num_elems(tau) >= n then

        return tau[n];

else

        return 0;

end if;

end proc;

 

g1 := [0, y, x];

g2 := [0, y^2-x-y, 0];

g3 := [x, x+y, 0];

g4 := [y, -y, 0];

g5 := [0, x*y+x/2+y/2, 0];

g6 := [0, x^2-x/4-y/4, 0];

 

m1 := Basis(g1, tdeg...

> restart; with(plottools);

> U := u(x, t);


> pde := (diff(U, `$`(x, 2)))/(2*x)^2 = (1/1250)*(diff(U, `$`(x, 2)))+(1/9)*sin(0.10e-1*Pi*t)*exp(0.10e-1*Pi*t^2);

ic := u(x, 0) = x^2, (D[2](u))(x, 0) = 1;

bc := (D[1](u))(0, t) = 0, u(1, t) = 1;


> S := pdsolve(pde, {bc, ic}, numeric);
Error, (in pdsolve/numeric/par_hyp) Incorrect number of initial conditions, expected 0, got 2
       ...

ode := diff(x(t), t, t) = 1^2*(cosh(x(t))-1)/cosh(x(t))

ics := x(0) = 2, (D(x))(0) = 0

xs := dsolve({ics, ode})

 

plot(xs, t = 0 .. 3)

 

why do i get this error?

Error, invalid input: plot expects its 1st argument, p, to be of type {set, array, list, rtable, algebraic, procedure, And(`module`, appliable)}, but received x(t) = RootOf(Int(1/(-4*arctan(exp(_a))+4*arctan(exp(2))-4+2*_a)^(1/2), _a = _Z .. 2)+t)

Hello,

I`m having trouble using dsolve in a loop in order to evaluate a differential equation for different constants/initial values. I`ve imported the data for the constants from excel using the import function and have defined them, and then created the differential equation which returned a DE with array parts. I created a sequence called sys_ode ad sys_init_val so that I could easily call the DE`s individually. I now wish to solve the DE at each of these points...

How to implement this in maple, can be developed graphically?

Hi all,

I have a question concerning a 3d theory to calculate forces, stresses, deflections, etc. I am calculating a simply supported beam (a cylindrical pile). The theory is build up cylindrical coordinates; x and theta.

solving the theory gives me deflection in 3 directions; ur (radial), ux (length), utheta (along the surface). To plot a the deflection of the pile I convert all to cartesian coordinates:

> xcart := unapply(x+ux(x, theta), [x, theta])

Hi all,

I've just started learning Maple. I can't figure it out how to transform my problem into maple syntax.

My problem includes solving a simple algebraic equation, that is,

Y[k+1] = -10*Y[k]

I would like to solve this equation for different values of k, for example, k = 0,1,2,3.

and express my results in terms of Y[0], i.e,.

Y[1] = -10*Y[0];

Y[2] = -10*Y[1] = 100*Y[0]

Y[3] = -1000*Y[0]

I don't know...

hi guys , i want to solve a system of equations but maple gives me "warning, solutions may have been lost" !

what can i do ?

 

thanks

 

z0.mw

How to find the integral

1/(4*Pi)*int((cos(t)-sin(s)-cos(t)*sin(s))/(3+2*(cos(t) - sin(s) - cos(t)*sin(s)))^(3/2),[t=0..2*Pi,s=0..2*Pi])?

Its geometric interpretation suggests the answer is -1. Maple finds the inner integrals both over t and s, but Maple cannot directly find the iterated integrals.

https://skydrive.live.com/redir?resid=E0ED7271C68BE47C!358

1/x!*subs(z=0,Diff(g(z)^x, x$(x-1))) = n*x

1/x!*subs(z=0,Diff(g(z)^x, z$(x-1))) = n*x

how to solve for g(z) ?

as i do not know what do this respect to which variable from a book. so i capture this diagram.

hope that can solve it

L := Summation(Summation(g(m, n)-g(m-1, n)-g(m, n-1), m = 1 .. 3), n = 1 .. 3);

M1 := subs(m=1, g(m, n)-g(m-1, n)-g(m, n-1))=0;

rsolve(rhs(M1),g,'genfunc'(1,b));

Error, invalid input: rsolve uses a 2nd argument, Fcns, which is missing

Reference:

Matrix([[0, g(0,1), g(0,2)],[g(1,0), g(1,1), 0],[g(2,0), 0, g(2,2)]]);

First 1457 1458 1459 1460 1461 1462 1463 Last Page 1459 of 2224