Maple Questions and Posts

These are Posts and Questions associated with the product, Maple

Noticed an issue with Vector and excel.  Not even really excel but I found it through that.  

If I select a row in excel and do a copy paste into Maple it sometimes appears as if it's a list.  ie it shows up as [1,2,3,4]  other times it shows up as [ 1 2 3 4 ] signifying an array (for this example I've saved as the data under the variable a).  Running whattype(a) on the data shows they're both arrays.  Of course it's probably wise to instead load data through Excel into Maple by using the ExcelTools and Import option, however I didn't think there was no reason to use the copy paste option.  It does, to some extent, or maybe, well, it shows a limitation.

In the first instance when it shows up as a list, I thought it might be simple enough just to add other numbers in the list ie/ just tack on ,5,6,7,8 after the 4.  But after pressing enter we get the error

Error, invalid sequence

I don't understand why I couldn't just add to the copied data but maybe it's the formatting of the data that was pasted into maple? 

With the original copied data, I can use with(plots):  listplot(a) no problem however, we want to add data.  ArrayTools will let us Append data to the vector

with(plots):
with(ArrayTools):
Append(a,5,6,7,8)

listplot(a) # will throw another error

                  Error, (in plots:-pointplot) points cannot be converted to floating-point values (this doesn't show in Maple 2019 but does come up in Maple 18)

For Maple 2019 it with responds with a returned array [ 1 2 3 4 5,6,7,8]

Running listplot on that Appended Array.  Maple only recognizes the next 1 added value.

So this means appending values using ArrayTools and Append only allows us to append one value at a time?  Is that a bug?  Are there better ways to append values to vectors?  The only solution for that is to convert to a list and use op to append more values.  But perhaps Maple should have understood the copied values from Excel should have been a list or listlist of values?

 

 

 

Hompotopy perturbation method

restart; with(LinearAlgebra);
PDEtools[declare](f(x), prime = x);
PDEtools[declare](g(x), prime = x);
N := 3;
F := sum(p^i*f[i](x), i = 0 .. N);
G := sum(p^i*g[i](x), i = 0 .. N);
FEq := (1-p)*(diff(F, x$3))+p*(diff(F, x$3)-(2*(diff(F, x$1))*(diff(F, x$1))-(5/2*F)*(diff(F, x$2))+M*(diff(F, x$1))) . A);
GEq := (1-p)*(diff(G, x$2))+p*(diff(G, x$2)+(5/2*(1/(1+R)) . Pr)*F*(diff(G, x$1)))*K(L);

M := 1;
A := (((1-W)^2.5*(1-W))*`ρf`+W*`ρt`)/`ρf`;
Pr := 6.2;
K := ((1-W)*`ρf`*Cf+W*`ρt`*Cs)/`ρf`;
L := .5;
`ρf` := 998.3;
`ρt` := 3970;
W := .2;
R := 1.0;
Cs := 765;
Cf := 4182;
coeff(FEq, p, 0);
coeff(GEq, p, 0);
for i from 0 to N do Fequ[i] := coeff(FEq, p, i) = 0 end do;
for i from 0 to N do Gequ[i] := coeff(GEq, p, i) = 0 end do;
Fcond[1][0] := f[0](0) = 0, (D(f[0]))(0) = 1, (D(f[0]))(5) = 0; for j to N do Fcond[1][j] := f[j](0) = 0, (D(f[j]))(0) = 0, (D(f[j]))(5) = 0 end do;
Gcond[0] := g[0](0) = 1, g[0](5) = 0; for j to N do Gcond[j] := g[j](0) = 0, g[j](5) = 0 end do;

for i from 0 to N do dsolve({Fequ[i], Fcond[1][i]}, f[i](x)); f[i](x) := rhs(%) end do;
for i from 0 to N do dsolve({Gcond[i], Gequ[i]}, g[i](x)); g[i](x) := rhs(%) end do;
Fa := simplify(sum(f[n](x), n = 0 .. N)); dFa := diff(Fa, x); subs(x = 2.4, dFa);
Ga := simplify(sum(g[n](x), n = 0 .. N)); dGa := diff(Ga, x); subs(x = 2.4, dGa);
plot(Ga, x = 0 .. 5);
plot(dFa, x = 0 .. 5);

ND sove solution 

Eq1 := diff(F(x), x$3)-(2*(diff(F(x), x$1))*(diff(F(x), x$1))-(5/2*F(x))*(diff(F(x), x$2))+M*(diff(F(x), x$1))) . A = 0;
Eq2 := (diff(G(x), x$2)+(5/2*(1/(1+R)))*Pr*F(x)*(diff(G(x), x$1)))*K(L) = 0;
M := 1;
Pr := 6.2;
A := (((1-W)^2.5*(1-W))*`ρf`+W*`ρt`)/`ρf`;
K := ((1-W)*`ρf`*Cf+W*`ρt`*Cs)/`ρf`;
L := 1;
`ρf` := 998.3;
`ρt` := 3970;
W := .2;
R := 2.0;
Cs := 765;
Cf := 4182;

Cd1 := F(0) = 0, (D(F))(0) = 1, (D(F))(5) = 0;
dsys := {Cd1, Eq1};
dsol := dsolve(dsys, numeric, output = operator);
dsol(.1);
plots[odeplot](dsol, [x, diff(F(x), x$1)], 0 .. 5, color = green);
Cd2 := G(0) = 1, G(5) = 0;
dsys := {Cd1, Cd2, Eq1, Eq2};
dsol := dsolve(dsys, numeric, output = operator);
plots[odeplot](dsol, [x, G(x)], 0 .. 5, color = green)

 

I find some book teach motion planning in topology 

but do it need to formulate the equations for the environments such as a map with obstacle in 2d or 3D?  the environment is quite complex, how can these equations be formulated?

 

how do i Import part or all  PDF files into maple 

I believe this was easier in older versions of maple or worked partially.

How I can pdsolve these equations in toroidal coordinates?

Initial conditions are arbitrary.

Please see attached pdf .

Thanks

Where.pdf

Weston1958

Can old maple version saved .m files in window be readable in maple 2015 Linux version?

Hello (again)

I thought I won't need help with that type of question but I came across an example that says otherwise.  Here it is

vars:=[x,y,z];

model7 := [x*(-RootOf(64*_Z^3+80*_Z^2+1104*_Z+561)-5/4)+y*alpha[1, 2]-33/(32*RootOf(64*_Z^3+80*_Z^2+1104*_Z+561)), x*z*alpha[2, 6]+y*RootOf(64*_Z^3+80*_Z^2+1104*_Z+561), x^2*(17*RootOf(64*_Z^3+80*_Z^2+1104*_Z+561)+17)/(alpha[1, 2]*alpha[2, 6])-17*x*y/alpha[2, 6]+2*z*x-z-(163/32+RootOf(64*_Z^3+80*_Z^2+1104*_Z+561)^2+5*RootOf(64*_Z^3+80*_Z^2+1104*_Z+561)*(1/4))/(alpha[1, 2]*alpha[2, 6])]

then I issued the command 

map(w->coeffs(w,vars),model7);

to get 

 

[-33/(32*RootOf(64*_Z^3+80*_Z^2+1104*_Z+561)), -RootOf(64*_Z^3+80*_Z^2+1104*_Z+561)-5/4, alpha[1, 2], RootOf(64*_Z^3+80*_Z^2+1104*_Z+561), alpha[2, 6], -(163/32+RootOf(64*_Z^3+80*_Z^2+1104*_Z+561)^2+5*RootOf(64*_Z^3+80*_Z^2+1104*_Z+561)*(1/4))/(alpha[1, 2]*alpha[2, 6]), -1, (17*RootOf(64*_Z^3+80*_Z^2+1104*_Z+561)+17)/(alpha[1, 2]*alpha[2, 6]), -17/alpha[2, 6], 2]

clearly the order does not follow model7's.  

I have also tried

[seq(coeffs(expand(model7[i]), indets(model7[i], suffixed({vars[]}))),i=1..nops(model7))];

Is there a solution to it?

Many thanks (again)

 

Ed

 

 

How to learn Maple Programming effectively, whether Python will help?

My objective is to write a procedure that will read data from xml at different mentioned condition, read ICBO value at different condition of VGS i.e ICBO value at VGS=5V

BJT_ICBO := proc(parsedXML, VGS at condition )
 

 

end proc;

can some one help me to write procedure 

kindly send me OHAM source code in Maple for PDEs. I need it.

Hi, can someone explain me why CodeGeneration in C throws the error : Error, (in Print) improper op or subscript selector ? Interestingly, CodeGeneration in Python or Matlab works. Source code is attached. Thanks in advance!

membrane_energy.mw
 

 

Membrane Energy

 

restart; with(VectorCalculus); with(LinearAlgebra); with(CodeGeneration)

Define variables

 

Vectors for vertices of current position

v1 := Vector(3, symbol = v1_i) = Vector[column]([[v1_i[1]], [v1_i[2]], [v1_i[3]]], ["x", "y", "z"]) 

v2 := Vector(3, symbol = v2_i) = Vector[column]([[v2_i[1]], [v2_i[2]], [v2_i[3]]], ["x", "y", "z"])NULL

v3 := Vector(3, symbol = v3_i) = Vector[column]([[v3_i[1]], [v3_i[2]], [v3_i[3]]], ["x", "y", "z"])NULL

n := `&x`(v2-v1, v3-v1)

v4 := v1+n/norm(n, 2)^.5

Vector for vertices of next position

v1n := Vector(3, symbol = v1n_i) = Vector[column]([[v1n_i[1]], [v1n_i[2]], [v1n_i[3]]], ["x", "y", "z"])NULL

v2n := Vector(3, symbol = v2n_i) = Vector[column]([[v2n_i[1]], [v2n_i[2]], [v2n_i[3]]], ["x", "y", "z"])NULL

v3n := Vector(3, symbol = v3n_i) = Vector[column]([[v3n_i[1]], [v3n_i[2]], [v3n_i[3]]], ["x", "y", "z"])NULL

nn := `&x`(v2n-v1n, v3n-v1n)

v4n := v1n+nn/norm(nn, 2)^.5``

``

 

Define Transformation

 

V := LinearAlgebra:-Transpose(Matrix([v2-v1, v3-v1, v4-v1]))

Dimension(V) = 3, 3 

Vn := LinearAlgebra:-Transpose(Matrix([v2n-v1n, v3n-v1n, v4n-v1n]))

Dimension(Vn) = 3, 3NULL

Note we have Vn = T*V and if the current triangle is not degenerate, then T = Vn/V. As we can pre-compute 1/V we define a new matrix for it:

Vinv := Matrix(3, 3, symbol = Vinv_ij) =

Matrix(%id = 18446746713267339006)

(1.2.1)

T := MatrixMatrixMultiply(Vn, Vinv)

Dimension(T) = 3, 3``

``

``

Define Energy

 

E := Trace(MatrixMatrixMultiply(T, LinearAlgebra:-Transpose(T)))``

``

``

Gradient and Hessian

 

gradE := Gradient(E, [v1n[1], v1n[2], v1n[3], v2n[1], v2n[2], v2n[3], v3n[1], v3n[2], v3n[3]])

Dimension(gradE) = 9NULL

CodeGeneration[C](gradE, defaulttype = numeric, optimize = tryhard, functionprecision = double, precision = double, deducetypes = false, resultname = 'gradE')t1 = v2n_i[0] - v1n_i[0];
t2 = v2n_i[1] - v1n_i[1];
t3 = v2n_i[2] - v1n_i[2];
t4 = t1 * Vinv_ij[0][0] + t2 * Vinv_ij[1][0] + t3 * Vinv_ij[2][0];
t5 = t1 * Vinv_ij[0][1] + t2 * Vinv_ij[1][1] + t3 * Vinv_ij[2][1];
t6 = t1 * Vinv_ij[0][2] + t2 * Vinv_ij[1][2] + t3 * Vinv_ij[2][2];
t7 = v3n_i[0] - v1n_i[0];
t8 = v3n_i[1] - v1n_i[1];
t9 = v3n_i[2] - v1n_i[2];
t10 = t7 * Vinv_ij[0][0] + t8 * Vinv_ij[1][0] + t9 * Vinv_ij[2][0];
t11 = t7 * Vinv_ij[0][1] + t8 * Vinv_ij[1][1] + t9 * Vinv_ij[2][1];
t12 = t7 * Vinv_ij[0][2] + t8 * Vinv_ij[1][2] + t9 * Vinv_ij[2][2];
t13 = t2 * t9 - t3 * t8;
t14 = fabs(t13);
t15 = t1 * t9 - t3 * t7;
t16 = fabs(t15);
t17 = t1 * t8 - t2 * t7;
t18 = fabs(t17);
t19 = pow(t14, 0.2e1) + pow(t16, 0.2e1) + pow(t18, 0.2e1);
t20 = pow(t19, -0.5e1 / 0.4e1);
t19 = t19 * t20;
t21 = Vinv_ij[0][0] * t13;
t22 = Vinv_ij[1][0] * t15;
t23 = Vinv_ij[2][0] * t17;
t24 = (t23 + t21 - t22) * t19;
t25 = -v2n_i[2] + v3n_i[2];
t26 = fabs(t15) / t15;
t27 = -v2n_i[1] + v3n_i[1];
t28 = fabs(t17) / t17;
t21 = t23 + t21 - t22;
t22 = (t16 * t25 * t26 + t18 * t27 * t28) * t20;
t23 = 0.1e1 / 0.2e1;
t29 = Vinv_ij[0][1] * t13;
t30 = Vinv_ij[1][1] * t15;
t31 = Vinv_ij[2][1] * t17;
t32 = (t31 + t29 - t30) * t19;
t29 = t31 + t29 - t30;
t30 = Vinv_ij[0][2] * t13;
t15 = Vinv_ij[1][2] * t15;
t17 = Vinv_ij[2][2] * t17;
t31 = (t17 + t30 - t15) * t19;
t15 = t17 + t30 - t15;
t17 = t6 + t12;
t30 = t5 + t11;
t33 = t4 + t10;
t13 = fabs(t13) / t13;
t34 = -v2n_i[0] + v3n_i[0];
t35 = (t14 * t25 * t13 - t18 * t34 * t28) * t20;
t35 = t17 * Vinv_ij[1][2] - t24 * (t23 * t35 * t21 - t19 * (t25 * Vinv_ij[0][0] - t34 * Vinv_ij[2][0])) + t30 * Vinv_ij[1][1] - t31 * (t23 * t35 * t15 - t19 * (t25 * Vinv_ij[0][2] - t34 * Vinv_ij[2][2])) - t32 * (t23 * t35 * t29 - t19 * (t25 * Vinv_ij[0][1] - t34 * Vinv_ij[2][1])) + t33 * Vinv_ij[1][0];
t36 = (t14 * t27 * t13 + t16 * t34 * t26) * t20;
t34 = Vinv_ij[2][2] * t17 - t24 * (-t23 * t36 * t21 + t19 * (t27 * Vinv_ij[0][0] - t34 * Vinv_ij[1][0])) + t30 * Vinv_ij[2][1] - t31 * (-t23 * t36 * t15 + t19 * (t27 * Vinv_ij[0][2] - t34 * Vinv_ij[1][2])) - t32 * (-t23 * t36 * t29 + t19 * (t27 * Vinv_ij[0][1] - t34 * Vinv_ij[1][1])) + t33 * Vinv_ij[2][0];
t36 = (t16 * t9 * t26 + t18 * t8 * t28) * t20;
t36 = t24 * (-t23 * t36 * t21 - t19 * (-t8 * Vinv_ij[2][0] + t9 * Vinv_ij[1][0])) + t31 * (-t23 * t36 * t15 - t19 * (-t8 * Vinv_ij[2][2] + t9 * Vinv_ij[1][2])) + t32 * (-t23 * t36 * t29 - t19 * (-t8 * Vinv_ij[2][1] + t9 * Vinv_ij[1][1])) + t4 * Vinv_ij[0][0] + t5 * Vinv_ij[0][1] + t6 * Vinv_ij[0][2];
t37 = (t14 * t9 * t13 - t18 * t7 * t28) * t20;
t9 = t24 * (-t23 * t37 * t21 + t19 * (-t7 * Vinv_ij[2][0] + t9 * Vinv_ij[0][0])) + t31 * (-t15 * t23 * t37 + t19 * (-t7 * Vinv_ij[2][2] + t9 * Vinv_ij[0][2])) + t32 * (-t23 * t29 * t37 + t19 * (-t7 * Vinv_ij[2][1] + t9 * Vinv_ij[0][1])) + t4 * Vinv_ij[1][0] + t5 * Vinv_ij[1][1] + t6 * Vinv_ij[1][2];
t37 = (t14 * t8 * t13 + t16 * t7 * t26) * t20;
t4 = t24 * (t23 * t37 * t21 - t19 * (-t7 * Vinv_ij[1][0] + t8 * Vinv_ij[0][0])) + t31 * (t15 * t23 * t37 - t19 * (-t7 * Vinv_ij[1][2] + t8 * Vinv_ij[0][2])) + t32 * (t23 * t29 * t37 - t19 * (-t7 * Vinv_ij[1][1] + t8 * Vinv_ij[0][1])) + t4 * Vinv_ij[2][0] + t5 * Vinv_ij[2][1] + t6 * Vinv_ij[2][2];
t5 = (t16 * t3 * t26 + t18 * t2 * t28) * t20;
t5 = t10 * Vinv_ij[0][0] + t11 * Vinv_ij[0][1] + t12 * Vinv_ij[0][2] + t24 * (t21 * t23 * t5 + t19 * (-t2 * Vinv_ij[2][0] + t3 * Vinv_ij[1][0])) + t31 * (t15 * t23 * t5 + t19 * (-t2 * Vinv_ij[2][2] + t3 * Vinv_ij[1][2])) + t32 * (t23 * t29 * t5 + t19 * (-t2 * Vinv_ij[2][1] + t3 * Vinv_ij[1][1]));
t6 = (-t18 * t1 * t28 + t14 * t3 * t13) * t20;
t3 = t10 * Vinv_ij[1][0] + t11 * Vinv_ij[1][1] + t12 * Vinv_ij[1][2] + t24 * (t21 * t23 * t6 - t19 * (-t1 * Vinv_ij[2][0] + t3 * Vinv_ij[0][0])) + t31 * (t15 * t23 * t6 - t19 * (-t1 * Vinv_ij[2][2] + t3 * Vinv_ij[0][2])) + t32 * (t23 * t29 * t6 - t19 * (-t1 * Vinv_ij[2][1] + t3 * Vinv_ij[0][1]));
t6 = (t16 * t1 * t26 + t14 * t2 * t13) * t20;
t1 = t10 * Vinv_ij[2][0] + t11 * Vinv_ij[2][1] + t12 * Vinv_ij[2][2] + t24 * (-t21 * t23 * t6 + t19 * (-t1 * Vinv_ij[1][0] + t2 * Vinv_ij[0][0])) + t31 * (-t15 * t23 * t6 + t19 * (-t1 * Vinv_ij[1][2] + t2 * Vinv_ij[0][2])) + t32 * (-t23 * t29 * t6 + t19 * (-t1 * Vinv_ij[1][1] + t2 * Vinv_ij[0][1]));
t2 = 0.2e1;
gradE[0] = -t2 * (-t24 * (t23 * t22 * t21 + t19 * (t25 * Vinv_ij[1][0] - t27 * Vinv_ij[2][0])) + t33 * Vinv_ij[0][0] + t30 * Vinv_ij[0][1] + t17 * Vinv_ij[0][2] - t32 * (t23 * t22 * t29 + t19 * (t25 * Vinv_ij[1][1] - t27 * Vinv_ij[2][1])) - t31 * (t23 * t22 * t15 + t19 * (t25 * Vinv_ij[1][2] - t27 * Vinv_ij[2][2])));
gradE[1] = -t2 * t35;
gradE[2] = -t2 * t34;
gradE[3] = t2 * t36;
gradE[4] = t2 * t9;
gradE[5] = t2 * t4;
gradE[6] = t2 * t5;
gradE[7] = t2 * t3;
gradE[8] = t2 * t1;

``

``

``

``

``

Hessian

 

``

hessE := Hessian(E, [v1n[1], v1n[2], v1n[3], v2n[1], v2n[2], v2n[3], v3n[1], v3n[2], v3n[3]])

Dimension(hessE)

9, 9

(1.5.1)

 

CodeGeneration[C](hessE, optimize = tryhard, deducetypes = false, resultname = 'hessE')

Error, (in Print) improper op or subscript selector

 

``

````

``

``

``

``


 

Download membrane_energy.mw

 

 

 

Cannot find integration proplem_in_maple.mw

restart

with(LinearAlgebra)

with(orthopoly)

``

with(student)

Digits := 32

32

(1)

interface(rtablesize = 100)

10

(2)

a := 0; b := 1; N := 5; h := (b-a)/N; B[0] := 1; B[1] := x; n := 2; B[2] := x^2+2; alpha := 1/2

0

 

1

 

5

 

1/5

 

1

 

x

 

2

 

x^2+2

 

1/2

(3)

NULL

for j from 3 to N do B[j] := expand(x*B[j-1]-B[j-2]) end do

x^3+x

 

x^4-2

 

x^5-3*x-x^3

(4)

for i from 0 to N do x[i] := h*i+a end do

0

 

1/5

 

2/5

 

3/5

 

4/5

 

1

(5)

y := sum(c[s]*B[s], s = 0 .. N)

c[0]+c[1]*x+c[2]*(x^2+2)+c[3]*(x^3+x)+c[4]*(x^4-2)+c[5]*(x^5-3*x-x^3)

(6)

yt := subs(x = t, y)

c[0]+c[1]*t+c[2]*(t^2+2)+c[3]*(t^3+t)+c[4]*(t^4-2)+c[5]*(t^5-3*t-t^3)

(7)

k := expand(int(yt*sin(t)*x, t = 0 .. x))

x*c[0]+22*x*c[4]-c[1]*cos(x)*x^2-c[2]*cos(x)*x^3+2*c[2]*sin(x)*x^2-c[3]*cos(x)*x^4+3*c[3]*sin(x)*x^3+5*c[3]*cos(x)*x^2-c[4]*cos(x)*x^5+4*c[4]*sin(x)*x^4+12*c[4]*cos(x)*x^3-24*c[4]*sin(x)*x^2-c[5]*cos(x)*x^6+5*c[5]*sin(x)*x^5+21*c[5]*cos(x)*x^4-63*c[5]*sin(x)*x^3-123*c[5]*cos(x)*x^2-x*cos(x)*c[0]-22*x*cos(x)*c[4]+x*c[1]*sin(x)-5*x*c[3]*sin(x)+123*x*c[5]*sin(x)

(8)

k4 := k*y

(x*c[0]+22*x*c[4]-c[1]*cos(x)*x^2-c[2]*cos(x)*x^3+2*c[2]*sin(x)*x^2-c[3]*cos(x)*x^4+3*c[3]*sin(x)*x^3+5*c[3]*cos(x)*x^2-c[4]*cos(x)*x^5+4*c[4]*sin(x)*x^4+12*c[4]*cos(x)*x^3-24*c[4]*sin(x)*x^2-c[5]*cos(x)*x^6+5*c[5]*sin(x)*x^5+21*c[5]*cos(x)*x^4-63*c[5]*sin(x)*x^3-123*c[5]*cos(x)*x^2-x*cos(x)*c[0]-22*x*cos(x)*c[4]+x*c[1]*sin(x)-5*x*c[3]*sin(x)+123*x*c[5]*sin(x))*(c[0]+c[1]*x+c[2]*(x^2+2)+c[3]*(x^3+x)+c[4]*(x^4-2)+c[5]*(x^5-3*x-x^3))

(9)

f := (8*x^3*(1/3)-2*x^(1/2))*y/GAMMA(1/2)+(1/1260)*x+k4

((8/3)*x^3-2*x^(1/2))*(c[0]+c[1]*x+c[2]*(x^2+2)+c[3]*(x^3+x)+c[4]*(x^4-2)+c[5]*(x^5-3*x-x^3))/Pi^(1/2)+(1/1260)*x+(x*c[0]+22*x*c[4]-c[1]*cos(x)*x^2-c[2]*cos(x)*x^3+2*c[2]*sin(x)*x^2-c[3]*cos(x)*x^4+3*c[3]*sin(x)*x^3+5*c[3]*cos(x)*x^2-c[4]*cos(x)*x^5+4*c[4]*sin(x)*x^4+12*c[4]*cos(x)*x^3-24*c[4]*sin(x)*x^2-c[5]*cos(x)*x^6+5*c[5]*sin(x)*x^5+21*c[5]*cos(x)*x^4-63*c[5]*sin(x)*x^3-123*c[5]*cos(x)*x^2-x*cos(x)*c[0]-22*x*cos(x)*c[4]+x*c[1]*sin(x)-5*x*c[3]*sin(x)+123*x*c[5]*sin(x))*(c[0]+c[1]*x+c[2]*(x^2+2)+c[3]*(x^3+x)+c[4]*(x^4-2)+c[5]*(x^5-3*x-x^3))

(10)

"f(x):=((8/3 x^3-2 sqrt(x)) (c[0]+c[1] x+c[2] (x^2+2)+c[3] (x^3+x)+c[4] (x^4-2)+c[5] (x^5-3 x-x^3)))/(sqrt(Pi))+1/1260 x+(x c[0]+22 x c[4]+x c[1] sin(x)-5 x c[3] sin(x)+123 x c[5] sin(x)-x cos(x) c[0]-22 x cos(x) c[4]-c[1] cos(x) x^2-c[2] cos(x) x^3+2 c[2] sin(x) x^2-c[3] cos(x) x^4+3 c[3] sin(x) x^3+5 c[3] cos(x) x^2-c[4] cos(x) x^5+4 c[4] sin(x) x^4+12 c[4] cos(x) x^3-24 c[4] sin(x) x^2-c[5] cos(x) x^6+5 c[5] sin(x) x^5+21 c[5] cos(x) x^4-63 c[5] sin(x) x^3-123 c[5] cos(x) x^2) (c[0]+c[1] x+c[2] (x^2+2)+c[3] (x^3+x)+c[4] (x^4-2)+c[5] (x^5-3 x-x^3))"

proc (x) options operator, arrow; ((8/3)*x^3-2*sqrt(x))*(c[0]+Typesetting:-delayDotProduct(c[1], x, true)+c[2]*(x^2+2)+c[3]*(x^3+x)+c[4]*(x^4-2)+c[5]*(x^5-3*x-x^3))/sqrt(Pi)+Typesetting:-delayDotProduct(1/1260, x, true)+(Typesetting:-delayDotProduct(x, c[0], true)+22*x*c[4]+Typesetting:-delayDotProduct(x, c[1], true)*sin(x)-5*x*c[3]*sin(x)+123*x*c[5]*sin(x)-Typesetting:-delayDotProduct(x, cos(x), true)*c[0]-22*x*cos(x)*c[4]-c[1]*cos(x)*x^2-c[2]*cos(x)*x^3+2*c[2]*sin(x)*x^2-c[3]*cos(x)*x^4+3*c[3]*sin(x)*x^3+5*c[3]*cos(x)*x^2-c[4]*cos(x)*x^5+4*c[4]*sin(x)*x^4+12*c[4]*cos(x)*x^3-24*c[4]*sin(x)*x^2-c[5]*cos(x)*x^6+5*c[5]*sin(x)*x^5+21*c[5]*cos(x)*x^4-63*c[5]*sin(x)*x^3-123*c[5]*cos(x)*x^2)*(c[0]+Typesetting:-delayDotProduct(c[1], x, true)+c[2]*(x^2+2)+c[3]*(x^3+x)+c[4]*(x^4-2)+c[5]*(x^5-3*x-x^3)) end proc

(11)

NULL

"H(f,alpha,x):=Int((x-s)^(alpha-1)*f(s)/GAMMA(alpha), s = 0 .. x)"

proc (f, alpha, x) options operator, arrow; Int((x-s)^(alpha-1)*f(s)/GAMMA(alpha), s = 0 .. x) end proc

(12)

`assuming`([value(%)], [x > 0])

proc (f, alpha, x) options operator, arrow; Int((x-s)^(alpha-1)*f(s)/GAMMA(alpha), s = 0 .. x) end proc

(13)

H(f, alpha, x)

Int((((8/3)*s^3-2*s^(1/2))*(c[0]+c[1]*s+c[2]*(s^2+2)+c[3]*(s^3+s)+c[4]*(s^4-2)+c[5]*(s^5-3*s-s^3))/Pi^(1/2)+(1/1260)*s+(s*c[0]+22*s*c[4]+c[1]*s*sin(s)-5*s*c[3]*sin(s)+123*s*c[5]*sin(s)-s*cos(s)*c[0]-22*s*cos(s)*c[4]-c[1]*cos(s)*s^2-c[2]*cos(s)*s^3+2*c[2]*sin(s)*s^2-c[3]*cos(s)*s^4+3*c[3]*sin(s)*s^3+5*c[3]*cos(s)*s^2-c[4]*cos(s)*s^5+4*c[4]*sin(s)*s^4+12*c[4]*cos(s)*s^3-24*c[4]*sin(s)*s^2-c[5]*cos(s)*s^6+5*c[5]*sin(s)*s^5+21*c[5]*cos(s)*s^4-63*c[5]*sin(s)*s^3-123*c[5]*cos(s)*s^2)*(c[0]+c[1]*s+c[2]*(s^2+2)+c[3]*(s^3+s)+c[4]*(s^4-2)+c[5]*(s^5-3*s-s^3)))/((x-s)^(1/2)*Pi^(1/2)), s = 0 .. x)

(14)

z := value(%)

int((((8/3)*s^3-2*s^(1/2))*(c[0]+c[1]*s+c[2]*(s^2+2)+c[3]*(s^3+s)+c[4]*(s^4-2)+c[5]*(s^5-3*s-s^3))/Pi^(1/2)+(1/1260)*s+(s*c[0]+22*s*c[4]+c[1]*s*sin(s)-5*s*c[3]*sin(s)+123*s*c[5]*sin(s)-s*cos(s)*c[0]-22*s*cos(s)*c[4]-c[1]*cos(s)*s^2-c[2]*cos(s)*s^3+2*c[2]*sin(s)*s^2-c[3]*cos(s)*s^4+3*c[3]*sin(s)*s^3+5*c[3]*cos(s)*s^2-c[4]*cos(s)*s^5+4*c[4]*sin(s)*s^4+12*c[4]*cos(s)*s^3-24*c[4]*sin(s)*s^2-c[5]*cos(s)*s^6+5*c[5]*sin(s)*s^5+21*c[5]*cos(s)*s^4-63*c[5]*sin(s)*s^3-123*c[5]*cos(s)*s^2)*(c[0]+c[1]*s+c[2]*(s^2+2)+c[3]*(s^3+s)+c[4]*(s^4-2)+c[5]*(s^5-3*s-s^3)))/((x-s)^(1/2)*Pi^(1/2)), s = 0 .. x)

(15)

`assuming`([value(%)], [x > 0])

int((((8/3)*s^3-2*s^(1/2))*(c[0]+c[1]*s+c[2]*(s^2+2)+c[3]*(s^3+s)+c[4]*(s^4-2)+c[5]*(s^5-3*s-s^3))/Pi^(1/2)+(1/1260)*s+(s*c[0]+22*s*c[4]+c[1]*s*sin(s)-5*s*c[3]*sin(s)+123*s*c[5]*sin(s)-s*cos(s)*c[0]-22*s*cos(s)*c[4]-c[1]*cos(s)*s^2-c[2]*cos(s)*s^3+2*c[2]*sin(s)*s^2-c[3]*cos(s)*s^4+3*c[3]*sin(s)*s^3+5*c[3]*cos(s)*s^2-c[4]*cos(s)*s^5+4*c[4]*sin(s)*s^4+12*c[4]*cos(s)*s^3-24*c[4]*sin(s)*s^2-c[5]*cos(s)*s^6+5*c[5]*sin(s)*s^5+21*c[5]*cos(s)*s^4-63*c[5]*sin(s)*s^3-123*c[5]*cos(s)*s^2)*(c[0]+c[1]*s+c[2]*(s^2+2)+c[3]*(s^3+s)+c[4]*(s^4-2)+c[5]*(s^5-3*s-s^3)))/((x-s)^(1/2)*Pi^(1/2)), s = 0 .. x)

(16)

``


Download proplem_in_maple.mw
 

Could anyone give an example how to use the hint option in polynomial solutions in PDEtools in maple?

The dsolve numeric events syntax requires the use of If(a,b,c) rather than the usual if then else syntax. Also, the possible action parts of an event are truly mysterious as are discrete variables. Has anyone plaed around with this much? For example, can the If's be nested? I know I can test that in a toy situation but there are many such questions that arise and I don't want to reinvent the wheel.

Can Maple auto switch input language according to mode of editing?

I would like to:
In 2D-math mode- auto set (after pressing F5 or clicking "math" button) english language
In Text-mode- auto set (after pressing F5 or clicking "text" button) my native language

How Can I set up this option?

First 66 67 68 69 70 71 72 Last Page 68 of 2097