ODEs and PDEs - Maple Help
For the best experience, we recommend viewing online help using Google Chrome or Microsoft Edge.

Online Help

All Products    Maple    MapleSim


Ordinary and Partial Differential Equations

Maple is the world leader in finding exact solutions to ordinary and partial differential equations. Maple 2021 extends that lead even further with new algorithms and techniques for solving more ODEs and PDEs.

For Maple 2021, there are significant improvements in dsolve for the exact solution of 2ndorder linear ODEs using hypergeometric functions. The algorithms implemented are at the frontier of the understanding of this problem, and handle classes of extended equations with apparent singularities as well as the most common linear equations with 4 and 5 singularities.

For ODEs and PDEs, the LieAlgebrasOfVectorFields package in Maple 2021 has a new command MapDE , for analyzing the possible linearization of polynomially nonlinear equations, and determining the corresponding mapping when it exists, allowing in that way for the computation of more approximate and exact solutions.

The new Student[ODEs] package covers the material in a standard first course in ODEs and provides step-by-step tools for solving ODEs as well as interactive visualization.  For details, see Student Packages.

 

Advanced type of Hypergeometric solutions for 2nd order linear ODEs

Linearization of polynomially nonlinear ODE and PDE

Advanced type of Hypergeometric solutions for 2nd order linear ODEs

When they exist, 2F1, 1F1 and 0F1 hypergeometric solutions for 2ndorder linear ODEs are now computable in a rather general case. An equation with 3 regular singularities and any number of apparent singularities can now be solved in terms of 2F1 equations using the algorithms presented in (6) and (7). Likewise, an equation with 2 or 1 singularities, one of which is irregular, can now be solved in general using 1F1 and 0F1 hypergeometric functions using the algorithms presented in (1), (2) and (3). Common equations with up to 5 regularities (plus any number of apparent singularities) can now be solved using mappings and the tables from references (4) and (5). All this significantly extends the previous capabilities in solving linear equations, and also of higher order and nonlinear ODE and PDE that through a reduction or symmetry process require the solving of intermediate 2ndorder linear ODEs.

 

The new algorithms are now automatically used by dsolve and also accessible through a new DEtools command, hypergeometricsols.

 

Examples

Despite the powerful algorithms for hypergeometric solutions of previous Maple releases, none of the following examples could be solved. Now they can. This equation admits 2F1 solutions where the argument is polynomial in x of degree 3

ode__1ⅆ2ⅆx2yx=1296a56x2+4a3+109x+4a949xx1b+216x288432x231+bx1x2x1ⅆⅆxyx9a56a16x232b41+bx1x2x1 yx:

dsolveode__1

yx=_C1F12112a2,a2+512;12;bx1x2+_C2x1xF12712a2,1112a2;32;bx1x2

(1.1)

Verify this solution

odetest,ode__1

0

(1.2)

This other equation admits solutions in terms of modified Bessel functions of the first and second kind

ode__2ⅆ2ⅆx2yx=8x482x92x15ⅆⅆxyx+4x696x5+931x44452x3+10539x212474x+97204x2x322x92x15 yx:

dsolveode__2

yx=_C1x4x336x2+141x225I1x2+4x3+24x263x+27I2x2x3+_C2x4x3+36x2141x+225K1x2+4x3+24x263x+27K2x2x3

(1.3)

Moreover, note that each independent solution involves a linear combination of functions. Indeed, while Bessel (or more generally, 0F1) solutions are related to equations with 1 singularity of irregular kind, this example has other regular singularities:

DEtoolssingularitiesode__2

regular=0,3,92,152,irregular=

(1.4)

thus requiring the use of a linear combination of pFq functions to construct a solution. A similar situation happens with the next example where, due to the presence of apparent singularities, a linear combination of - this time 1F1 - hypergeometric functions (KummerM and KummerU) is required to solve the problem

ode__3ⅆ2ⅆx2yx=16x4+32x236x+816x416x3+32x24xⅆⅆxyx12x3+13x2+x9416x416x3+32x24 x yx:

dsolveode__3

yx=_C112x122M54,3,x+20x+5M94,3,x+_C216x122U54,3,x+20x5U94,3,x

(1.5)

In addition to computing new solutions out of reach in previous releases, when the linear ODE is of Heun type, so it has 4 regular singularities or one of its confluent cases, and it happens to be one of the special Heun function cases that can be expressible using hypergeometric functions, both kinds of solutions are now computable. This equation is of the Heun triconfluent type

