MaplePrimes Questions

restart:

Digits:= trunc(evalhf(Digits)); #generally a very efficient setting

15

(1)

Setup of BVP system:

#ordinary differential equations:
ODEs:= [
   #Eq 1:
   A1*(diff(f(x), x, x, x))/(A2*phi)-(diff(f(x), x))^2-M^2*(f(x))+f(x)*(diff(f(x), x, x)),

   #Eq 2:
   A4*Pr*phi*(diff(Theta(x), x, x))/A3+f(x)*(diff(Theta(x), x))+Q*Theta(x)
   
   #All these ODEs are implicitly equated to 0.
]:

<ODEs[]>; #Display the ODEs.

Vector(2, {(1) = A1*(diff(diff(diff(f(x), x), x), x))/(A2*phi)-(diff(f(x), x))^2-M^2*f(x)+f(x)*(diff(diff(f(x), x), x)), (2) = A4*Pr*phi*(diff(diff(Theta(x), x), x))/A3+f(x)*(diff(Theta(x), x))+Q*Theta(x)})

(2)

Params := Record(fw = .2, M = .5, Q = .5, Pr = 6.2, phi = 0.5e-1, rf = 997.1, kf = .613, cpf = 4179, btf = 0.3e-4, p1 = 0.1e-1, p2 = 0.5e-1, p3 = 0.5e-1, rs1 = 5100, ks1 = 3007.4, cps1 = 410, bs1 = 0.2e-3, rs2 = 2200, ks2 = 5000, cps2 = 790, bs2 = 0.5e-3, rs3 = 3970, ks3 = 40, cps3 = 765, bs3 = 0.4e-3, A1 = B1*p1+B2*p2+B3*p3, B1 = 1+2.5*phi+6.2*phi^2, B2 = 1+13.5*phi+904.4*phi^2, B3 = 1+37.1*phi+612.6*phi^2, B4 = (ks1+2*kf-2*phi*(kf-ks1))/(ks1+2*kf+phi*(kf-ks1)), B5 = (ks2+3.9*kf-3.9*phi*(kf-ks2))/(ks2+3.9*kf+phi*(kf-ks2)), B6 = (ks3+4.7*kf-4.7*phi*(kf-ks3))/(ks3+4.7*kf+phi*(kf-ks3)), A2 = 1-p1-p2-p3+p1*rs1/rf+p2*rs2/rf+p3*rs3/rf, A3 = B4*p1+B5*p2+B6*p3, A4 = 1-p1-p2-p3+p1*rs1*cps1/(rf*cpf)+p2*rs2*cps2/(rf*cpf)+p3*rs3*cps3/(rf*cpf))

Record(fw = .2, M = .5, Q = .5, Pr = 6.2, phi = 0.5e-1, rf = 997.1, kf = .613, cpf = 4179, btf = 0.3e-4, p1 = 0.1e-1, p2 = 0.5e-1, p3 = 0.5e-1, rs1 = 5100, ks1 = 3007.4, cps1 = 410, bs1 = 0.2e-3, rs2 = 2200, ks2 = 5000, cps2 = 790, bs2 = 0.5e-3, rs3 = 3970, ks3 = 40, cps3 = 765, bs3 = 0.4e-3, A1 = B1*p1+B2*p2+B3*p3, B1 = 1+2.5*phi+6.2*phi^2, B2 = 1+13.5*phi+904.4*phi^2, B3 = 1+37.1*phi+612.6*phi^2, B4 = (ks1+2*kf-2*phi*(kf-ks1))/(ks1+2*kf+phi*(kf-ks1)), B5 = (ks2+3.9*kf-3.9*phi*(kf-ks2))/(ks2+3.9*kf+phi*(kf-ks2)), B6 = (ks3+4.7*kf-4.7*phi*(kf-ks3))/(ks3+4.7*kf+phi*(kf-ks3)), A2 = 1-p1-p2-p3+p1*rs1/rf+p2*rs2/rf+p3*rs3/rf, A3 = B4*p1+B5*p2+B6*p3, A4 = 1-p1-p2-p3+p1*rs1*cps1/(rf*cpf)+p2*rs2*cps2/(rf*cpf)+p3*rs3*cps3/(rf*cpf))

(3)

