Updates to Differential Equation (DE) Solvers in Maple 13
Summary
Exact Solutions
Numerical Solutions
The theme for exact, symbolic Ordinary Differential Equation solving in Maple 13 is the exploration of alternative methods for finding solutions to DE problems that are beyond the scope of standard methods or for which standard methods give overly complicated results. For example, important nonlinear ODE families, including some which do not have point symmetries, can be solved by constructing and then solving related linear ODEs of higher order. Similarly, by exploring symmetries in non-standard ways, the solution for various ODE initial value problems can be expressed in simple form even when the ODE general solution cannot be computed. These abilities are now built in to the standard DE solver (dsolve), and the techniques are also available separately through a variety of new tools.
For Partial Differential Equations, the functionality of most of the symmetry commands of PDEtools has been significantly expanded in many respects and four new commands were added. Among the novelties there is one new command for the fast computation of polynomial solutions to linear and nonlinear PDE systems, and the internal PDEtools Library, with 45 specialized routines for programming purposes, is now available.
For numerical solutions of ODEs, improvements have been made to event handling and to accuracy and error control for ODE and index-1 DAE problems.
Ordinary Differential Equations (ODEs)
The dsolve command can now solve varied problems formerly out of reach, as well as compute remarkably simpler solutions for various ODE families for which former solutions were too complicated.
New solutions for nonlinear ODEs, from 1st to 5th order: linearization by differentiation
In some cases, a nonlinear ODE that cannot be solved using standard methods can still be multiplied by an appropriate factor so that after differentiation (one or two times), the resulting expression contains a linear ODE of higher order as a factor. Solving this linear ODE permits expressing the solution to the original problem explicitly and in rather compact manner.
Examples
PDEtools:-declare(y(x), prime=x);
y⁡x⁢will now be displayed as⁢y
derivatives with respect to⁢x⁢of functions of one variable will now be displayed with '
The following shows a first order ODE nonlinear in y', as an arbitrary function G of two arguments, and its corresponding new solution.
ode[1] := G((2*y(x)-2+diff(y(x),x)*x)*x^3/(3*x^4+2*x^3),-x^3*(-y(x)+1+(x+1)*diff(y(x),x))/(3*x+2)) = 0;
ode1≔G⁡2⁢y−2+y'⁢x⁢x33⁢x4+2⁢x3,−x3⁢−y+1+x+1⁢y'3⁢x+2=0
sol[1] := dsolve(ode[1], implicit);
sol1≔G⁡−−y+c__1x2+1x+1,c__1=0
So, for any form of G in ode[1], the same G in the output above solves the problem. ODE solutions can be verified as usual with odetest.
odetest(sol[1], ode[1]);
0
Here are two nonlinear ODE examples, of third and fourth order, extracted from scientific publications related to applications, and their new solutions computed quickly and in compact manner using linearization by differentiation.
ode[2] := diff(y(x),x,x,x) = 1/8*(-8*x*diff(y(x),x,x)*diff(y(x),x) + 4*x^2*diff(y(x),x,x)^2 + diff(y(x),x)^2 + 12*y(x))/x^2/diff(y(x),x);
ode2≔y'''=−8⁢x⁢y''⁢y'+4⁢x2⁢y''2+y'2+12⁢y8⁢x2⁢y'
dsolve(ode[2]);
y=x2+4⁢x32⁢c__13−4⁢x⁢c__2+c__3⁢x−4⁢c__1⁢c__23−c__3212
ode[3] := diff(y(x),x,x,x,x) = 1/2*(2*diff(y(x),x,x,x)*diff(y(x),x)-diff(y(x),x,x)^2+c^4*y(x)^2)/y(x);
ode3≔y''''=2⁢y'''⁢y'−y''2+c4⁢y22⁢y
dsolve(ode[3]);
New ODE-IVP solutions from the ODE symmetries
For various nonlinear ODE initial value problems (ODE-IVP), a rational solution exists, but the general ODE solution involves elliptic or special functions, making it difficult to compute the simpler form when adjusting the integration constants to match the initial conditions. In Maple 13, dsolve automatically explores the ODE symmetries to compute an ODE-IVP solution in its simpler rational form directly, even if the general solution is entirely out of reach.
ode[4] := diff(y(x), x, x) + 3*(diff(y(x), x))/x - 8*y(x)^3/x^6 = 0;
ode4≔y''+3⁢y'x−8⁢y3x6=0
ic[4] := y(1) = -1/2, D(y)(1) = -1/2;
ic4≔y⁡1=−12,D⁡y⁡1=−12
The general solution of ode[4] involves the inverse of an elliptic integral, represented by the elliptic function JacobiSN.
dsolve(ode[4]);
y=c__2⁢JacobiSN⁡−Ix2+c__1⁢c__2,I
It is not easy to adjust the integration constants C1, C2 so that the preceding solution satisfies the conditions y(1) = -1/2, D(y)(1) = -1/2. However, by exploring the ODE symmetries,
DEtools[symgen](ode[4]);
_ξ=x3,_η=0,_ξ=x2,_η=y
dsolve can compute directly the following simple solution to the whole ODE initial value problem.
sol_ic[4] := dsolve([ode[4], ic[4]]);
sol_ic4≔y=−x2x2+1
You can use odetest to test solutions against the initial conditions.
odetest(sol_ic[4], [ode[4], ic[4]]);
0,0,0
ode[5] := diff(y(x), x,x,x) - diff(y(x), x,x)*y(x) + diff(y(x),x)^2 = 0;
ode5≔y'''−y''⁢y+y'2=0
ic[5] := y(0) = 1, D(y)(0) = 1/6;
ic5≔y⁡0=1,D⁡y⁡0=16
For ode[5] alone dsolve obtains only a reduction of order, which contains an ODE of Abel type for _g(_f) whose solution is not known.
dsolve(ode[5]);
y=ⅇ∫_g⁡_fⅆ_f+c__2where_g_f=6⁢_f−1⁢_g⁡_f3+7⁢_f−1⁢_g⁡_f2_f+_g⁡_f_f,_f=y'y2,_g⁡_f=y2y⁢y''y'−2⁢y',x=∫_g⁡_f_f⁢ⅇ∫_g⁡_fⅆ_f+c__2ⅆ_f+c__1,y=ⅇ∫_g⁡_fⅆ_f+c__2
This result is the best one achievable at present but there is no useful way to adjust it to match the conditions y(0) = 1, D(y)(0) = 1/6. In Maple 13, however, dsolve first detects the symmetries of ode[5] and instead of just failing to compute the general solution, it explores these symmetries, solving the problem as a whole.
sol_ic[5] := dsolve([ode[5], ic[5]]);
sol_ic5≔y=−6x−6
map(odetest, [sol_ic[5]], [ode[5], ic[5]]);
New solutions for linear ODEs with non-rational coefficients
The existing routines in dsolve for this problem were optimized to solve more complicated problems and in simpler form, or using simpler special functions.
Example
ode[6] := diff(y(x),x,x) + tan(x)*diff(y(x),x) + a^2*cos(x)^2*sin(x)^(2*n-2)*y(x) = 0;
ode6≔y''+tan⁡x⁢y'+a2⁢cos⁡x2⁢sin⁡x2⁢n−2⁢y=0
For the ode[6], the solution in Maple 12 involves hypergeometric functions. In Maple 13, the solution is computed in terms of simpler Bessel functions.
dsolve(ode[6]);
y=c__1⁢sin⁡x⁢BesselJ⁡12⁢n,sin⁡xn⁢an+c__2⁢sin⁡x⁢BesselY⁡12⁢n,sin⁡xn⁢an
New solutions for nonlinear ODEs exploring dynamical symmetries
Maple's dsolve started exploring dynamical symmetries in 1997. The related solving approach, however, is algebraically complicated. For Maple 13, corresponding routines were enhanced substantially to handle these kinds of problems, taking advantage of the properties of subfamilies of these symmetries (for example, self-invariant contact symmetries). In this way, new or concretely simpler solutions can now be computed.
ode[7] := diff(y(x), x,x) = diff(y(x), x)+(ln(diff(y(x), x))-x)*diff(y(x), x)^2/(y(x)-diff(y(x), x));
ode7≔y''=y'+ln⁡y'−x⁢y'2y−y'
This ODE admits only one point symmetry, but in addition it has a computable self-invariant contact (dynamical) symmetry that involves y'.
DEtools[symgen](ode[7]);
_ξ=1,_η=y,_ξ=0,_η=−ln⁡_y1+x
Remarkably, the point symmetry (first one in the preceding output) is of no use to integrate the equation; it leads to an intractable first order ODE. The dynamical symmetry, on the other hand, results in the following new implicit solution, involving the Ei (exponential integral) composed with the LambertW function.
dsolve(ode[7], implicit);
Ei1⁡−1−c__1⁢ⅇ−x−LambertW⁡−y⁢ⅇ−x−c__1⁢ⅇ−x−1⁢c__1−yLambertW⁡−y⁢ⅇ−x−c__1⁢ⅇ−x−1−c__2=0
New parametric solutions for nonlinear ODEs
For ODEs of all differential orders, dsolve can now compute parametric solutions directly from their symmetries. This is useful in various cases where the standard solution, of the form y⁡x=..., involves the algebraic inversion of special functions or integrals, while the parametric solution is simpler.
ode[8] := diff(y(x),x,x) = y(x)+_F1(diff(y(x),x)-y(x));
ode8≔y''=y+f__1⁡−y+y'
dsolve(ode[8]);
y=∫RootOf⁡−x−∫` `_Z1−f__1⁡_f+_fⅆ_f+c__1⁢ⅇ−xⅆx+c__2⁢ⅇx
This solution is the best that can be achieved but involves composite integrals where the inner one is algebraically solved with respect to the integration variable using RootOf. These solutions can frequently be re-expressed in parametric form, free of RootOf, which can now be computed directly by dsolve from the ODE symmetries.
dsolve(ode[8], parametric);
y⁡_T=∫ⅇ∫−1f__1⁡_T−_Tⅆ_T−c__2⁢_Tf__1⁡_T−_Tⅆ_T+c__1⁢ⅇ∫1f__1⁡_T−_Tⅆ_T+c__2,x⁡_T=∫1f__1⁡_T−_Tⅆ_T+c__2
DEtools[IVPsol], a new command for specializing general solutions and a related new option in dsolve
The standard process of solving an ODE-IVP consists of first computing a solution that is more general, which depends on arbitrary constants, and then adjusting these constants to match the initial or boundary conditions. The initial more general solution, however, can frequently be written in different ways, which can either facilitate or make more complicated the posterior adjustment of the solution.
To take advantage of this situation, a new command, IVPsol, has been added to the DEtools package, with the purpose of adjusting an ODE solution to given initial or boundary conditions. Also, related new flexibility has been added to dsolve: it now accepts a given solution to be used directly as a departure point to match the initial/boundary conditions.
ode[9] := x*diff(y(x),x,x)+4*y(x)^2 = 0;
ode9≔x⁢y''+4⁢y2=0
A general solution for ode[9] is not known. So, in principle, it would not be possible to solve an initial value problem involving it, such as in the following example with these initial conditions.
ic[9] := y(1) = -1/2, D(y)(1) = 1/2;
ic9≔y⁡1=−12,D⁡y⁡1=12
But suppose you know a particular solution for ode[9] that you might have computed by any other means, for instance:
sol[9] := y(x) = _C1/(2*x);
sol9≔y=c__12⁢x
You can now pass this solution directly to dsolve so that it uses it to solve the problem instead of trying and failing to compute one itself.
dsolve([ode[9], ic[9]], usesolution = sol[9]);
y=−12⁢x
Analogously, you can pass the initial conditions and the solution directly to DEtools[IVPsol].
DEtools[IVPsol]([ic[9]], sol[9]);
DEtools: extended functionality of parametricsol and particularsol
The DEtools commands particularsol and parametricsol can now solve a new range of higher order and nonlinear ODE problems by combining standard methods with alternative ways of using symmetries.
ode[10] := diff(y(x), x,x,x) - diff(y(x), x,x)*y(x) + diff(y(x),x)^2 = 0;
ode10≔y'''−y''⁢y+y'2=0
No general solution is known for ode[10]. A particular solution for it, however, depending on one arbitrary constant, is now computable using the following.
DEtools[particularsol](ode[10]);
y=0,y=6−x+c__1
For ode[8], introduced in a previous paragraph, a parametric solution is now computable using the following.
DEtools[parametricsol](ode[8]);
This functionality also has been added as an option to dsolve; see previous paragraphs.
Partial Differential Equations (PDEs)
A large number of improvements and additions were made to the PDEtools package, setting a new benchmark for the state-of-the-art in symbolic computation and Partial Differential Equations.
The new commands in PDEtools
Four new commands were added to PDEtools: CharacteristicQInvariants, ConsistencyTest, PolynomialSolutions, and SymmetrySolutions. As their names suggest, the new commands can perform fast consistency tests, compute polynomial solutions for PDE systems, transform given solutions into other different solutions exploring the symmetries of the problem, and can compute invariants of differential equation systems using a simpler approach, exploring the CharacteristicQ function of the system's symmetries.
with(PDEtools);
CanonicalCoordinates,ChangeSymmetry,CharacteristicQ,CharacteristicQInvariants,ConservedCurrentTest,ConservedCurrents,ConsistencyTest,D_Dx,DeterminingPDE,Eta_k,Euler,FirstIntegralSolver,FromJet,FunctionFieldSolutions,InfinitesimalGenerator,Infinitesimals,IntegratingFactorTest,IntegratingFactors,InvariantEquation,InvariantSolutions,InvariantTransformation,Invariants,Laplace,Library,PDEplot,PolynomialSolutions,ReducedForm,SimilaritySolutions,SimilarityTransformation,Solve,SymmetryCommutator,SymmetryGauge,SymmetrySolutions,SymmetryTest,SymmetryTransformation,TWSolutions,ToJet,ToMissingDependentVariable,build,casesplit,charstrip,dchange,dcoeffs,declare,diff_table,difforder,dpolyform,dsubs,mapde,separability,splitstrip,splitsys,undeclare
Polynomial solutions for PDE systems can now be computed using the new PolynomialSolutions command.
PDEtools:-declare((f, g)(x,y));
f⁡x,y⁢will now be displayed as⁢f
g⁡x,y⁢will now be displayed as⁢g
sys[1] := diff(f(x,y),x)*diff(g(x,y),x) + diff(f(x,y),y)*diff(g(x,y),y) + g(x,y)*(diff(f(x,y),x,x) + diff(f(x,y),y,y)) = -1;
sys1≔fx⁢gx+fy⁢gy+g⁢fx,x+fy,y=−1
psol[1] := PolynomialSolutions(sys[1]);
psol1≔f=2⁢x2−y2⁢c__3+2⁢x⁢c__2+2⁢c__1⁢c__5−2⁢c__3⁢c__4⁢y−2⁢y2⁢c__5,g=c__5⁢y+c__4,f=−2⁢c__5⁢y2+2⁢c__4⁢x+2⁢c__2⁢y+2⁢x2⁢c__5+2⁢c__3⁢x+2⁢c__1⁢c__6−y22⁢c__6,g=c__6,f=−2⁢y⁢c__3+c__24⁢c__5⁢x⁢2+c__3⁢y2+c__2⁢y+c__1⁢c__5+−2⁢c__3⁢c__4−1⁢xc__5,g=c__5⁢x+2⁢c__5⁢y2+c__4,f=2⁢y⁢c__3+c__24⁢c__5⁢x⁢2+c__3⁢y2+c__2⁢y+c__1⁢c__5+−2⁢c__3⁢c__4−1⁢xc__5,g=c__5⁢x−2⁢c__5⁢y2+c__4,f=−x2⁢c__3+2⁢c__3⁢y2−c__2⁢y−c__1⁢c__63−6⁢y⁢c__3−c__26⁢c__5+c__3⁢c__43−16⁢x⁢c__62+2⁢x2⁢c__3−12⁢c__3⁢y2+c__2⁢y+c__1⁢c__52⁢c__6−2⁢x⁢c__52⁢c__2⁢c__5+c__3⁢c__4+12⁢c__52⁢c__6−c__63,g=c__5⁢y+c__6⁢x+c__4
map(pdetest, [psol[1]], sys[1]);
0,0,0,0,0
New different solutions for PDE systems can now be computed from old known solutions exploring their symmetries; consider, for example, the wave equation in two dimensions:
pde[2] := diff(u(x, t), x,x) - diff(u(x, t), t,t) = 0;
pde2≔ux,x−ut,t=0
Here is a solution separable by product using pdsolve.
sol[2] := pdsolve(pde[2], HINT = `*`, build);
sol2≔u⁡x,t=c__3⁢ⅇ_c1⁢t⁢c__1⁢ⅇ_c1⁢x+c__3⁢ⅇ_c1⁢t⁢c__2ⅇ_c1⁢x+c__4⁢c__1⁢ⅇ_c1⁢xⅇ_c1⁢t+c__4⁢c__2ⅇ_c1⁢t⁢ⅇ_c1⁢x
Using a new feature, symmetries of polynomial type:
S[2] := Infinitesimals(pde[2], typeofsymmetry = polynomial)[-1..-1];
S2≔_ξx⁡x,t,u=2⁢x⁢t,_ξt⁡x,t,u=t2+x2,_ηu⁡x,t,u=0
A new solution is obtained transforming sol[2] and exploring the symmetry S[2].
newsol[2] := SymmetrySolutions(sol[2], S[2]);
newsol2≔u⁡x,t=c__3⁢ⅇ2⁢_c1⁢t2−x2⁢_ε+t1+t2−x2⁢_ε2+2⁢t⁢_ε⁢c__2+c__3⁢c__1⁢ⅇ2⁢_c1⁢t+x⁢1+t−x⁢_ε1+t2−x2⁢_ε2+2⁢t⁢_ε+c__4⁢ⅇ2⁢x⁢_c11+t2−x2⁢_ε2+2⁢t⁢_ε⁢c__1+c__2⁢ⅇ−_c1⁢t+x⁢1+t−x⁢_ε1+t2−x2⁢_ε2+2⁢t⁢_ε
This new solution is verified using pdetest.
pdetest(newsol[2], pde[2]);
Significant functionality added to compute solutions using symmetries
Most of the symmetry commands of PDEtools have had their functionality significantly expanded, providing enough flexibility to get a solution, or one of the necessary form, even for tough problems. New features that stand out are:
The main solver of the symmetry approach, InvariantSolutions has been packed with options to facilitate obtaining solutions of the most varied forms;
All of InvariantSolutions, SimilaritySolutions, and Infinitesimals can now solve problems faster, exploring symmetries of polynomial type or with restricted dependency, making solutions easier to compute;
InvariantSolutions and SimilaritySolutions automatically specialize arbitrary functions entering the infinitesimals of PDE systems, including an option to avoid this specialization when desired;
The key command of the symmetry approach, DeterminingPDE, can now compute the determining system also for integrating factors and conserved currents.
In many cases, a particular solution for a PDE system, which can also be computed faster than a more general solution, is enough to solve the problem. The new features permit searching for these particular solutions in varied manners. Recall, for example, the wave equation in two dimensions introduced in a previous section:
pde[2];
ux,x−ut,t=0
The following specifies that a solution depending only on t would suffice.
InvariantSolutions(pde[2], numberofsolutions = 1, dependency = t);
u⁡x,t=c__1⁢t+c__2
This other input specifies to construct a solution using infinitesimals only depending on one variable, either x or t, which are easy to compute.
InvariantSolutions(pde[2], dependencyofinfinitesimals = {x, t});
u⁡x,t=c__1⁢t+c__2,u⁡x,t=c__1⁢x+c__2
With this input, you specify the use of infinitesimals of polynomial type, linear in the jet variables (almost the simplest ones that can be computed, requiring only inverting a matrix); note the display option to show the corresponding invariants and solution.
InvariantSolutions(pde[2], degreeofinfinitesimals = 1, display);
invariants=tx,u⁡x,t
solutions=u⁡x,t=c__1−c__2⁢ln⁡t+xx2+c__2⁢ln⁡t−xx2
_________________________________________________
invariants=t2−x2,u⁡x,t
solutions=u⁡x,t=c__4⁢ln⁡t2−x2+c__3
invariants=t,u⁡x,t
solutions=u⁡x,t=c__5⁢t+c__6
invariants=x,u⁡x,t
solutions=u⁡x,t=c__7⁢x+c__8
u⁡x,t=c__1⁢t+c__2,u⁡x,t=c__1⁢x+c__2,u⁡x,t=c__2⁢ln⁡t2−x2+c__1,u⁡x,t=c__1−c__2⁢ln⁡t+xx2+c__2⁢ln⁡t−xx2
These invariants shown are a fingerprint of each solution; they can now be copied directly from the screen and pasted in the call to InvariantSolutions to reproduce precisely the corresponding solution.
InvariantSolutions(pde[2], invariants = [t/x, u(x,t)]);
u⁡x,t=c__1−c__2⁢ln⁡t+xx2+c__2⁢ln⁡t−xx2
The general form of Infinitesimals for pde[2] involves arbitrary functions _Fn⁡t+x and _Fm⁡x−t.
Infinitesimals(pde[2]);
_ξx⁡x,t,u=f__1⁡t+x+f__2⁡t−x,_ξt⁡x,t,u=−f__2⁡t−x+f__1⁡t+x+1,_ηu⁡x,t,u=f__3⁡t+x+f__4⁡t−x,_ξx⁡x,t,u=f__5⁡t+x+f__6⁡t−x,_ξt⁡x,t,u=−f__6⁡t−x+f__5⁡t+x,_ηu⁡x,t,u=u+f__7⁡t+x+f__8⁡t−x
It is not possible to compute a SimilarityTransformation or, for that matter, any symmetry related transformation with them because of the arbitrary functions. In order to use these infinitesimals, the arbitrary functions are now automatically specialized by all the symmetry commands (except for Infinitesimals), as you could see by interactively using the new specialize_Fn option of Infinitesimals.
S := Infinitesimals(pde[2], specialize_Fn, displayfunctionality = false);
S≔_ξx=1,_ξt=0,_ηu=0,_ξx=1,_ξt=2,_ηu=0,_ξx=0,_ξt=1,_ηu=1,_ξx=1,_ξt=1,_ηu=u,_ξx=1,_ξt=−1,_ηu=u,_ξx=0,_ξt=1,_ηu=t+x,_ξx=0,_ξt=1,_ηu=t−x,_ξx=0,_ξt=0,_ηu=u+1,_ξx=0,_ξt=0,_ηu=u+t+x,_ξx=0,_ξt=0,_ηu=u+t−x,_ξx=t+x,_ξt=1+t+x,_ηu=0,_ξx=t−x,_ξt=−t+x+1,_ηu=0,_ξx=t+x,_ξt=t+x,_ηu=u,_ξx=t−x,_ξt=x−t,_ηu=u
In this way, all these commands can deal with the symmetries of pde[2] properly.
SymmetryTransformation(S[5], u(x, t), v(r, s));
r=x+_ε,s=−_ε+t,v⁡r,s=u⁡x,t⁢ⅇ_ε
Invariant solutions can then be computed automatically because this specialization of arbitrary functions is now automatic.
InvariantSolutions(pde[2]);
u⁡x,t=c__1⁢t+x,u⁡x,t=c__1t−x,u⁡x,t=c__1⁢x+c__2+t,u⁡x,t=c__1⁢−2⁢x+t+c__2,u⁡x,t=c__1⁢ⅇt2−x2ⅇ−x,u⁡x,t=c__1⁢ⅇ−t2−x2ⅇ−x,u⁡x,t=x22+t+c__1⁢x+t22+c__2,u⁡x,t=x22+−t+c__2⁢x+t22+c__1,u⁡x,t=c__2⁢ln⁡ⅇ2⁢x−2⁢t⁢1+2⁢t+2⁢x+c__1,u⁡x,t=c__2⁢ln⁡ⅇ2⁢t+2⁢x⁢2⁢t−2⁢x−1+c__1
The internal PDEtools Library of routines is now available for programming purposes
The PDEtools internal library for manipulating and programming with differential equations is now available, starting in Maple 13 with 45 subroutines.
The PDEtools Library of routines is made available mainly for programming purposes. Some of these routines, however, are valuable for mathematical reasons. For example, the result previously obtained using the new PolynomialSolutions command for sys[1] is computed by first estimating upper bounds for the degree of the solution.
sys[1];
fx⁢gx+fy⁢gy+g⁢fx,x+fy,y=−1
Describe(PDEtools:-Library:-UpperBounds);
# # Parameters # * PDESYS - a PDE system; it can contain PDEs, ODEs, and also non-differential equations # * F - a list of the unknown functions of PDESYS # * increasefornonautonomous - optional, can be true (default) or false, to increase the upper bounds by 1 in the presence of nonautonomous equations in PDESYS # Description: UpperBounds returns a sequence of sets of equations, where the lhs is a function of F and the rhs is an upper bound for the degree of a solution polynomial in the independent variables. # Example # > sys := diff(f(x,y),x)*diff(g(y),y) + diff(f(x,y),y)*diff(g(y),y) + f(x,y)*(diff(f(x,y),x,x) + diff(f(x,y),y,y)) = x*y: # > PDEtools:-Library:-UpperBounds(sys, [f(x,y), g(y)]); # {f(x, y) = 3, g(y) = 2} # > PDEtools:-Library:-UpperBounds(sys, [f(x,y), g(y)], increasefornonautonomous = false); # {f(x, y) = 2, g(y) = 1} # UpperBounds( PDESYS, F, X::list(name) := _GetIndepVars(F), { increasefornonautonomous::truefalse := true } )
PDEtools:-Library:-UpperBounds(sys[1], [f, g](x,y));
f=2,g=1
Relevant extension in dpolyform and casesplit
The casesplit and dpolyform commands can now compute with arbitrary functions of algebraic expressions (not symbol variables). In other words, given an expression for some unknowns (that is, non-rational in arbitrary functions whose arguments are non-rational in the independent variables), compute a differential polynomial representation (PDE system), solved by the given expression, where the PDE system is rational in the unknowns and its derivatives, and has rational coefficients.
Motivation: arbitrary functions of algebraic expressions (typically differential invariants) appear frequently when solving intermediary PDE problems that enter the formulation of applications or larger PDE problems. The new ability permits doing differential elimination with these objects and so uncoupling nonlinear PDE systems that involve them, extending in significant ways what can now be done with PDE systems and their solutions.
Consider the following expression for some g⁡x,t that involves the arbitrary functions f__1⁡t+x+f__2⁡x−t.
sol[3] := g(x,t) = _F1(x+t) + _F2(x-t);
sol3≔g⁡x,t=f__1⁡t+x+f__2⁡x−t
What is the PDE satisfied by this expression? It can now be computed: it is the wave equation in two dimensions.
pde[3] := dpolyform(sol[3], no_Fn);
pde3≔gx,x=gt,twhere
The ability to compute differential polynomial representations for some mapping of variables x,t,... is old, based on the knowledge of the mathematical properties of the mapping applied to the variables (for example, sin⁡t+x). The ability to compute these PDE representations with arbitrary mappings (for example, f__1⁡t+x) that have no particular mathematical properties is new in Maple 13. Derivatives of arbitrary mappings evaluated at expressions can also be represented in rational PDE form.
sol[4] := g(x,t) = D(_F1)(ln(x*t) + _F2(1/exp(t)));
sol4≔g⁡x,t=D⁡f__1⁡ln⁡x⁢t+f__2⁡1ⅇt
pde[4] := dpolyform(sol[4], no_Fn);
pde4≔gt,x=gt⁢gx,xgx+gtxwheregt≠0,gx≠0
These results can be verified as usual using pdetest.
pdetest(sol[4], pde[4]);
The casesplit command also accepts a new optional argument, caseplot, so that in addition to the splitting into cases, it also produces a plot with a graphical representation of the splitting.
ode[11] := diff(y(t),t,t)^2 + 2*diff(y(t),t,t)*y(t)^3*diff(y(t),t) - 4*y(t)^2*diff(y(t),t)^3;
ode11≔yt,t2+2⁢yt,t⁢y⁡t3⁢yt−4⁢y⁡t2⁢yt3
casesplit(ode[11], caseplot);
========= Pivots Legend =========
p1=y⁡t3⁢yt+yt,t
p2=y⁡t
p3=yt
PLOT⁡...
yt,t2=−2⁢yt,t⁢y⁡t3⁢yt+4⁢y⁡t2⁢yt3wherey⁡t3⁢yt+yt,t≠0,yt=−y⁡t44wherey⁡t≠0,yt=0wherey⁡t≠0,y⁡t=0where
Extended functionality in pdetest regarding boundary conditions
The pdetest command can now test solutions for correctness regarding boundary conditions.
Consider the following PDE, boundary condition, and solution.
pde[3] := diff(u(x,t),t) = k*diff(diff(u(x,t),x),x)+Q;
pde3≔ut=k⁢ux,x+Q
bc[3] := u(0,t) = 2*exp(k*t)-1/k*Q;
bc3≔u⁡0,t=2⁢ⅇk⁢t−Qk
sol[3] := u(x,t) = _C1^2*exp(x+k*t)-(_C1^2-2)*exp(-x+k*t)-1/2/k*Q*x^2+1/_C1^2/k*Q*(_C1^2-2)*x-1/k*Q;
sol3≔u⁡x,t=c__12⁢ⅇk⁢t+x−c__12−2⁢ⅇk⁢t−x−Q⁢x22⁢k+Q⁢c__12−2⁢xc__12⁢k−Qk
You can test whether the sol[1] solves pde[1] using pdetest; the new functionality is that you can now test whether it solves the boundary condition bc[1].
pdetest(sol[3], [pde[3], bc[3]]);
0,0
The boundary conditions can involve derivatives:
bc[3.1] := D[1,1](u)(0,t) = 2*exp(k*t)-1/k*Q;
bc3.1≔D1,1⁡u⁡0,t=2⁢ⅇk⁢t−Qk
pdetest(sol[3], [pde[3], bc[3.1]]);
There have been improvements in several aspects of numerical ODE solution for Maple 13.
The event handling features introduced in Maple 12 have been extended with the ability to control initial triggering of events; the addition of new event programming constructs (tobegin, toend, breakiteration, delayhalt); the addition of the side construct for round-off control; the ability to restrict a root-finding trigger to an increasing or decreasing region of the trigger expression; and the ability to interactively query when events have fired (eventfired). See dsolve,Events for more details.
There is improved robustness of core solvers with respect to accuracy and error control for pure ODE problems and index-1 DAE variables. This provides better detection of solution discontinuities (for more information see examples,dsolve_numeric_NewErrorControl).
The error control improvements mean that Maple now gives a correct answer to the following problem:
dsn:=dsolve({diff(x(t),t)=1,y(t)=sin(Pi*t),x(0)=0},numeric):
dsn(10);
t=10.,x⁡t=10.0000000000000,y⁡t=3.77932738528965×10−8
A gap in the explicit Runga-Kutta technique error control mechanism has been fixed, and Maple now gives a correct answer to the following problem:
dsn2:=dsolve({diff(x(t),t)=x(t)/(1-t),x(0)=1},numeric):
dsn2(0.99);
t=0.99,x⁡t=99.9999931813019
Maple can also perform more sophisticated error detection:
dsn2(1.01);
Error, (in dsn2) cannot evaluate the solution further right of .99999999, probably a singularity
This returns an error because the ODE is singular at t=1.
There is improved performance for DAE problems having relatively few degrees of freedom using an improved projection strategy.
There is more effective optimization with optimize=true option, and the addition of the new compile option for use of the Compiler with hardware precision evalhf-capable problems using the default rkf45 and rosenbrock solvers.
There is also the addition of the interactive numfun query option to provide the number of evaluations of the ODE performed in computation of a solution value for an IVP problem (supported for all IVP solvers that support maxfun).
See Also
Index of New Maple 13 Features
Download Help Document