ode__4  ⅆ2ⅆx2yx = 4 x44 x2+10 x2yx:

The algorithms in dsolve perceive that and solve it accordingly

dsolveode__4

yx=_C1ⅇ23x3+xHT36234,152,613,x6233+_C2ⅇ23x3xHT36234,152,613,x6233

(1.6)

By using the option of indicating the method, a solution in terms of linear combinations of Airy functions (of the 0F1)  is now also computable

dsolveode__4,hypergeometricsols

yx=_C12x+1Aix21+2x2+x1Aix21+_C22x+1Bix21+2x2+x1Bix21

(1.7)

To express this solution in terms of the more general 0F1 form you can use

convert,hypergeom

yx=_C12x+13316Γ232F10;13;x2+139π+x212313F10;53;x2+1396Γ23+2x2+x1313F10;23;x2+1393Γ23x21316Γ23F10;43;x2+1392π+_C22x+13323Γ232F10;13;x2139π+356x12x+12F10;53;x2139x1x+16x26Γ23+2x2+x1356F10;23;x2+1393Γ23+323x21Γ23F10;43;x2+1392π

(1.8)

A similar situation, this time with regards to this equation of the Heun biconfluent class

ode__5ⅆ2ⅆx2yx=x2+3x+43xⅆⅆxyx+x+19x yx:

dsolveode__5

yx=_C1HB13,6,−3,1469,6x6ⅇxx+66+_C2HB13,6,−3,1469,6x6ⅇxx+66x13

(1.9)

The solution is expressible in terms of linear combinations of modified Bessel functions of the 1st and 2nd kinds

dsolveode__5,hypergeometricsols

yx=_C1ⅇxx+612x2+6x+16I134+x4+xx12+4+x4+xxI434+x4+xx124+xx16+_C2ⅇxx+612x2+6x+16K134+x4+xx124+x4+xxK434+x4+xx124+xx16

(1.10)

The following example is of the same kind but more general: it belongs to the Heun general class, but again it is one of those special cases where pFq function solutions exist, in this case 2F1 with rational coefficients

ode__6ⅆ2ⅆx2yx=345x2+14x+14x27x2+14x+3ⅆⅆxyx+3x+12b3b+364x227x2+14x+3 yx:

dsolveode__6

yx=_C1HG4I2+74I2+7,45927b+4I2b143b2815141904I25983+Ib2+10Ib+51I72+17b256+85b28484I2+734I27256I2b61904I25983+17b,1+b6,2515056I2115212301904I25983+bI232946012+b4I2+734I27256I2b61904I25983+17b,b4+1,32,27x4I2+7x38+b827x+4I2+73427x+4I27656157113+10604I2456I2+1724I2724I2+7327x2+14x+314+_C2HG4I2+74I2+7,1561518b467Ib476+30I172275b952+15281904I25983+Ib210Ib+17949I23825983b21904+29915b952+4856I2+174I2+734I27256I2b61904I25983+17b,1b12,5030106I2115212301904I25983+bI23294606+b4I2+734I27256I2b61904I25983+17b,b4+1,32,27x4I2+7x38b827x+4I2+73427x+4I27656157113+10604I2456I2+1724I2724I2+7327x2+14x+314

(1.11)

dsolveode__6,hypergeometricsols

yx=_C11+143x+9x2b24181x3b1214x38b8F1258b24,b24+18;1b12;256x3x3227x2+14x+3+_C21+143x+9x2b24181x3b1214x38+b8F1258+b24,b24+18;1+b12;256x3x3227x2+14x+3

(1.12)

odetest,ode__6

0

(1.13)

References

  

(1) M. van Hoeij and Q. Yuan. {em Finding all Bessel type solutions for Linear Differential Equations with Rational Function Coefficients}, ISSAC'2010 Proceedings.

  

(2) R. Debeerst, M. van Hoeij, W. Koepf, Solving Differential Equations in Terms of Bessel Functions, ISSAC'2008 Proceedings.

  

(3)    M. van Hoeij, J-A. Weil, Solving Second Order Linear Differential Equations with Klein's Theorem. ISSAC'2005 Proceedings.

  