LB, UB := 0, 1; BCs := [`~`[`=`](([f(x), diff(f(x), x), Theta])(LB), [fw, 1, 1])[], `~`[`=`](([diff(f(x), x), Theta])(UB), [0, 0])[]]

[(f(x))(0) = fw, (diff(f(x), x))(0) = 1, Theta(0) = 1, (diff(f(x), x))(1) = 0, Theta(1) = 0]

(4)

NBVs := [A1*(diff(f(x), x, x))(0) = C*`*f`, -A4*(diff(Theta(x), x))(0) = `Nu*`]; Nu := `Nu*`; Cf := `C*__f`; x0 := Array([LB])

NULL

Solve := module () local nbvs_rhs, Sol, Dsolve, ModuleApply, AccumData, ModuleLoad; export SavedData, Pos, Init;  nbvs_rhs := `~`[rhs](:-NBVs); Dsolve := proc (Sys, Params::(set(name = realcons))) option remember; Sol := dsolve(Sys, _rest, 'numeric'); AccumData(Params); eval(Sol) end proc; ModuleApply := subs(_Sys = {:-BCs[], :-NBVs[], :-ODEs[]}, proc ({ fw::realcons := Params:-fw, Pr::realcons := Params:-Pr, M::realcons := Params:-M, Q::realcons := Params:-Q, phi::realcons := Params:-phi }) Dsolve(_Sys, {_options}, {_rest}[]) end proc); AccumData := proc (params::(set(name = realcons))) local n, nbvs; if Sol::rtable then nbvs := seq(n = Sol[2, 1][1, Pos(n)], n = nbvs_rhs) else nbvs := `~`[`=`](nbvs_rhs, eval(nbvs_rhs, Sol(:-LB)))[] end if; SavedData[params] := Record[packed](params[], nbvs); return  end proc; ModuleLoad := eval(Init); Init := proc () Pos := proc (n::name) local p; option remember; member(n, Sol[1, 1], 'p'); p end proc; SavedData := table(); return  end proc; ModuleLoad() end module

NULL

colseq := [red, green, blue, brown]

#parameter values that remain fixed for the entire set of plots:
Pc:= phi=0.05:
 

#parameter values that remain fixed with each of the four plots::
Ps:= [
   [fw=0.2, Pr=6.2, M=0.5],
   [fw=0.2, Q=0.3, M=0.5],
   [fw=0.2, Pr=6.2, Q=0.3],
   [Q=0.3, Pr=6.2, M=0.5]
]:

#parameter value for each curve
Pv:= [
   Q=[0.2, 0.4, 0.6, 0.8],
   Pr=[0.7, 1.4, 2.1, 2.8],
   M=[0.6, 1.2, 1.8, 2.4],
   fw=[1, 2, 3, 4]
]:
      

for i to nops(Ps) do
   plots:-display(
      [seq(
         plots:-odeplot(
            Solve(lhs(Pv[i])= rhs(Pv[i])[j], Ps[i][], Pc),
            [x, Theta(x)], 'color'= colseq[j], 'legend'= [lhs(Pv[i])= rhs(Pv[i])[j]]
         ),
         j= 1..nops(rhs(Pv[i]))
      )],
      'axes'= 'boxed', 'gridlines'= false,
      'labelfont'= ['TIMES', 'BOLDOBLIQUE', 16],
      'caption'= nprintf(
         cat("\n%a = %4.2f, "$nops(Ps[i])-1, "%a = %4.2f\n\n"), (lhs,rhs)~(Ps[i])[]
      ),
      'captionfont'= ['TIMES', 16]
   )
od;

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

 

for i to nops(Ps) do plots:-display([seq(plots:-odeplot(Solve(lhs(Pv[i]) = rhs(Pv[i])[j], Ps[i][], Pc), [x, D(f(x))], 'color' = colseq[j], 'legend' = [lhs(Pv[i]) = rhs(Pv[i])[j]]), j = 1 .. nops(rhs(Pv[i])))], 'axes' = 'boxed', 'gridlines' = false, 'labelfont' = ['TIMES', 'BOLDOBLIQUE', 16], 'caption' = nprintf(cat(`$`("\n%a = %4.2f, ", nops(Ps[i])-1), "%a = %4.2f\n\n"), `~`[lhs, rhs](Ps[i])[]), 'captionfont' = ['TIMES', 16]) end do

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

 

