Enhancements to Symbolic Capabilities in Maple 10
Maple 10 includes enhancements to its symbolic capabilities in the following areas.
Differential Equations
Differentiation
Integration
Simplification
Mathematical functions: new Heun functions, SphericalY function, n-dimensional Dirac function, other improvements
Network of Conversions for Mathematical Functions
The series command
Miscellaneous enhancements: Equate, ImportMatrix and ImportVector, iratrecon, solve
See also enhancements in the packages for symbolic Polynomial System Solving and Algebraic Geometry and Summation and Difference Equations
Differential Equations (DEs)
The simplify Command
Mathematical Functions
Network of Conversion Routines for Mathematical Functions
The series Command
Miscellaneous
The differential equation solving capabilities of the dsolve and pdsolve commands for computing exact solutions have been enhanced with new algorithms, representing the most important developments in this area in the last four Maple releases; for a description see Updates to Differential Equation Solvers.
The Traveling Wave Solutions command of the PDEtools package has been significantly enhanced and nine new commands, some based on original algorithms, are now available in the DEtools package. For details, see the Updates to Differential Equation Packages help page.
Exact Differentiation of Abstract (Symbolic) Order
The diff command can now compute derivatives of abstract order for varied expressions, returning results in closed form or as finite sums. Similarly, a new fracdiff command computes derivatives of non-integral order.
Examples
For arbitrary values of n, a positive integer,
Diff(sin(x), x$n);
Diff⁡sin⁡x,x$n
value((1));
sin⁡x+n⁢π2
The new routines can compute the symbolic order derivative of most mathematical functions and of some of their compositions with other functions or algebraic expressions. To compute the nth integral, that is, the inverse operation, differentiate "−n times".
diff((2), x$(-n));
sin⁡x
A more involved example:
Diff(exp(x^2), x$n);
Diff⁡exp⁡x2,x$n
value((4));
x−n⁢2n⁢MeijerG⁡0,12,,0,12+n2,n2,−x2
The Leibniz rule for the derivative of a product:
Diff(f(x)*g(x), x$n);
Diff⁡f⁡x⁢g⁡x,x$n
value((6));
∑_k1=0n⁡n_k1⁢ⅆ_k1ⅆx_k1f⁡x⁢ⅆn−_k1ⅆxn−_k1g⁡x
The fractional derivative of the exponential function and the general formula (see fracdiff) for an arbitrary f⁡x
fracdiff(exp(x), x, 1/2);
erf⁡x⁢ⅇx
fracdiff(f(x), x, 1/2);
int⁡diff⁡f⁡τ,τx−τ⁢π,τ=0..x
Differentiation Knowledge for Special Functions
An number of new formulas, some of them original, were added for the differentiation of special functions with respect to parameters.
Differentiating Bessel functions with respect to the first parameter (assuming the first parameter is a positive integer):
Diff(BesselJ(n,z),n) = diff(BesselJ(n,z),n) assuming n::posint;
Diff⁡BesselJ⁡n,z,n=12⁢π⁢BesselY⁡n,z+12⁢factorial⁡n⁢Sum⁡12⁢z_k1−n⁢BesselJ⁡_k1,zfactorial⁡_k1⁢n−_k1,_k1=0..n−1
Maple can perform the derivative above for any of the four Bessel functions and also when n is a negative integer.
Diff(BesselK(n,z),n) = diff(BesselK(n,z),n) assuming n::negint;
Diff⁡BesselK⁡n,z,n=−12⁢factorial⁡−n⁢Sum⁡12⁢z_k1+n⁢BesselK⁡_k1,zfactorial⁡_k1⁢−n−_k1,_k1=0..−n−1
Similar formulas are implemented for the Struve functions, with results expressed in terms of the MeijerG and Bessel functions.
Diff(StruveH(n,z),n) = diff(StruveH(n,z),n) assuming n::negint;
Diff⁡StruveH⁡n,z,n=−12⁢Sum⁡binomial⁡−n,_k1⁢factorial⁡−n−_k1−1⁢−12⁢z_k1+n⁢StruveH⁡−_k1,z,_k1=0..−n−1+12⁢−1−n⁢π⁢BesselJ⁡−n,z+12⁢zn−1⁢−1−n⁢π⁢MeijerG⁡1,1,14,34,1,1,12−n,34,12,14,14⁢z2
For Chebyshev functions, the formulas are valid for arbitrary values of the first parameter.
Diff(ChebyshevT(a,z),a) = diff(ChebyshevT(a,z),a);
Diff⁡ChebyshevT⁡a,z,a=−arccos⁡z⁢−z2+1⁢ChebyshevU⁡a−1,z
Numerical Differentiation
A new fdiff command, to compute derivatives numerically, was added to the library (see the Numerics Updates in Maple 10 help page). This command is used to compute the value of derivatives when the exact differentiation rule is not known and is tightly integrated with the symbolic differentiation commands.
eval( Diff(exp(x),x), x=1) = fdiff(exp(x), x=1);
eval⁡Diff⁡exp⁡x,x,x=1=2.718281828
The differentiation rule of LegendreP⁡a,x with respect to the first parameter is not known in general.
eval(diff(LegendreP(a,1/3), a), a=1/2+I);
eval⁡diff⁡LegendreP⁡a,13,a,a=12+I
The numerical value of this derivate is computed using fdiff.
evalf( (15) );
−1.131424808−0.4882991380⁢I
fdiff(LegendreP(a,1/3), a=1/2+I);
In Maple 10, fdiff is also used to numerically evaluate symbolic derivatives evaluated at a point, constructed using the D operator.
D[1](LegendreP)(1/2+I,1/3);
D1⁡LegendreP⁡12+I,13
evalf((18));
The int command has been updated regarding Heun, Wrightomega and the multidimensional Dirac function, all new in Maple 10.
Int(2*Wrightomega((z-1)/(z+1))/(z+1)^2/(1+Wrightomega((z-1)/(z+1))),z);
Int⁡2⁢Wrightomega⁡z−1z+1z+12⁢1+Wrightomega⁡z−1z+1,z
value((20));
Wrightomega⁡z−1z+1
Int(2*HeunTPrime(a,b,c,(z-1)/(z+1))/(z+1)^2,z);
Int⁡2⁢HeunTPrime⁡a,b,c,z−1z+1z+12,z
value((22));
HeunT⁡a,b,c,z−1z+1
A 4-Dimensional Dirac and integral:
Int(Int(Int(Int(Dirac([x, y, z, t])*f(x,y,z,t), x = -infinity .. infinity), y = -infinity .. infinity), z = -infinity .. infinity), t = -infinity .. infinity);
Int⁡Int⁡Int⁡Int⁡Dirac⁡t,x,y,z⁢f⁡x,y,z,t,x=−∞..∞,y=−∞..∞,z=−∞..∞,t=−∞..∞
value((24));
f⁡0,0,0,0
Various families of integrals previously computed in terms of infinite sums are now computed in terms of MeijerG or other special functions.
Example
Int(1/2*x^(r-1)*Pi*BesselY(0,2*x)*BesselY(0,2*a^(1/2)*x),x = 0 .. infinity);
Int⁡12⁢xr−1⁢π⁢BesselY⁡0,2⁢x⁢BesselY⁡0,2⁢a⁢x,x=0..∞
value((26)) assuming a>0;
π⁢MeijerG⁡−r2+1,−r2+1,−12,32−r2,0,0,−12,32−r2,a4
In Maple 10, the diff command can also compute integrals of abstract order for some expressions, returning results in closed form or as finite sums. To compute the nth integral, differentiate "−n times". For more details, see the Exact Differentiation of Abstract (Symbolic) Order help page.
Size of Expressions
The routines for simplifying the size of a mathematical expression were rewritten, resulting in more powerful, flexible, and efficient simplification. For details, see the simplify,size help page.
Consider the following large symbolic expression, with rational subexpressions and exponential and trigonometric functions, which appeared as part of the solution of a differential equation problem.
eq:=-r*h*m*K*(K*exp(K*t/(A + Ab))*cos((h*C/(A + Ab) + h*Ab/(A + Ab))*t)/(A + Ab)/(K^2/(A + Ab)^2 + (h*C/(A + Ab) + h*Ab/(A + Ab))^2)-(-h*C/(A + Ab)-h*Ab/(A + Ab))*exp(K*t/(A + Ab))*sin((h*C/(A + Ab) + h*Ab/(A + Ab))*t)/(K^2/(A + Ab)^2 + (h*C/(A + Ab) + h*Ab/(A + Ab))^2)) + r*h*m*K*(K*exp(K*t/(A + Ab))*cos((-h*C/(A + Ab) + 2*h*A/(A + Ab) + h*Ab/(A + Ab))*t)/(A + Ab)/(K^2/(A + Ab)^2 + (-h*C/(A + Ab) + 2*h*A/(A + Ab) + h*Ab/(A + Ab))^2)-(h*C/(A + Ab)-2*h*A/(A + Ab)-h*Ab/(A + Ab))*exp(K*t/(A + Ab))*sin((-h*C/(A + Ab) + 2*h*A/(A + Ab) + h*Ab/(A + Ab))*t)/(K^2/(A + Ab)^2 + (-h*C/(A + Ab) + 2*h*A/(A + Ab) + h*Ab/(A + Ab))^2))-Ab*m*h^2*r*((h*C/(A + Ab)-2*h*A/(A + Ab)-h*Ab/(A + Ab))*exp(K*t/(A + Ab))*cos((-h*C/(A + Ab) + 2*h*A/(A + Ab) + h*Ab/(A + Ab))*t)/(K^2/(A + Ab)^2 + (-h*C/(A + Ab) + 2*h*A/(A + Ab) + h*Ab/(A + Ab))^2) + K*exp(K*t/(A + Ab))*sin((-h*C/(A + Ab) + 2*h*A/(A + Ab) + h*Ab/(A + Ab))*t)/(A + Ab)/(K^2/(A + Ab)^2 + (-h*C/(A + Ab) + 2*h*A/(A + Ab) + h*Ab/(A + Ab))^2)) + Ab*m*h^2*r*((-h*C/(A + Ab)-h*Ab/(A + Ab))*exp(K*t/(A + Ab))*cos((h*C/(A + Ab) + h*Ab/(A + Ab))*t)/(K^2/(A + Ab)^2 + (h*C/(A + Ab) + h*Ab/(A + Ab))^2) + K*exp(K*t/(A + Ab))*sin((h*C/(A + Ab) + h*Ab/(A + Ab))*t)/(A + Ab)/(K^2/(A + Ab)^2 + (h*C/(A + Ab) + h*Ab/(A + Ab))^2)):
Try different methods of simplifying its size, such as converting to horner form, factoring, directly simplifying, or simplifying and combining. Measure the length of the resulting expression and compare with the expression obtained by simplification by size.
`starting length` = length(eq), `converting to horner`=length(convert(eq,horner)), factoring=length(factor(eq)), simplifying=length(simplify(eq)), `simplifying and combining` = length(combine(simplify(eq)));
starting length=2173,converting to horner=1688,factoring=2992,simplifying=616,simplifying and combining=2992
`using simplify/size`=length(simplify(eq,size));
using simplify/size=616
By performing simple manipulations (simplify,size), it is possible to rewrite the expression in a more compact form than by applying other specific mathematical simplification algorithms.
New Simplification Routines
Simplifying expressions involving the new Wrightomega function:
Wrightomega(ln(2)+ln(ln(2)));
Wrightomega⁡ln⁡2+ln⁡ln⁡2
simplify((30));
ln⁡2
Improved Simplification of RootOf
For expressions involving RootOf, the simplification is more efficient and sophisticated, finding simplifications in cases where previously none was found, and terminating more quickly when no simplification is possible.
Zeta(0,n,x+a)-Zeta(0,RootOf(-Zeta(0,n,a)+Zeta(0,_Z,A)),x+A);
ζ⁡0,n,x+a−ζ⁡0,RootOf⁡−ζ⁡0,n,a+ζ⁡0,_Z,A,x+A
simplify( (32) );
ζ⁡0,n,x+a−ζ⁡0,n,x+A
a*RootOf(x^2-2*x+1,index = 1)^2+RootOf(x^2-2*x+1,index = 1)*RootOf(x^2-2*x+1,index = 1)+c;
a+1+c
simplify( (34) );
Taking advantage of the presence of multiple roots:
1/(alpha-RootOf(_Z^3-11*_Z^2+35*_Z-25));
1α−RootOf⁡_Z3−11⁢_Z2+35⁢_Z−25
simplify( (36) );
Less processing time when no simplification is available:
simplify(RootOf(-RootOf(_Z^4+_Z+1,index= 4)+_Z^3,index = 1));
RootOf⁡−RootOf⁡_Z4+_Z+1,index=4+_Z3,index=1
Improved Simplification of Radicals and Powers
More transformations are considered:
2^(-sqrt(2)/4-1)*(sqrt(2)+2)^(sqrt(2)/4)*(2-sqrt(2))^(sqrt(2)/4)/Pi;
2−24−1⁢2+224⁢2−224π
simplify((39));
12⁢π
Improved Simplification of Bessel, Kummer and Whittaker Special Functions
More identities are taken into account.
(-alpha+2*y(x)^2*alpha+2)*WhittakerM(1/4*(alpha-2)/alpha,-1/4,y(x)^2)+(-1+alpha)*WhittakerM(1/4*(-2+5*alpha)/alpha,-1/4,y(x)^2)-WhittakerM(-1/4*(3*alpha+2)/alpha,-1/4,y(x)^2);
−α+2⁢y⁡x2⁢α+2⁢WhittakerM⁡α−24⁢α,−14,y⁡x2+−1+α⁢WhittakerM⁡−2+5⁢α4⁢α,−14,y⁡x2−WhittakerM⁡−3⁢α+24⁢α,−14,y⁡x2
simplify((41));
0
BesselJ(1+1/v,x)-2/v*BesselJ(1/v,x)/x+BesselJ(-1+1/v,x);
BesselJ⁡1+1v,x−2⁢BesselJ⁡1v,xv⁢x+BesselJ⁡−1+1v,x
simplify((43));
These improvements have also had a positive effect in other parts of the Maple library. For example, this Abel type differential equation and implicit exact solution are now testable due to improvements in the simplification of Bessel functions.
ode := diff(y(x),x) = 2*delta^3*y(x)*d/(-y(x)*d*delta^3+x*(x*d*delta^3-4));
ode≔ⅆⅆxy⁡x=2⁢δ3⁢y⁡x⁢d−y⁡x⁢d⁢δ3+x⁢x⁢d⁢δ3−4
sol := _C1 = -(x*BesselI(2/d/delta^3,y(x)^(1/2))+y(x)^(1/2)*BesselI((2+d*delta^3)/d/delta^3,y(x)^(1/2)))/(x*BesselK(2/d/delta^3,y(x)^(1/2))-y(x)^(1/2)*BesselK((2+d*delta^3)/d/delta^3,y(x)^(1/2)));
sol≔_C1=−x⁢BesselI⁡2d⁢δ3,y⁡x+y⁡x⁢BesselI⁡d⁢δ3+2d⁢δ3,y⁡xx⁢BesselK⁡2d⁢δ3,y⁡x−y⁡x⁢BesselK⁡d⁢δ3+2d⁢δ3,y⁡x
odetest(sol, ode);
Combining Sums and Integrals
Products of Integrals and Sums can now be combined using combine.
Int(f(a,x),x)*Sum(g(a,x),_k2 = 0 .. n-_k1);
Int⁡f⁡a,x,x⁢Sum⁡g⁡a,x,_k2=0..n−_k1
combine((48));
Sum⁡Int⁡f⁡a,x,x⁢g⁡a,x,_k2=0..n−_k1
Maple 10 includes important developments in the mathematical function's area:
a pioneering implementation in computer algebra systems of the five Heun functions
the Spherical Harmonics function
the Wrightomega function
the Dirac function has been extended to be multidimensional, as frequently presented in the context of physics problems
additional knowledge regarding identities for mathematical functions
more mathematical functions are sensitive to assumptions
The Heun functions
The five Heun functions are solutions to the five canonical forms of the Heun family of second order linear ordinary differential equations. The General Heun Equation
diff(y(x),x,x) + ((alpha+beta+1-delta-gamma)/(x-a)+delta/(x-1)+gamma/x)*diff(y(x),x) + ((alpha*beta*a-q)/(x-a)/a/(a-1)+(-alpha*beta+q)/(x-1)/(a-1)-q/x/a)*y(x) = 0;
ⅆ2ⅆx2y⁡x+α+β+1−δ−γx−a+δx−1+γx⁢ⅆⅆxy⁡x+α⁢β⁢a−qx−a⁢a⁢a−1+−α⁢β+qx−1⁢a−1−qx⁢a⁢y⁡x=0
has four regular singular points. The other Heun equations are obtained from the general equation using confluence processes.
None of the solutions to these five equations can be expressed in terms of other mathematical functions.
Due to the rich structure of their singularities, Heun equations appear in the representation of a large number of problems, from finance to general relativity and quantum physics. The generality of these functions is also illustrated by the fact that most other mathematical functions are particular cases of Heun functions, including the Spheroidal wave function, the Mathieu, Lame and hypergeometric pFq functions, and with them all of Legendre, Kummer, Bessel etc. functions admitting hypergeometric representation in the 2F1, 1F1, and 0F1 classes.
The Heun functions are defined as the solutions of the Heun equations for given initial conditions. The equations and conditions can be seen using the FunctionAdvisor.
FunctionAdvisor(definition, HeunG);
HeunG⁡a,q,α,β,γ,δ,z=DESol⁡ⅆ2ⅆz2_Y⁡z−α+β+1⁢z2+−δ−γ⁢a−α+δ−β−1⁢z+γ⁢a⁢ⅆⅆz_Y⁡zz⁢z−1⁢−z+a−α⁢β⁢z−q⁢_Y⁡zz⁢z−1⁢−z+a,_Y⁡z,_Y⁡0=1,D⁡_Y⁡0=qγ⁢a
The 2F1 and 1F1 hypergeometric functions are special cases of HeunG (the Heun General) and HeunC (the Heun Confluent) functions.
FunctionAdvisor(specialize, HeunG, hypergeom);
HeunG⁡a,q,α,β,γ,δ,z=hypergeom⁡α,β,α−δ+1+β,z,a=0∧q=0,HeunG⁡a,q,α,β,γ,δ,z=hypergeom⁡α,β,γ,z,a=1∧q=α⁢β∨q=a⁢α⁢β∧δ=α+β−γ+1,HeunG⁡a,q,α,β,γ,δ,z=hypergeom⁡α−β2+γ2+−2⁢α−2⁢β⁢γ+4⁢q2+γ2−α2+β2,α−β2+γ2+−2⁢α−2⁢β⁢γ+4⁢q2+γ2+α2−β2,γ,z−1+z−α−β2+γ2+−2⁢α−2⁢β⁢γ+4⁢q2−γ2+α2+β2⁢ⅇI2⁢π⁢α−β2+γ2+−2⁢α−2⁢β⁢γ+4⁢q+γ−α−β,a=1∧0≤ℑ⁡z,HeunG⁡a,q,α,β,γ,δ,z=hypergeom⁡β2,α2,γ,−z⁢z−2,a=2∧q=α⁢β∧δ=α+β−2⁢γ+1∧−1<ℜ⁡z∧ℜ⁡z<1,HeunG⁡a,q,α,β,γ,δ,z=hypergeom⁡β3,α3,12,z⁢z−324,a=4∧q=α⁢β∧γ=12∧δ=2⁢α3+2⁢β3∧−1<ℜ⁡z∧ℜ⁡z<1∧−π<ℑ⁡z∧ℑ⁡z<π
FunctionAdvisor(specialize, HeunC, hypergeom);
HeunC⁡α,β,γ,δ,η,z=hypergeom⁡β+1⁢α+2⁢δ2⁢α,β+1,−z⁢α1−z,α≠0∧β+1≠0∧γ=1∧η=12−δ∧z≠1∨α≠0∧β+1=0∧δ=0∧γ=1∧η=12∧z≠1,HeunC⁡α,β,γ,δ,η,z=11−zβ2+γ2+12+β2+γ2−4⁢η+12⁢hypergeom⁡β2−γ2+12+β2+γ2−4⁢η+12,β2+γ2+12+β2+γ2−4⁢η+12,β+1,z−1+z,α=0∧β+1≠0∧δ=0∧z≠1
Some identities and special values:
FunctionAdvisor(identities,HeunC);
HeunC⁡α,β,γ,δ,η,z=1−z−γ⁢HeunC⁡α,β,−γ,δ,η,z,β::¬integer∧z<1,HeunC⁡α,β,γ,δ,η,z=ⅇ−z⁢α⁢HeunC⁡−α,β,γ,δ,η,z,β::¬integer∧z<1
FunctionAdvisor(special_values,HeunG);
HeunG⁡a,q,α,−1,γ,δ,z=HeunG⁡a,q,−1,α,γ,δ,z,HeunG⁡a,q,α,0,γ,δ,z=HeunG⁡a,q,0,α,γ,δ,z,HeunG⁡a,q,α,1,γ,δ,z=HeunG⁡a,q,1,α,γ,δ,z,HeunG⁡a,q,α,β,γ,δ,0=1,HeunG⁡a,q,∞,β,γ,δ,z=HeunG⁡a,q,β,∞,γ,δ,z,HeunG⁡a,q,−∞,β,γ,δ,z=HeunG⁡a,q,β,−∞,γ,δ,z
Series and asymptotic series expansions for the HeunT (Triconfluent Heun) and HeunD (Doubleconfluent Heun) functions:
FunctionAdvisor(series, HeunT);
series⁡HeunT⁡α,β,γ,z,z,4=1−12⁢α⁢z2+−γ⁢α6−β6+12⁢z3+O⁡z4
For more details, see the Heun help page.
The Spherical Harmonics
The spherical harmonics SphericalY(lambda,mu,theta,phi) are the angular part of the solution to Laplace's equation in spherical coordinates (r,theta,phi). These functions are frequently used to represent solutions in problems with spherical symmetry, and are particularly relevant in Quantum Mechanics, where they are eigenfunctions of observable operators associated with angular momentum. The SphericalY harmonics are related to Legendre functions as follows.
FunctionAdvisor(definition, SphericalY);
SphericalY⁡λ,μ,θ,φ=−1μ⁢2⁢λ+1π⁢λ−μ!⁢ⅇI⁢φ⁢μ⁢LegendreP⁡λ,μ,cos⁡θ2⁢λ+μ!,¬λ+μ::negint∧¬λ−μ::negint
The differentiation rule with respect to the two angular variables is known in closed form.
Diff(SphericalY(lambda,mu,theta,phi),theta): (57) = value((57));
SphericalY⁡λ,μ,θ,φ=−1μ⁢2⁢λ+1π⁢λ−μ!⁢ⅇI⁢φ⁢μ⁢LegendreP⁡λ,μ,cos⁡θ2⁢λ+μ!,¬λ+μ::negint∧¬λ−μ::negint=SphericalY⁡λ,μ,θ,φ=−1μ⁢2⁢λ+1π⁢λ−μ!⁢ⅇI⁢φ⁢μ⁢LegendreP⁡λ,μ,cos⁡θ2⁢λ+μ!,¬λ+μ::negint∧¬λ−μ::negint
Diff(SphericalY(lambda,mu,theta,phi),phi): (58) = value((58));
SphericalY⁡λ,μ,θ,φ=−1μ⁢2⁢λ+1π⁢λ−μ!⁢ⅇI⁢φ⁢μ⁢LegendreP⁡λ,μ,cos⁡θ2⁢λ+μ!,¬λ+μ::negint∧¬λ−μ::negint=SphericalY⁡λ,μ,θ,φ=−1μ⁢2⁢λ+1π⁢λ−μ!⁢ⅇI⁢φ⁢μ⁢LegendreP⁡λ,μ,cos⁡θ2⁢λ+μ!,¬λ+μ::negint∧¬λ−μ::negint=SphericalY⁡λ,μ,θ,φ=−1μ⁢2⁢λ+1π⁢λ−μ!⁢ⅇI⁢φ⁢μ⁢LegendreP⁡λ,μ,cos⁡θ2⁢λ+μ!,¬λ+μ::negint∧¬λ−μ::negint=SphericalY⁡λ,μ,θ,φ=−1μ⁢2⁢λ+1π⁢λ−μ!⁢ⅇI⁢φ⁢μ⁢LegendreP⁡λ,μ,cos⁡θ2⁢λ+μ!,¬λ+μ::negint∧¬λ−μ::negint
The series expansion with respect to phi:
series( SphericalY(lambda,mu,theta,phi), phi, 3 ); # up to order 3
SphericalY⁡λ,μ,θ,0+I⁢μ⁢SphericalY⁡λ,μ,θ,0⁢φ−12⁢μ2⁢SphericalY⁡λ,μ,θ,0⁢φ2+O⁡φ3
The Wrightomega Function
The Wrightomega function is a single-valued (but discontinuous on two rays in the complex plane) variant of the LambertW function. It is defined as follows.
FunctionAdvisor(definition, Wrightomega);
Wrightomega⁡z=LambertW⁡ℑ⁡z−π2⁢π,ⅇz,with no restrictions on ⁡z
Because the Wrightomega function is single-valued, its branching behavior is simpler than that of the LambertW function and the relationship LambertW⁡k,z=Wrightomega⁡ln⁡z+2⁢I⁢π⁢k can be used as an analytic continuation of LambertW in the (otherwise discrete) branch index.
The Wrightomega function sometimes has another advantage over the LambertW function. For large x,
Wrightomega(x) = asympt( Wrightomega(x), x, 3 );
Wrightomega⁡x=x−ln⁡x+ln⁡xx+−ln⁡x+ln⁡x22x2
and when Wrightomega appears in applications, the equivalent formulation in terms of LambertW, namely Wrightomega⁡x=LambertW⁡ⅇx can overflow on computation of ⅇx, before being "undone" by LambertW. In other words, for some applications, such as the fringing fields of a capacitor, numerical evaluation of Wrightomega is easier.
The n-dimensional Dirac Function
The Maple 10 Dirac command allows for a compact representation, usual in formulations in Physics, of an n-dimensional Dirac delta function, defined in terms of the product of 1-dimensional Dirac functions.
Dirac([x, y, z, t]) = expand( Dirac([x, y, z, t]) );
Dirac⁡t,x,y,z=Dirac⁡t⁢Dirac⁡x⁢Dirac⁡y⁢Dirac⁡z
Derivatives of the n-dimensional Dirac function are denoted by the two-argument Dirac function as in the 1-dimensional case (see Dirac). The Maple library has been updated accordingly, so it is now possible to integrate, expand, compute integral transforms and other operations using the n-dimensional form.
Int(Int(Int(Int( Dirac([x, y, z, t])*f(x,y,z,t), x=-infinity..infinity), y=-infinity..infinity), z=-infinity..infinity), t=-infinity..infinity);
value((64));
More Identities Known to the System
FunctionAdvisor(identities, HeunG);
HeunG⁡a,q,α,β,γ,δ,z=1−z1−δ⁢HeunG⁡a,q−δ−1⁢γ⁢a,β−δ+1,α−δ+1,γ,2−δ,z,HeunG⁡a,q,α,β,γ,δ,z=1−za−α−β+γ+δ⁢HeunG⁡a,q−γ⁢α+β−γ−δ,−β+γ+δ,−α+γ+δ,γ,δ,z,a≠0,HeunG⁡a,q,α,β,γ,δ,z=1−z1−δ⁢1−za−α−β+γ+δ⁢HeunG⁡a,q−γ⁢δ−1⁢a+α+β−γ−δ,−β+γ+1,−α+γ+1,γ,2−δ,z,a≠0,HeunG⁡a,q,α,β,γ,δ,z=HeunG⁡1a,qa,α,β,γ,α+β−γ−δ+1,za,a≠0,HeunG⁡a,q,α,β,γ,δ,z=1−z−α⁢HeunG⁡aa−1,α⁢γ⁢a−qa−1,α,α−δ+1,γ,α−β+1,zz−1,a≠1∧z≠1,HeunG⁡a,q,α,β,γ,δ,z=1−za−α⁢HeunG⁡1−a,α⁢γ−q,α,−β+γ+δ,γ,δ,1−a⁢zz−a,a≠0∧z≠a,HeunG⁡a,q,α,β,γ,δ,z=1−za−α⁢HeunG⁡11−a,−α⁢γ+qa−1,α,−β+γ+δ,γ,α−β+1,zz−a,a≠0∧a≠1∧z≠a
More Mathematical Functions Sensitive to Assumptions
The Psi function now takes into account assumptions made on the function parameters.
Psi(n,x) assuming n::posint, x=1;
−1n+1⁢n!⁢ζ⁡n+1
Psi(n,x) assuming n=1, x=1/4;
π2+8⁢Catalan
The network of conversions between mathematical functions was introduced in Maple 8. In Maple 9, the number of conversions was almost tripled. In Maple 10, more relations and conversion routines have been added, including conversions for the LambertW function, the Wrightomega function, and the five Heun functions.
New conversions:
convert( Wrightomega(z), LambertW );
LambertW⁡ℑ⁡z−π2⁢π,ⅇz
convert( LambertW(z), Wrightomega );
Wrightomega⁡ln⁡z
The hypergeometric form of SphericalY:
convert( SphericalY(lambda,mu,theta,phi), hypergeom );
−1μ⁢2⁢λ+1π⁢λ−μ!⁢ⅇI⁢φ⁢μ⁢cos⁡θ+1μ2⁢hypergeom⁡−λ,λ+1,1−μ,12−cos⁡θ22⁢λ+μ!⁢cos⁡θ−1μ2⁢Γ⁡1−μ
In the case, frequent in Quantum Mechanics, where lambda is a positive integer and mu lies between -lambda and lambda, the radicals can be combined.
combine((71)) assuming lambda::posint, mu >= -lambda, mu <= lambda;
−1μ⁢cos⁡θ+1μ2⁢cos⁡θ−1−μ2⁢2⁢λ+1⁢λ−μ!π⁢λ+μ!⁢ⅇI⁢φ⁢μ⁢hypergeom⁡−λ,λ+1,1−μ,12−cos⁡θ22⁢Γ⁡1−μ
The HeunG form of SphericalY can be obtained by rewriting the hypergeometric function in terms of HeunG.
convert((72), HeunG);
−1μ⁢cos⁡θ+1μ2⁢cos⁡θ−1−μ2⁢2⁢λ+1⁢λ−μ!π⁢λ+μ!⁢ⅇI⁢φ⁢μ⁢HeunG⁡0,0,−λ,λ+1,0,1+μ,12−cos⁡θ22⁢Γ⁡1−μ
The HeunC form of the 1F1 hypergeometric confluent function:
hypergeom([a],[b],z);
hypergeom⁡a,b,z
convert((74), HeunC);
HeunC⁡1,b−1,1,−b2+a,b2−a+12,−z⁢z+1
For the HeunB form of 1F1, try convert⁡hypergeom⁡a,b,z,HeunB.
New routines are available in the conversion network
JacobiZeta(z,k);
JacobiZeta⁡z,k
convert((76), Sum);
∑_k1=1∞⁡−2⁢π⁢EllipticNome⁡k_k1⁢sin⁡_k1⁢π⁢zEllipticK⁡kEllipticK⁡k⁢EllipticNome⁡k2⁢_k1−1
The new convert,algebraic routine accepts a procedure and returns, when possible, an algebraic expression representing the procedure. This conversion takes advantage of the fact that in Maple all algebraic expressions are appliable, like procedures. The returned algebraic expression, when applied to arguments, will behave the same as the procedure applied to the same arguments.
P := z -> GAMMA(z)*Psi(z) + 1;
P≔z↦Γ⁡z⋅Ψ⁡z+1
convert((78), algebraic);
Γ⁢Ψ+1
(79)(z) = P(z);
Γ⁡z⁢Ψ⁡z+1=Γ⁡z⁢Ψ⁡z+1
The convert,boolean_function and convert,boolean_operator routines now accept a filtering option allowing the user to only apply the conversion to selected boolean operators or functions.
a or b and c;
aorbandc
convert((81), boolean_function, `and`);
aorb∧c
convert((81), boolean_function, `or`);
a∨bandc
Routines for computing series expansions of the new Wrightomega and Heun functions have been added to the library.
series( Wrightomega(z), z, 3);
Wrightomega⁡0+Wrightomega⁡01+Wrightomega⁡0⁢z+12⁢Wrightomega⁡01+Wrightomega⁡03⁢z2+O⁡z3
series( HeunB(alpha,beta,gamma,delta,z), z, 3);
1+12⁢β⁢α+β+δα+1⁢z−18⁢−α2⁢β2−4⁢α⁢β2−2⁢α⁢β⁢δ−4⁢α2+4⁢α⁢γ−3⁢β2−4⁢β⁢δ−δ2−12⁢α+4⁢γ−8α+1⁢α+2⁢z2+O⁡z3
The Equate Command
The new Equate command is used to turn pairs of datasets into a list of equations, matching up the elements of the datasets pairwise. The inputs can be two lists, a list and a Vector, two Matrices, or in fact any two objects of the same structure. For example, a 2x3 Matrix can be paired with a,b,c,d,e,f.
The ImportMatrix and ImportVector Commands
The ImportMatrix and ImportVector commands now have the option of skipping lines at the beginning of source data.
ImportMatrix("myData.dat", source=delimited, delimiter=",", skiplines=2):
Error, (in ImportMatrix) file or directory does not exist: myData.dat
The iratrecon Command
The iratrecon command has been extended to implement maximal quotient rational reconstruction.
The solve Command
The solve command now accepts lists of equations and variables. This removes the need to convert lists to sets for use with solve. Also when the variables are given in the list, solve will return the answer as list of lists of the equations, which left hand sides will be sorted according to initial order of variables' list.
New or Enhanced Symbolic Packages for Polynomial System Solving, Algebraic Geometry, Summation, and Difference Equations
The Groebner package has been enhanced and the PolynomialIdeals and RegularChains packages added.
The QDifferenceEquations and SumTools packages have been enhanced.
For more information, see Enhanced Packages in Maple 10.
See Also
Index of New Maple 10 Features
Download Help Document