(4)    R. Vidunas, G. Filipuk: A Classification of Covering yielding Heun to Hypergeometric Reductions, Funkcialaj Ekvacioj (2013).

  

(5)    M. van Hoeij, V. Kunwar, Classifying (near)-Belyi maps with Five Exceptional Points. Indagationes Mathematicae (2019).

  

(6) V. Kunwar and M. van Hoeij, Second Order Differential Equations with Hypergeometric Solutions of Degree Three, ISSAC'2013 Proceedings.

  

(7) E. Imamoglu and M. van Hoeij, Computing Hypergeometric Solutions of Second Order Linear Differential Equations using Quotients of Formal Solutions and Integral Bases,  J. of Symbolic Computation, (2017).

Linearization of polynomially nonlinear ODE and PDE

A fingerprint of a linear DE is that linear super-position of its solutions yields other solutions.  Encoded geometrically this means that the input DE must have a subgroup of symmetries corresponding to this super-position symmetry (and in particular be an infinite abelian Lie subgroup in the case of linearizable PDE).

IsLinearizable and MapDE leverage the power of the LieAlgebrasOfVectorFields package, introduced in Maple 2020, by algorithmically computing and exploiting symmetry group properties through their associated Lie algebras.  Lie symmetry groups, when linearized about the identity symmetry, yield Lie algebras of vector fields tangent to their one parameter group orbits.

This beautiful linearization yields determining systems of linear homogeneous PDE (LHPDE) for the components of the associated Lie algebra of vector fields.

Then algorithmic differential reduction and elimination algorithms are applied to these linear systems, to find both algebraic (e.g. center, lower central series, etc) and geometric (e.g. distribution, invariants, etc) properties of the Lie algebras of vector fields.

The LieAlgebrasOfVectorFields package is a complement to DifferentialGeometry. In particular, the LieAlgebras package in DifferentialGeometry enables the flexible formulation of geometric problems arising in applications, enabling the user to formulate and solve them using exterior differential systems and moving frames while working intrinsically on the relevant manifolds.

The IsLinearizable command illustrating the existence step of MapDE

The IsLinearizable command introduced in Maple 2020 illustrates some basic ideas underlying MapDE.  In particular it uses LieAlgebrasOfVectorFields (LAVF) to implement a remarkable algorithm introduced by Lyakhov, Gerdt and Michels (2017).

To illustrate it, consider the nonlinear ODE:

withLieAlgebrasOfVectorFields:

NLODEuxⅆ3ⅆx3ux+3ⅆⅆxuxⅆ2ⅆx2ux3ⅆⅆxux2+uxⅆ2ⅆx2ux+12uxⅆⅆxux+x8xuxⅆⅆxux+x41+ux2+x2ux2+x2=0:

To check whether this ODE can be linearized you can use IsLinearizable. First, set up the symmetry vector field

X  VectorFieldxix,u,x,etax,u,u, space = x,u

Xξx,ux+ηx,uu

(2.1.1)

Then apply IsLinearizable

IsLinearizableNLODE, X

true

(2.1.2)

Here true means that there exists an invertible change of variables that maps the nonlinear ODE to a linear ODE.  IsLinearizable is a good example of how LAVF enables the efficient computation of geometric information, in this case the existence of a linearization map, to determine if more expensive methods can be applied to a problem (in this case to determine the linearization). Here we display the simple procedure, which uses the LAVF commands SymmetryLAVF, SolutionDimension, DerivedAlgebra and IsAbelian.

printIsLinearizable

procDEs::equation&comma;X::LieAlgebrasOfVectorFields:-VectorFieldNULL&comma; $localn&comma;L&comma;m&comma;Da&comma;S&semi;ifDEs::equationthenSDEselseSDEsfi&semi;nPDEtools&lsqb;difforder&rsqb;S&semi;ifn<2thenreturntruefi&semi;tryLLieAlgebrasOfVectorFields:-SymmetryLAVFS&comma;Xcatch&colon;errorend&semi;mSolutionDimensionL&semi;ifn&equals;2andm&equals;8thenreturntruefi&semi;ifm&equals;n&plus;4thenreturntruefi&semi;ifm&equals;n&plus;1orm&equals;n&plus;2thenDaDerivedAlgebraL&semi;returnevalbIsAbelianDaandn&equals;SolutionDimensionDafi&semi;returnfalseend

(2.1.3)