ParamPlot2d := proc (Y::{`module`, procedure}, X::(name = range(realcons)), FP::(list(name = realcons)), { dsolveopts::(list({name, name = anything})) := [] }) plot(proc (x) options operator, arrow; Y(Solve(lhs(X) = x, FP[], 'abserr' = 0.5e-4, 'interpolant' = false, 'output' = x0, dsolveopts[])) end proc, rhs(X), 'numpoints' = 25, 'axes' = 'boxed', 'gridlines' = false, 'labelfont' = ['TIMES', 'BOLDOBLIQUE', 16], 'caption' = nprintf(cat(`$`("%a = %4.2f, ", nops(FP)-1), "%a = %4.2f"), `~`[lhs, rhs](FP)[]), 'captionfont' = ['TIMES', 16], _rest) end proc

#procedure that extracts Nusselt number from dsolve solution:
GetNu:= (Sol::Matrix)-> Sol[2,1][1, Solve:-Pos(:-Nu)]:

Q:= [0.2, 0.4, 0.6]:
plots:-display(
   [seq(
      ParamPlot2d(
         GetNu, fw= 1..4, [M= 0.5],
         'dsolveopts'= [Q= Q[k], Pr=6.2,  phi=0.05],
         'legend'= [Q= Q[k]], 'color'= colseq[k], 'labels'= [fw, Nu]
      ),
      k= 1..nops(Q)
   )]
);

Error, invalid input: ParamPlot2d expects value for keyword parameter dsolveopts to be of type list({name, name = anything}), but received [[.2, .4, .6] = .2, Pr = 6.2, phi = 0.5e-1]

 

NULL

Download surface_dinesh_paper.mw  please help me to solve the problem

Hi, I would appreciate some help in solving the following system of partial differential equations. The particularity of the system is that only the individual variables (i.e. a, c, and l) depend on two arguments (t: current time period and v: date of birth). The other variables are either rates or aggregates. The aggregate variables (i.e. K, L, and Y) depend only on time, t, because they are the integrals of the individual variables over v. Thanks for your help.

NULL

NULL

restart; with(PDEtools)

alpha := .3306341; delta := solve(1+0.4877489e-1 = exp(delta_a)); T := 1

l0 := 42.375*(33.16667/(52*(24-9.95)*7)); L0 := l0*T

x0 := 0

IOR := .2093723865

KOR := IOR/delta

r0 := alpha/KOR-delta; rho := r0; fsolve({K0 = Y0*KOR, w0 = (1-alpha)*Y0/L0, alpha*exp(x0)*K0^(alpha-1)*L0^(1-alpha) = r0+delta}); assign(%)

0.2758153402e-1

 

{K0 = 2.510740299, Y0 = .5710794198, w0 = 1.390997088}

(1)

C0 := -K0*delta+Y0; c0 := C0/T

.4515111588

 

.4515111588

(2)

sigma := w0*(1-l0)/c0

2.234133040

(3)

eq1 := diff(c(t, v), t) = (r(t)-rho)*c(t, v)

eq2 := sigma*c(t, v) = w(t)*(1-l(t, v))

eq3 := r(t)*a(t, v)+w(t)*l(t, v) = c(t, v)+diff(a(t, v), t)

eq4 := Y(t) = exp(x(t))*K(t)^alpha*L(t)^(1-alpha)

eq5 := r(t)-delta = alpha*Y(t)/K(t)

eq6 := w(t) = (1-alpha)*Y(t)/L(t)

eq7 := K(t) = int(a(t, v), v = t-T .. t)

eq8 := L(t) = int(l(t, v), v = t-T .. t)

eq9 := x(t) = piecewise(t = 0, 0, t > 0, 0.1e-1)

eq := {eq1, eq2, eq3, eq4, eq5, eq6, eq7, eq8, eq9}

SV := {K(0) = K0, L(0) = L0, Y(0) = Y0, a(t, 0) = 0, c(0, 0) = c0, l(0, 0) = l0, r(0) = r0, w(0) = w0}

pdsolve(eq, SV, numeric, 'time' = t, 'range' = 0 .. T)

Error, (in pdsolve/numeric/process_PDEs) variable(s) {v} are in the PDE system but are not dependent or independent variables

 

sol := pdsolve(eq, SV, 'time' = t, 'range' = 0 .. T)

(4)

NULL

Download OLG.mw

Hi!

