Maple Questions and Posts

These are Posts and Questions associated with the product, Maple

    /  /                                                    0.5
    |  |/         2                                        \   
 int\x \\D(c[2]) x  + 2 c[2] D(x) x + D(c[1]) x + c[1] D(x)/   

                                              \            \
            2             2                1.5|            |
    + c[2] x  + c[1] x - x  - 1.504505556 x   /, x = 0 .. 1/
   /   /                                                    0.5
   | 2 |/         2                                        \   
int\x  \\D(c[2]) x  + 2 c[2] D(x) x + D(c[1]) x + c[1] D(x)/   

                                             \            \
           2             2                1.5|            |
   + c[2] x  + c[1] x - x  - 1.504505556 x   /, x = 0 .. 1/
 

Hi,

I naively thought that
f := t -> Some expression containing t
and
f := unapply(Some expression containing t, t)
where two different ways to define the same function f.

 

Recently I defined f and g this way
X := RandomVariable(Normal(m, s)):
U := Sample(X, 30000) ;  
f := t -> PDF(X, t);
g := unapply(PDF(X, t), t);

Could you explain me why f~(U) exectues in about 10 seconds and g~(U) in less than 0.1 s ?

Thanks in advance

 

 

Hellow , Any body can help me to write the codes for the differential equation to solve by Galerkin finite element method by four elements by taking step size h=pi/2 and compare with homotropy method by plotting the graph of Galerkin method, homotropy method and exact, here is my codes

ode := diff(y(x), x, x) + y(x)-1=0:
ics := y(0) = 0, y(2*pi) = 0:
dsolve({ics, ode}):
 

How to do a full reinstall so that no settings are kept?

I tried deleting the maple 2017 folder in program files after I uninstalled but that did not help.

I need my results are nice and neat in final presentation so how can I change the way it present matrix in maple, its so messy in hear like picture . It happend resulted in Maple can reduce the same ratio such as As^2+Bs^2=(A+B)s^2, I tried all my best to find way to simply it but its so hard due to my noob in maple. Please help me make it nice and neat in array of matrix [    ]. 

Hello everyone

I am new in mapple software and i am facing some proplem to tackle  Laplace equation and Poisson equation. I want to find out the potential psi given in two equations 

I want to solve following equ with finite difference method in order to find potential psi .In the second equation  n = concentration of electrons  ,p= concentration of holes and C= additional concentration ,q is electronic charge .

Can anyone suggeset how I can solve this type of partial differential equation with numerical method (FDM) in mapple?

Can we use this euler lagrange command for the system of pde's?

If we have a system without lagrangian then euler opertor is applied corresponding to three dependent variables.

so we have three equations but in this euler lagrange command no dependent variable is mentioned.   

When I right-click on a Matrix, the cursor rotates, but the context menu does not open at all (in Maple 2017, in document mode, in Win 10).
Any suggestions - Anyone else with this problem?

Just like the title described, I have encountered an error when I use the command "expand". Actually, I just follow the example, but it doesn't work. Please help me or tell me how can I solve it in other commands.


restart;
alias(epsilon = e, omega = w, omega[0] = w0, t[1] = t1, t[2] = t2); e := proc (t1, t2) options operator, arrow; e end proc; w0 := proc (t1, t2) options operator, arrow; w0 end proc; a := proc (t1, t2) options operator, arrow; a end proc; f := proc (t1, t2) options operator, arrow; f end proc; mu := proc (t1, t2) options operator, arrow; mu end proc;
ode := (D@@2)(u)+2*mu*e*D(u)+w0^2*u+e*w0^2*u^3-e*f*cos(omega*t) = 0;
                                               2  
     @@(D, 2)(u) + 2 mu epsilon D(u) + omega[0]  u

                          2  3                             
        + epsilon omega[0]  u  - epsilon f cos(omega t) = 0
e_oredr := 1;
ode := simplify(subs(D = sum('e^(i-1)*D[i]', 'i' = 1 .. e_oredr+1), ode), {e^(e_oredr+1) = 0});
 / 3         2                                                 
 \u  omega[0]  + 2 (epsilon D[2] + D[1])(u) mu - cos(omega t) f

                  \                   2                   
    + 2 D[1, 2](u)/ epsilon + omega[0]  u + D[1, 1](u) = 0