In the procedure above, for our example, n = 3.  SymmetryLAVF sets up the Lie algebra of vector fields, and m is the dimension of the Lie symmetry algebra m = 4 = n + 1 .  The LAVF instruction IsAbelian(Da) yields true, without determining a basis for the Derived Algebra Da.  Only algorithmic differentiations and eliminations of the determining system for Da were needed, based in an induced Lie algebra on the space of initial data for Da.

Apply MapDE to uux,x,x+3uxux,x3uux,x+ux2+12uux+x8xuux+x4u2+x2+1u2+x2=0

The IsLinearizable command in the previous section only determines the existence of a mapping of an input DE to some (unknown) linear (target) DE.  Here we illustrate how MapDE determines more information about the mapping, and in some cases can determine the map explicitly.

Applying MapDE to NLODE:

We set the MapDE infolevel to get some information about the main steps of the computation:

infolevelMapDE  1&colon;

MLODE  MapDENLODE&comma; x&comma;u&comma; xi&comma;eta&comma; ToLinearDE&comma; xh&comma; uh&comma; psi&comma; phi

MapDE: Begin section where we compute sys S' of subalgebra L' of L, containing solution of mapping problem.

MapDE: Single ODE so apply the Lyakhov-Gerdt-Michels ODE Test for Existence of Linearization

MapDE: Input DE is linearizable by Lyakhov-Gerdt-Michels ODE Test: dimL = 4

MapDE: Construct BK map eqns on Tangent Space to Jet Variety.

MapDE: Mapping equations constructed.

MapDE: Set up ranking and mindim specification for differential-elimination.

MapDE: In ToLinear and not CK.

MapDE:  Settings for differential-elimination: MinDim = 3 ranking = [rho[1] xi eta] RifStrategy = ezcriteria = [1 .9]

MapDE: Apply differential-elimination (rifsimp) to Mapping Equations.

MapDE: Completed differential-elimination and casesplitting of Mapping System. Time in rifsimp = 0.45e-1

MapDE: Existence of linearization was found earlier. Now attempting to integrate mapping eqns

MapDE: Try to simplify PhiEqSol by setting values for the unknown functions, constants etc.

MapDE: Attempted simplification of PhiEq yielded nonzero Jacobian, now using simplified form

MLODEtableIntegratedMap=xh=u2+x2&comma;uh=x&comma;MapDEPivs=uψx&comma;u0&comma;uφx&comma;uxxφx&comma;uu0&comma;TargetDE=&DifferentialD;3&DifferentialD;xh3uhxh=xh+1uhxhxhwhereuhxh&DifferentialD;&DifferentialD;xhuhxh0&comma;uhxh2+xh0&comma;uhxh0&comma;MapExists=true&comma;RedMapDE=2x2φx&comma;u=2u2φx&comma;uux222uxφx&comma;uu2xuφx&comma;uu2uφx&comma;ux2u3&comma;xψx&comma;u=uψx&comma;uxu

(2.2.1)

Here MapDE has carried out the existence step described in the previous section, to determine that there exists a mapping [xh = psi(x,u), uh = phi(x,u)] of NLODE to a linear ODE.  Then MapDE is guaranteed in theory to return canonical differential equations in phi and psi for the mapping MLODE[RedMapDE] subject to the inequality constraints MLODE[MapDEPivs].  MapDE then uses pdsolve to attempt to integrate those equations to obtain an explicit form for the mapping, obtaining in this case:

MLODE&lsqb;IntegratedMap&rsqb;

xh=u2+x2&comma;uh=x

(2.2.2)

The target linear ODE is also obtained:

MLODETargetDE

&DifferentialD;3&DifferentialD;xh3uhxh=xh+1uhxhxhwhereuhxh&DifferentialD;&DifferentialD;xhuhxh0&comma;uhxh2+xh0&comma;uhxh0

(2.2.3)

Even though both NLODE and the considerably simpler linear MLODE can not be explicitly solved by dsolve, approximations for a basis of 3 solutions can be found by dsolve/series or dsolve/numeric.  In this way the linearity of the target can be exploited to enable a general solution to be constructed without further significant computation.

Nonlinear PDE System linearizable by hodograph transformation  vt=v3ux&comma; ut=u5vx

infolevelMapDE  2&colon;