This might sound like a simple question, but I have looked pretty hard in the documentation and can't find a solution.  I want to plot functions in spherical coordinates in such a way that they are actually spherical.  For example, r = 1 should be a sphere.  All I can do is get the "cube" with sides labelled as the traditional variables r, theta, and phi.  That's not really spherical coordinates, it's just relabelled Cartesian.

I didn't make a worksheet for this topic.

Thanks in advance for your help!

Hi,

I have been bothered lately by the number format for axis labels in Maple. My problem existed before, but it apparently didn't bother me before. I have spent many hours trying to find an answer in the program help, in MaplePrimes, and in general online searches. I am not having any luck at all (good luck, that is).

I want to change the format of the axis numbering. Maple seems to default to 2 decimal places in my graph, and I really need more. Oddly, when I export the graph to PDF, I get another decimal place (even though I didn't explicitly ask for one). 

How do I change the axis-label format? Any idea what I might get when I export the graph?

Thanks for your help,

Jno.

 

How can I change the order of variables in a polynomial as I want? For example, I want to assign a polynomial G of 3 variables a,b,c. Then I want to compute G(a,b,c) (exchange the variable a to b, exchange variable b to a)?

Hello everybody

I would like to check, with Spacetime Tensors computation , if  a transfomation is a Lorentz transformation , i.e that leavs Minkosky metric invariant 

For esample a boost  or axis rotation transformation

Some could help me ? ( Maple 2016)

Thank's a lot

I've probably asked about this long time ago but I do not remember now. But it is still a problem any way in 2022.2

Compare these two results

code is

 

restart;

alias(seq(c[k] = _C||k, k = 0..10));
c[1]*h(x);
Int(c[1]*h(x),x);


restart;
c[1]*h(x);
Int(c[1]*h(x),x);

I tried with typesetting level as extended and standard and same result.

Is this a know issue? It is not a big deal as it only affects display but it will be nice to find why it happens when using alias.

 

This a more a math question than  a maple programming question. But interesting.

I have a point P=[x,y] on a line y= 2+3x. The point maps to Pn=[f(x, y), g(x, y)]. That represents a conic.

I want to find the equation of the conic. I did it by calculating 5 points and that works fine but only because I know I'm looking for a conic. 

Can the problem by solved without having to get the five points?
I copied and pasted the equations for the lines because they were generated by commands in a pagkage I have.

restart

NULL

NULL

P := [X, Y]

[X, Y]

``

NULL

Pn := [(5*X+12*Y)*(-384+48*X+55*Y)/(225*X^2+225*Y^2-1800*X-602*Y), (2*(12*X-5*Y))*(-384+48*X+55*Y)/(225*X^2+225*Y^2-1800*X-602*Y)]

[(5*X+12*Y)*(-384+48*X+55*Y)/(225*X^2+225*Y^2-1800*X-602*Y), 2*(12*X-5*Y)*(-384+48*X+55*Y)/(225*X^2+225*Y^2-1800*X-602*Y)]

NULL

``

Y := 2+3*Xn

2+3*X

``

for i to 5 do P || i := eval(Pn, X = i) end do

[181139/51416, -19775/25708]

NULL

l12 := 153621*x*(1/68840)+169429*y*(1/27536)-15067/17210

(153621/68840)*x+(169429/27536)*y-15067/17210

NULL

l34 := -5733*x*(1/473062)+258973*y*(1/946124)+244205/946124

-(5733/473062)*x+(258973/946124)*y+244205/946124

c1 := l12*l34

((153621/68840)*x+(169429/27536)*y-15067/17210)*(-(5733/473062)*x+(258973/946124)*y+244205/946124)

NULL

l13 := 5499*x*(1/2360)+6539*y*(1/944)-793/472

(5499/2360)*x+(6539/944)*y-793/472

l24 := 596115*x*(1/6899489)+7228091*y*(1/6899489)+195364/363131

(596115/6899489)*x+(7228091/6899489)*y+195364/363131

plots:-implicitplot([l12, l34, l13, l24])

c2 := l13*l24

((5499/2360)*x+(6539/944)*y-793/472)*((596115/6899489)*x+(7228091/6899489)*y+195364/363131)

c := simplify(c2*lambda+c1)

(655607277/3256558808)*(x+(2515/846)*y-305/423)*(x+(556007/45855)*y+285532/45855)*lambda-(880709193/32565588080)*(x-(19921/882)*y-18785/882)*(x+(65165/23634)*y-4636/11817)

lambda := solve(eval(c, [x = P5[1], y = P5[2]]), lambda)

-1/4

simplify(c)

-(5039454771/65131176160)*x^2+(1/130262352320)*(-29130506847*y+40315638168)*x-(423368829/3256558808)*y^2+(111619143207/130262352320)*y

plt1 := plot(Y, X = -10 .. 10)

NULL

NULL

plt2 := plots:-implicitplot([c])

plots:-display(plt1, plt2, colour = ["Red", "Green"])

NULL

for i in [-7, 13/3, 42*(1/7)] do x := eval(Pn[1], X = i); y := eval(Pn[2], X = i); simplify(c) end do

0

NULL

Download Q_23-03-04_how_to_find_conic_from_mapping.mw

Dears,
I have a problem whem try to solve a optimization probolem.
The equations are "complex" (G1 equation), and this error is showed "Error, (in Optimization:-NLPSolve) could not store 0.1749271137e-1*(588.000000000000+72.0000000000000*(-3.03333333+.333333333333333*MM)*(MM-17.80)+72.0000000000000*(.333333333333333*NN-3.5666666666667)*(17.00-1.*NN)+24.50000000*(2.90+4.666666667*tan(1.000000000*arctan(.166666666666667*MM-2.96666666666667)))*(18.00+5.627472876000*sin(-1.570796327+1.000000000*arctan(.166666666666667*MM-2.96666666666667))/sin(-1.745329252+1.000000000*arctan(.166666666666667*MM-2.96666666666667)))*cos(-.5235987756000+1.000000000*arctan(.166666666666667*MM-2.96666666666667))^2*sin(.3490658504000+1.000000000*arctan(.166666666666667*MM-2.9666 ... 756000+1.000000000*arctan(.166666666666667*MM-2.96666666666667))^2)-1. in a floating-point rtable".
Someone can help me?

ATS := proc(NN::float, MM::float) 
L[7]*H[4] + L[4]*H[2] + L[1]*(H[1] - H[2]) + 1/2*(P[X1] - NN)*(H[1] - H[2]) + 1/2*(MM - P[XF])*(H[1] - H[2]); 
end proc;
bounds := 14.90 .. 16.90, 17.90 .. 19.90;
cstr8 := proc(NN::float, MM::float) 
G1 - FS; 
end proc;

NLPSolve(ATS, {cstr8}, bounds, initialpoint = [15.90, 18.90], assume = nonnegative)

Hi MaplePrimes, 

I am interested in obtaining some gravitational field equations from an action using the FunDiff command. I have been able to write what I think is a pretty short and quick worksheet(with an arbitrary metric) and I am easily able to obtain the Einstein Field Equations. However, when I introduce some new more complicated terms into the action and apply the Simplify command maple does not appear to be able to evaluate and I end up halting the computation. When I specify a metric Maple, for example Schwarzschild, Maple will easily be able to Simplify my expression but it will use metric components during the process. Where what I am interested in is just the Tensor expression with respective indices. 

I was wondering if anyone had any thoughts on how I could resolve this. 

I have attached the worksheet that I am working with. I look forward to your thoughts/comments.

Thank you.  

ActionFieldEquations.mw

If we use, for example, pointplot3d with an mx3 matrix we get a 3d plot. I can click on the plot and choose the lighting. But how do we do that with code?

Maple continuously shows 'Evaluating' and there is no output. How to fix it?

restart

with(LinearAlgebra)

assume(x::real); assume(t::real); assume(`&alpha;__1`::real); assume(`&alpha;__2`::real); assume(nu::real)

A2s := Matrix([[H__11*exp(I*v__11)/(`&lambda;__1`-conjugate(`&lambda;__1`))+H__13*exp(I*v__21)/(`&lambda;__1`-conjugate(`&lambda;__2`))+1, H__12*exp(-I*v__11)/(`&lambda;__1`-conjugate(`&lambda;__1`))+H__14*exp(-I*v__21)/(`&lambda;__1`-conjugate(`&lambda;__2`)), H__11*exp(I*v__12)/(`&lambda;__2`-conjugate(`&lambda;__1`))+H__13*exp(I*v__22)/(`&lambda;__2`-conjugate(`&lambda;__2`)), H__12*exp(-I*v__12)/(`&lambda;__2`-conjugate(`&lambda;__1`))+H__14*exp(-I*v__22)/(`&lambda;__2`-conjugate(`&lambda;__2`))], [H__12*exp(I*v__11)/(`&lambda;__1`-conjugate(`&lambda;__1`))+H__14*exp(I*v__21)/(`&lambda;__1`-conjugate(`&lambda;__2`)), 1+H__11*exp(-I*v__11)/(`&lambda;__1`-conjugate(`&lambda;__1`))+H__13*exp(-I*v__21)/(`&lambda;__1`-conjugate(`&lambda;__2`)), H__12*exp(I*v__12)/(`&lambda;__2`-conjugate(`&lambda;__1`))+H__14*exp(I*v__22)/(`&lambda;__2`-conjugate(`&lambda;__2`)), H__11*exp(-I*v__12)/(`&lambda;__2`-conjugate(`&lambda;__1`))+H__13*exp(-I*v__22)/(`&lambda;__2`-conjugate(`&lambda;__2`))], [H__13*exp(I*v__11)/(`&lambda;__1`-conjugate(`&lambda;__1`))+H__33*exp(I*v__21)/(`&lambda;__1`-conjugate(`&lambda;__2`)), H__14*exp(-I*v__11)/(`&lambda;__1`-conjugate(`&lambda;__1`))+H__34*exp(-I*v__21)/(`&lambda;__1`-conjugate(`&lambda;__2`)), 1+H__13*exp(I*v__12)/(`&lambda;__2`-conjugate(`&lambda;__1`))+H__33*exp(I*v__22)/(`&lambda;__2`-conjugate(`&lambda;__2`)), H__14*exp(-I*v__12)/(`&lambda;__2`-conjugate(`&lambda;__1`))+H__34*exp(-I*v__22)/(`&lambda;__2`-conjugate(`&lambda;__2`))], [H__14*exp(I*v__11)/(`&lambda;__1`-conjugate(`&lambda;__1`))+H__34*exp(I*v__21)/(`&lambda;__1`-conjugate(`&lambda;__2`)), H__13*exp(-I*v__11)/(`&lambda;__1`-conjugate(`&lambda;__1`))+H__33*exp(-I*v__21)/(`&lambda;__1`-conjugate(`&lambda;__2`)), H__14*exp(I*v__12)/(`&lambda;__2`-conjugate(`&lambda;__1`))+H__34*exp(I*v__22)/(`&lambda;__2`-conjugate(`&lambda;__2`)), H__13*exp(-I*v__12)/(`&lambda;__2`-conjugate(`&lambda;__1`))+H__33*exp(-I*v__22)/(`&lambda;__2`-conjugate(`&lambda;__2`))+1]])

Matrix(%id = 36893490803012390908)

(1)

vvalue := {v__11 = (conjugate(`&lambda;__1`)-`#msub(mi("&lambda;",fontstyle = "normal"),mn("1"))`)*x+(4*`&alpha;__1`*(conjugate(`&lambda;__1`)^3-`&lambda;__1`^3)+2*`&alpha;__2`*(conjugate(`&lambda;__1`)^2-`&lambda;__1`^2)-8*nu*(conjugate(`&lambda;__1`)^4-`&lambda;__1`^4))*t, v__12 = (conjugate(`&lambda;__1`)-`#msub(mi("&lambda;",fontstyle = "normal"),mn("2"))`)*x+(4*`&alpha;__1`*(conjugate(`&lambda;__1`)^3-`&lambda;__2`^3)+2*`&alpha;__2`*(conjugate(`&lambda;__1`)^2-`&lambda;__2`^2)-8*nu*(conjugate(`&lambda;__1`)^4-`&lambda;__2`^4))*t, v__21 = (conjugate(`&lambda;__2`)-`#msub(mi("&lambda;",fontstyle = "normal"),mn("1"))`)*x+(4*`&alpha;__1`*(conjugate(`&lambda;__2`)^3-`&lambda;__1`^3)+2*`&alpha;__2`*(conjugate(`&lambda;__2`)^2-`&lambda;__1`^2)-8*nu*(conjugate(`&lambda;__2`)^4-`&lambda;__1`^4))*t, v__22 = (conjugate(`&lambda;__2`)-`#msub(mi("&lambda;",fontstyle = "normal"),mn("2"))`)*x+(4*`&alpha;__1`*(conjugate(`&lambda;__2`)^3-`&lambda;__2`^3)+2*`&alpha;__2`*(conjugate(`&lambda;__2`)^2-`&lambda;__2`^2)-8*nu*(conjugate(`&lambda;__2`)^4-`&lambda;__2`^4))*t}

{v__11 = (conjugate(lambda__1)-`#msub(mi("&lambda;",fontstyle = "normal"),mn("1"))`)*x+(4*alpha__1*(conjugate(lambda__1)^3-lambda__1^3)+2*alpha__2*(conjugate(lambda__1)^2-lambda__1^2)-8*nu*(conjugate(lambda__1)^4-lambda__1^4))*t, v__12 = (conjugate(lambda__1)-`#msub(mi("&lambda;",fontstyle = "normal"),mn("2"))`)*x+(4*alpha__1*(conjugate(lambda__1)^3-lambda__2^3)+2*alpha__2*(conjugate(lambda__1)^2-lambda__2^2)-8*nu*(conjugate(lambda__1)^4-lambda__2^4))*t, v__21 = (conjugate(lambda__2)-`#msub(mi("&lambda;",fontstyle = "normal"),mn("1"))`)*x+(4*alpha__1*(conjugate(lambda__2)^3-lambda__1^3)+2*alpha__2*(conjugate(lambda__2)^2-lambda__1^2)-8*nu*(conjugate(lambda__2)^4-lambda__1^4))*t, v__22 = (conjugate(lambda__2)-`#msub(mi("&lambda;",fontstyle = "normal"),mn("2"))`)*x+(4*alpha__1*(conjugate(lambda__2)^3-lambda__2^3)+2*alpha__2*(conjugate(lambda__2)^2-lambda__2^2)-8*nu*(conjugate(lambda__2)^4-lambda__2^4))*t}

(2)

NULL

A2s2 := Determinant(A2s); dets22 := simplify(A2s2, size); length(%)

8949

(3)

dets22f := simplify(subs(vvalue, dets22))

NULL

Download sol1det.mw

Hello. I work with vector fields and 1-forms with the package DifferentialGeometry. I need to copy the output in a latex file, but when I use copy paste what I get is the internal representation of the 1-forms, for example, something like

_DG([[\"form\", M, 1], [[[1], x2/x4], [[2], -1]]])

But what I need is something like:

x2/x4 dx1-(`*`(dx2))

which is what I see at the screen. I have tried lot of commands but I don't get what I want.

Here is the basic code:

restart;

with(DifferentialGeometry);

with(JetCalculus);

DGsetup([x1, x2, x3], M);

w:=evalDG(x2/x4 dx1-dx2)

I'm using Maple 2022.  I'm using fsolve to solve for values of 3 variables and I've created a function that looks like 

solution := (TtT, FtT) -> fsolve({eq1, eq2, eq3},{Y,P,PY},{Y=0..100,P=0..100,PY=0..100})

this works fine, giving answers like

solution(1, 0.5);
    {P = 0.1813175442, PY = 0.1593412279, Y = 0.4393982627}

I'd like to plot Y vs TtT at a fixed FtT of 0.5 so I defined a second function

YFtpt5 := TtT -> solution(TtT, 0.5)[3]

this also works fine, giving

YFtpt5(10);
                       Y = 0.02320766980

so I try to plot it with a range variable like this

with plots:

plot(YFtpt5,0.01..10)

but this gives the error 

plot(YFtpt5, 0.01 .. 10);
Warning, unable to evaluate the function to numeric values in the region; see the plotting command's help page to ensure the calling sequence is correct

It draws axis but no plot.  I've evaluated the function at 0.01,10, and a number of points in between and everything I've tried gives a numeric answer.  Is it because the answer is "Y=0.43"  or something else.  

Help, have no idea what to do.

Obtain a finite topological space from a dynamical system specified as a system of ODEs, by writing Maple code for following steps (use Maple packages DynamicSytems and GraphTheory, preferablly):

  1. Visualize the phase space of the system by plotting solution curves for different initial conditions.

  2. Consider a finite region of the phase space.

  3. Define a finite grid of points in the region.

  4. Define a topology on the grid points based on their connectivity.

  5. Give some useful information regarding the dynamical system in terms of topological properties.

First 115 116 117 118 119 120 121 Last Page 117 of 2308