simplify(collect(%, e), {e^(e_oredr+1) = 0});

u := sum('v[i]*e^i', 'i' = 0 .. e_oredr);
                      epsilon v[1] + v[0]
ode := simplify(collect(ode, e), {e^2 = 0});
for i from 0 to e_oredr do eq[i] := coeff(lhs(ode), e, i) = 0 end do;
                       2                         
               omega[0]  v[0] + D[1, 1](v[0]) = 0
       3         2           2                       
   v[0]  omega[0]  + omega[0]  v[1] + 2 D[1](v[0]) mu

      - cos(omega t) f + 2 D[1, 2](v[0]) + D[1, 1](v[1]) = 0
remove(has, lhs(eq[1]), cos); convert(%(t1, t2), diff);
eq[1] := %-convert(f*cos(sigma*t2+t1*w0), 'exp');

v[0] := A(t2)*cos(w0*t1+B(t2)); convert(%, 'exp'); v[0] := unapply(%, t1, t2);
                         /1                             
       (t1, t2) -> A(t2) |- exp(I (omega[0] t1 + B(t2)))
                         \2                             

            1                              \
          + - exp(-I (omega[0] t1 + B(t2)))|
            2                              /

expand(eq[1]);
Error, (in property/ConvertProperty) invalid input: PropRange uses a 2nd argument, b, which is missing
collect(%, exp(I*w0*t1));
Error, (in collect) invalid 1st argument proc (t1, t2) options operator, arrow; A(t2)*((1/2)*exp(I*(w0*t1+B(t2)))+(1/2)*exp(-I*(w0*t1+B(t2)))) end proc
coeff(%, exp(I*w0*t1));
map(proc (x) options operator, arrow; x*exp(-I*B(t2)) end proc, %);
combine(%, 'exp');
subs(I*B(t2) = I*sigma*t2-I*C(t2), B(t2) = sigma*t2-C(t2), %);
conds := combine(%, 'exp');
                               0

 

With this feature, it requires the worksheet from which to import a result from executing it from the worksheet with the Run worksheet command to have section titles as Input  and Calculation respectively.

 

This is a really helpful feature, but what i need is to "fetch" the content from a number of worksheets in a folder from a specified particular section name, for a number of different section names.

I worked on a document about 2 hours ago. And now when I try to open it, it is empty. I saved it in MapleCloud, and I have had it saved before. So today I opnened the saved file from MapleCloud, but now it is gone. How can I get it back!!? It happend to two of my most important files..

PDE := diff(u(x, y), x, x)+diff(u(x, y), y, y)-6*x*y*(1-y)-2*x^3 = 0; BCsx := u(xL, y) = 0, u(xU, y) = y*(1-y); BCsy := u(x, yL) = 0, u(x, yU) = 0; solPDE := pdsolve({BCsx, BCsy, PDE}, u(x, y)); exactSol := unapply(rhs(%), x, y)

how i can write these boundary conditions for dsolve?

(diff(u(r), r))^(n-1)*(diff(r*(diff(u(r), r)), r))/r    be [finite] at r =0

and  u(0) = finite?

Thanks..

 

Hello!

I can't seem to figure out how to use the Physics package within a procedure. In particular, I can't get tensors to be recognized within the body of the proc.

As an example, here's a short program that works correctly when not in a procedure:

with(Physics):
Coordinates(X,quiet):
d_[mu](X[~mu]);
# Returns 4; Correct

However, placing this code inside a proc causes the tensor X to not be recognized as a tensor:

Test := proc()
  uses Physics:

  Coordinates(X,quiet):
  d_[mu](X[~mu]);
end proc:
Test();
# Returns 0; Wrong

Apparently, Physics:-Coordinates still defines the tensor X (as can be checked by calling Physics:-Define()). However, the derivative d_[mu] (X[~mu]) seems to be treating X as a standard symbol. Any idea how I would go about correcting this?

Thanks!

I am sure that this is a common enough problem. I want to show what commands I'm using to make an output in a maple worksheet in a latex document that i can include in a report.

So far I've got the export feature to work:

(here is an example mapleworksheet, texfile and a corresponding LatexProducedPDF),

but i can't see how to get it to include the commands that create the output.

First 99 100 101 102 103 104 105 Last Page 101 of 2097