NPDESysdiffvx&comma;t&comma;t=vx&comma;t3diffux&comma;t&comma;x&comma;diffux&comma;t&comma;t=ux&comma;t5diffvx&comma;t&comma;x

NPDESystvx&comma;t=vx&comma;t3xux&comma;t&comma;tux&comma;t=ux&comma;t5xvx&comma;t

(2.3.1)

We now compute the linearizing mapping and, when possible, also the resulting linear DE system, with MapDE

MPDESys3MapDENPDESys&comma;x&comma;t&comma;u&comma;v&comma;ξ&comma;τ&comma;η&comma;β&comma;ToLinearDE&comma;xh&comma;th&comma;uh&comma;vh&comma;ψ&comma;ϒ&comma;ϕ&comma;φ

MapDE: Enter MapDE: Planned to have glossary of symbols and their meaning similar to rifsimp:

MapDE: ID = Initial Data

MapDE: Dim = Dimension

MapDE: DA  = Derived Algebra

MapDE: R  = input DE or its rif-form, Rh = Target DE or its rif-form

MapDE: S  = DetSys Sym of R, S' = DetSys for SubAlg of Sym of S

MapDE: Input DE of order 1 in 2 dependent variable(s) 2 independent variable(s) 2 equation(s)

MapDE: Enter Fast Early Algebraic-Geometric Prop Test

MapDE: Begin section where we compute sys S' of subalgebra L' of L, containing solution of mapping problem.

MapDE: About to enter DerivedAlgebraInf

DerivedAlgebraInf: Enter DerivedAlgebraInf

DerivedAlgebraInf: Lie pseudogroup G of sym of DE: dim(G) = infinity So DE is possibly linearizable

DerivedAlgebraInf: Apply rif to commutator DA sys

DerivedAlgebraInf: ID for DA sys =  [[] [xi(x[0] t[0] u[0] v) = _F1(v) tau(x[0] t[0] u[0] v) = _F2(v)]]

MapDE: Exited from DerivedAlgebraInf. Time in DerivedAlgebraInf = .588

MapDE: Construct BK map eqns on Tangent Space to Jet Variety.

MapDE: Mapping equations constructed.

MapDE: Set up ranking and mindim specification for differential-elimination.

MapDE: In ToLinear and not CK.

MapDE:  Settings for differential-elimination: MinDim = infinity ranking = [rho[1] rho[2] xi tau eta beta] RifStrategy = ezcriteria = [1 .9]

MapDE:  For a detailed description of these settings see Maple's documentation on rifsimp.

MapDE: Apply differential-elimination (rifsimp) to Mapping Equations.

MapDE: Completed differential-elimination and casesplitting of Mapping System. Time in rifsimp = 2.815

MapDE: After rif ncases = 46

MapDE: Number consistent cases satisfying minimum dim condns 2

MapDE: Multiple   2   cases found. Analyzing cases.

MapDE: nops(RifMapEqsSys)= 2 ntruecases= 2

MapDE: CaseSelectList = [2]

MapDE: Apply a pure elimination strategy to isolate the target and prepare to find the transformations.

MapDE: PsiPhiEqs have triangular structure wrt phi - psi vars

MapDE: Existence of linearization was found earlier. Now attempting to integrate mapping eqns

MapDE: Try to simplify PhiEqSol by setting values for the unknown functions, constants etc.

MapDE: Attempted simplification of PhiEq yielded nonzero Jacobian, now using simplified form

MPDESys3tableIntegratedMap=xh=u&comma;th=v&comma;uh=x&comma;vh=t&comma;MapDEPivs=xφx&comma;t&comma;u&comma;v0&comma;tϕx&comma;t&comma;u&comma;v0&comma;uψx&comma;t&comma;u&comma;vvϒx&comma;t&comma;u&comma;vvψx&comma;t&comma;u&comma;vuϒx&comma;t&comma;u&comma;v0&comma;TargetDE=xhvhxh&comma;th=thuhxh&comma;thxh5&comma;thvhxh&comma;th=xhuhxh&comma;thth3&comma;2xh2uhxh&comma;th=2th2uhxh&comma;thth3xh5wherethuhxh&comma;th2th3+xhuhxh&comma;th2xh50&comma;vhxh&comma;th0&comma;MapExists=true&comma;RedMapDE=2x2φx&comma;t&comma;u&comma;v=0&comma;2x2ϕx&comma;t&comma;u&comma;v=0&comma;2txϕx&comma;t&comma;u&comma;v=0&comma;2t2ϕx&comma;t&comma;u&comma;v=0&comma;xϒx&comma;t&comma;u&comma;v=0&comma;xψx&comma;t&comma;u&comma;v=0&comma;tϒx&comma;t&comma;u&comma;v=0&comma;tφx&comma;t&comma;u&comma;v=0&comma;tψx&comma;t&comma;u&comma;v=0

(2.3.2)

Here MapDE finds an elegant hodograph form for the transformation to a linear system.  Such hodograph transformations are important in applications, precisely because they linearize such problems.  Notice that during the linearization analysis, MapDE detected highly non-trivial infinite dimensional Lie pseudogroups which were key to the analysis.

Fast certification of nonlinearizability of the KP Equation ux,t+3ux22+3uux,x2+ux,x,x,x4+3uy,y4=0

Consider the KP (Kadomtsev–Petviashvili) equation which arises from nonlinear wave motion, and is a generalization of the KdV (Korteweg–de Vries) equation to two dimensions:

infolevelMapDE  2

infolevelMapDE2

(2.4.1)

KPDEdiffdiffux&comma;y&comma;t&comma;t+32ux&comma;y&comma;tdiffux&comma;y&comma;t&comma;x+14diffux&comma;y&comma;t&comma;x&comma;x&comma;x&comma;x+34diffux&comma;y&comma;t&comma;y&comma;y=0

 

 

KPDE2txux&comma;y&comma;t+3xux&comma;y&comma;t22+3ux&comma;y&comma;t2x2ux&comma;y&comma;t2+4x4ux&comma;y&comma;t4+32y2ux&comma;y&comma;t4=0

(2.4.2)

MKPDEMapDEKPDE&comma;x&comma;y&comma;t&comma;u&comma;ξ&comma;η&comma;τ&comma;β&comma;ToLinearDE&comma;xh&comma;yh&comma;th&comma;uh&comma;ψ&comma;ϒ&comma;ϕ&comma;φ

MapDE: Enter MapDE: Planned to have glossary of symbols and their meaning similar to rifsimp:

MapDE: ID = Initial Data

MapDE: Dim = Dimension

MapDE: DA  = Derived Algebra

MapDE: R  = input DE or its rif-form, Rh = Target DE or its rif-form

MapDE: S  = DetSys Sym of R, S' = DetSys for SubAlg of Sym of S

MapDE: Input DE of order 4 in 1 dependent variable(s) 3 independent variable(s) 1 equation(s)

MapDE: Enter Fast Early Algebraic-Geometric Prop Test

MapDE: Input R not linearizable since DiffDim(L}= 1  <  2  = DiffDim(R))

MKPDEtableMapExists=false

(2.4.3)

Although the KP equation has an infinite dimensional Lie pseudogroup of symmetries it is not linearizable, since the differential dimension (a measure of size of such pseudogroups) is not large enough (not equal to the differential dimension of solutions of the KP equation).

 

To solve the equation in cases like this one, note that despite the non-existence of a linearizing mapping, the underlying point symmetries of the equation can be used to compute invariant solutions. The existence of point symmetries is guaranteed when the PDEtools:-DeterminingPDE command returns related infinitesimals different from zero

PDEtools:-DeterminingPDEKPDE

2y2_&xi;yx&comma;y&comma;t&comma;u=0&comma;t_&xi;tx&comma;y&comma;t&comma;u=3y_&xi;yx&comma;y&comma;t&comma;u2&comma;u_&xi;tx&comma;y&comma;t&comma;u=0&comma;x_&xi;tx&comma;y&comma;t&comma;u=0&comma;y_&xi;tx&comma;y&comma;t&comma;u=0&comma;u_&xi;xx&comma;y&comma;t&comma;u=0&comma;x_&xi;xx&comma;y&comma;t&comma;u=y_&xi;yx&comma;y&comma;t&comma;u2&comma;y_&xi;xx&comma;y&comma;t&comma;u=2t_&xi;yx&comma;y&comma;t&comma;u3&comma;u_&xi;yx&comma;y&comma;t&comma;u=0&comma;x_&xi;yx&comma;y&comma;t&comma;u=0&comma;_&eta;ux&comma;y&comma;t&comma;u=uy_&xi;yx&comma;y&comma;t&comma;u+2t_&xi;xx&comma;y&comma;t&comma;u3

(2.4.4)

Indeed, in this example, infinitesimals depending on three arbitrary functions are computable using PDEtools:-Infinitesimals

PDEtools:-InfinitesimalsKPDE

_&xi;xx&comma;y&comma;t&comma;u=&DifferentialD;&DifferentialD;t_F1tx2&DifferentialD;2&DifferentialD;t2_F1ty232&DifferentialD;&DifferentialD;t_F2ty3+_F3t&comma;_&xi;yx&comma;y&comma;t&comma;u=&DifferentialD;&DifferentialD;t_F1ty+_F2t&comma;_&xi;tx&comma;y&comma;t&comma;u=3_F1t2+1&comma;_&eta;ux&comma;y&comma;t&comma;u=u&DifferentialD;&DifferentialD;t_F1t+&DifferentialD;2&DifferentialD;t2_F1tx32&DifferentialD;3&DifferentialD;t3_F1ty294&DifferentialD;2&DifferentialD;t2_F2ty9+2&DifferentialD;&DifferentialD;t_F3t3

(2.4.5)

With the purpose of using these infinitesimals to compute solutions, this general form (2.4.5) can be specialized

PDEtools:-InfinitesimalsKPDE&comma;specialize_Fn

_&xi;xx&comma;y&comma;t&comma;u=0&comma;_&xi;yx&comma;y&comma;t&comma;u=1&comma;_&xi;tx&comma;y&comma;t&comma;u=1&comma;_&eta;ux&comma;y&comma;t&comma;u=0,_&xi;xx&comma;y&comma;t&comma;u=1&comma;_&xi;yx&comma;y&comma;t&comma;u=0&comma;_&xi;tx&comma;y&comma;t&comma;u=1&comma;_&eta;ux&comma;y&comma;t&comma;u=0,_&xi;xx&comma;y&comma;t&comma;u=0&comma;_&xi;yx&comma;y&comma;t&comma;u=0&comma;_&xi;tx&comma;y&comma;t&comma;u=52&comma;_&eta;ux&comma;y&comma;t&comma;u=0,_&xi;xx&comma;y&comma;t&comma;u=t&comma;_&xi;yx&comma;y&comma;t&comma;u=0&comma;_&xi;tx&comma;y&comma;t&comma;u=1&comma;_&eta;ux&comma;y&comma;t&comma;u=23,_&xi;xx&comma;y&comma;t&comma;u=2y3&comma;_&xi;yx&comma;y&comma;t&comma;u=t&comma;_&xi;tx&comma;y&comma;t&comma;u=1&comma;_&eta;ux&comma;y&comma;t&comma;u=0,_&xi;xx&comma;y&comma;t&comma;u=x2&comma;_&xi;yx&comma;y&comma;t&comma;u=y&comma;_&xi;tx&comma;y&comma;t&comma;u=3t2+1&comma;_&eta;ux&comma;y&comma;t&comma;u=u

(2.4.6)

Using any of the infinitesimals above, for example the first one, we get a solution

PDEtools:-InvariantSolutionsKPDE&comma;1

ux&comma;y&comma;t=4_C244_C2_C33_C32cosh_C2x+_C3y+t+_C12+12_C246cosh_C2x+_C3y+t+_C12_C22

(2.4.7)

From the form of this solution one can infer this equation also admits travelling wave solutions

PDEtools:-TWSolutionsKPDE

ux&comma;y&comma;t=_C5,ux&comma;y&comma;t=2_C22tanh_C2x+_C3y+_C4t+_C12+8_C244_C2_C43_C326_C22

(2.4.8)

References

(1) D.A. Lyakhov, V.P. Gerdt, and D.L. Michels. Algorithmic Verification of Linearizability for Ordinary Differential Equations. Proceedings of ISSAC 2017. ACM Press, 2017.

(2) Z. Mohammadi, G. Reid, and S.-L.T Huang. Introduction of the MapDE algorithm for determination of mappings relating differential equations. Proceedings of ISSAC 2019, pp. 331–338. ACM Press, 2019.

(3) Z. Mohammadi, G. Reid, and S.-L.T. Huang. Symmetry-based algorithms for invertible mappings of polynomially nonlinear PDE to linear PDE. Mathematics in Computer Science, 1–24, 2020.