hide long namesshow long names
hide short namesshow short names
Integer type:  int32  int64  nag_int  show int32  show int32  show int64  show int64  show nag_int  show nag_int

PDF version (NAG web site, 64-bit version, 64-bit version)
Chapter Contents
Chapter Introduction
NAG Toolbox

NAG Toolbox Chapter Introduction

D03 — partial differential equations

Scope of the Chapter

This chapter is concerned with the numerical solution of partial differential equations.

Background to the Problems

The definition of a partial differential equation problem includes not only the equation itself but also the domain of interest and appropriate subsidiary conditions. Indeed, partial differential equations are usually classified as elliptic, hyperbolic or parabolic according to the form of the equation and the form of the subsidiary conditions which must be assigned to produce a well-posed problem. The functions in this chapter will often call upon functions from other chapters, such as Chapter F04 (Simultaneous Linear Equations) and Chapter D02 (Ordinary Differential Equations). Other chapters also contain relevant functions, in particular Chapter D06 (Mesh Generation) and Chapter F11 (Large Scale Linear Systems).
The classification of partial differential equations is easily described in the case of linear equations of the second order in two independent variables, i.e., equations of the form
auxx+2buxy+cuyy+dux+euy+fu+g=0, (1)
where a, b, c, d, e, f and g are functions of x and y only. Equation (1) is called elliptic, hyperbolic or parabolic according to whether ac-b2 is positive, negative or zero, respectively. Useful definitions of the concepts of elliptic, hyperbolic and parabolic character can also be given for differential equations in more than two independent variables, for systems and for nonlinear differential equations.
For elliptic equations, of which Laplace's equation
uxx+uyy=0 (2)
is the simplest example of second order, the subsidiary conditions take the form of boundary conditions, i.e., conditions which provide information about the solution at all points of a closed boundary. For example, if equation (2) holds in a plane domain D bounded by a contour C, a solution u may be sought subject to the condition
u=f  on  C, (3)
where f is a given function. The condition (3) is known as a Dirichlet boundary condition. Equally common is the Neumann boundary condition
u=g  on  C, (4)
which is one form of a more general condition
u+fu=g  on  C, (5)
where u denotes the derivative of u normal to the contour C, and f and g are given functions. Provided that f and g satisfy certain restrictions, condition (5) yields a well-posed boundary value problem for Laplace's equation. In the case of the Neumann problem, one further piece of information, e.g., the value of u at a particular point, is necessary for uniqueness of the solution. Boundary conditions similar to the above are applicable to more general second-order elliptic equations, whilst two such conditions are required for equations of fourth order.
For hyperbolic equations, the wave equation
utt-uxx=0 (6)
is the simplest example of second order. It is equivalent to a first-order system
ut-vx=0,  vt-ux=0. (7)
The subsidiary conditions may take the form of initial conditions, i.e., conditions which provide information about the solution at points on a suitable open boundary. For example, if equation (6) is satisfied for t>0, a solution u may be sought such that
u x,0 = f x , u t x,0 = g x , (8)
where f and g are given functions. This is an example of an initial value problem, sometimes known as Cauchy's problem.
For parabolic equations, of which the heat conduction equation
ut-uxx=0 (9)
is the simplest example, the subsidiary conditions always include some of initial type and may also include some of boundary type. For example, if equation (9) is satisfied for t>0 and 0<x<1, a solution u may be sought such that
u x,0 = f x , 0 < x < 1 , (10)
and
u 0,t = 0 , u 1,t = 1 , t > 0 . (11)
This is an example of a mixed initial/boundary value problem.
For all types of partial differential equations, finite difference methods (see Mitchell and Griffiths (1980)) and finite element methods (see Wait and Mitchell (1985)) are the most common means of solution. The use of finite difference methods features prominently in this chapter, however, the use of finite element methods is sufficiently large in scope to warrant a separate library of functions for their implementation. NAG no longer provides a companion finite element library, but there are several such specialist libraries available, including ParaFEM. Some of the utility functions in this chapter are concerned with the solution of the large sparse systems of equations which arise from finite difference and finite element methods. Further functions for this purpose are provided in Chapter F11.
Alternative methods of solution are often suitable for special classes of problems. For example, the method of characteristics is the most common for hyperbolic equations involving time and one space dimension (see Smith (1985)). The method of lines (see Mikhlin and Smolitsky (1967)) may be used to reduce a parabolic equation to a (stiff) system of ordinary differential equations, which may be solved by means of functions from Chapter D02 (Ordinary Differential Equations). Similarly, integral equation or boundary element methods (see Jaswon and Symm (1977)) are frequently used for elliptic equations. Typically, in the latter case, the solution of a boundary value problem is represented in terms of certain boundary functions by an integral expression which satisfies the differential equation throughout the relevant domain. The boundary functions are obtained by applying the given boundary conditions to this representation. Implementation of this method necessitates discretization of only the boundary of the domain, the dimensionality of the problem thus being effectively reduced by one. The boundary conditions yield a full system of simultaneous equations, as opposed to the sparse systems yielded by finite difference and finite element methods, but the full system is usually of much lower order. Solution of this system yields the boundary functions, from which the solution of the problem may be obtained, by quadrature, as and where required.

Recommendations on Choice and Use of Available Functions

The choice of function will depend first of all upon the type of partial differential equation to be solved. At present no special allowances are made for problems with boundary singularities such as may arise at corners of domains or at points where boundary conditions change. For such problems results should be treated with caution. The choice of function may also depend on whether or not it is to be used in a multithreaded environment.
You may wish to construct your own partial differential equation solution software for problems not solvable by the functions described in Elliptic Equations to Convection-diffusion Systems below. In such cases you can employ appropriate functions from the Linear Algebra Chapters to solve the resulting linear systems; see Utility Routines for further details.

Elliptic Equations

The function nag_pde_2d_laplace (d03ea) solves Laplace's equation in two dimensions, equation (2), by an integral equation method. This function is applicable to an arbitrary domain bounded internally or externally by one or more closed contours, when the value of either the unknown function u or its normal derivative u is given at each point of the boundary.
The functions nag_pde_2d_ellip_fd (d03eb) and nag_pde_3d_ellip_fd (d03ec) solve a system of simultaneous algebraic equations of five-point and seven-point molecule form (see Mikhlin and Smolitsky (1967)) on two-dimensional and three-dimensional topologically-rectangular meshes respectively, using Stone's Strongly Implicit Procedure (SIP). These functions, which make repeated calls of the utility functions nag_pde_2d_ellip_fd_iter (d03ua) and nag_pde_3d_ellip_fd_iter (d03ub) respectively, may be used to solve any boundary value problem whose finite difference representation takes the appropriate form.
The function nag_pde_2d_ellip_mgrid (d03ed) solves a system of seven-point difference equations in a rectangular grid (in two dimensions), using the multigrid iterative method. The equations are supplied by you, and the seven-point form allows cross-derivative terms to be represented (see Mitchell and Griffiths (1980)). The method is particularly efficient for large systems of equations with diagonal dominance and should be preferred to nag_pde_2d_ellip_fd (d03eb) whenever it is appropriate for the solution of the problem.
The function nag_pde_2d_ellip_discret (d03ee) discretizes a second-order equation on a two-dimensional rectangular region using finite differences and a seven-point molecule. The function allows for cross-derivative terms, Dirichlet, Neumann or mixed boundary conditions, and either central or upwind differences. The resulting seven-diagonal difference equations are in a form suitable for passing directly to the multigrid function nag_pde_2d_ellip_mgrid (d03ed), although other solution methods could just as easily be used.
The function nag_pde_3d_ellip_helmholtz (d03fa), based on the function HW3CRT from FISHPACK (see Swarztrauber and Sweet (1979)), solves the Helmholtz equation in a three-dimensional cuboidal region, with any combination of Dirichlet, Neumann or periodic boundary conditions. The method used is based on the fast Fourier transform algorithm, and is likely to be particularly efficient on vector-processing machines.

Hyperbolic Equations

See Convection-diffusion Systems.

Parabolic Equations

There are five functions available for solving general parabolic equations in one space dimension:
Equations may include nonlinear terms but the true derivative ut should occur linearly and equations should usually contain a second-order space derivative uxx. There are certain restrictions on the coefficients to try to ensure that the problems posed can be solved by the above functions.
The method of solution is to discretize the space derivatives using finite differences or collocation, and to solve the resulting system of ordinary differential equations using a ‘stiff’ solver.
nag_pde_1d_parab_fd (d03pc) and nag_pde_1d_parab_coll (d03pd) can solve a system of parabolic equations of the form
j = 1 n P i j x,t,U, U x U j t + Q i x,t,U, U x = x - m x x m R i x,t,U, U x ,  
where i=1,2,,n, axb, tt0.
The parameter m allows the function to handle different coordinate systems easily (Cartesian, cylindrical polars and spherical polars). nag_pde_1d_parab_fd (d03pc) uses a finite differences spatial discretization and nag_pde_1d_parab_coll (d03pd) uses a collocation spatial discretization.
nag_pde_1d_parab_dae_fd (d03ph) and nag_pde_1d_parab_dae_coll (d03pj) are similar to nag_pde_1d_parab_fd (d03pc) and nag_pde_1d_parab_coll (d03pd) respectively, except that they provide scope for coupled differential-algebraic systems. This extended functionality allows for the solution of more complex and more general problems, e.g., periodic boundary conditions and integro-differential equations.
nag_pde_1d_parab_remesh_fd (d03pp) is similar to nag_pde_1d_parab_dae_fd (d03ph) but allows remeshing to take place in the spatial direction. This facility can be very useful when the nature of the solution in the spatial direction varies considerably over time.
For parabolic systems in two space dimensions see Second-order Systems in Two Space Dimensions.

Black–Scholes Equations

nag_pde_1d_blackscholes_fd (d03nc) solves the Black–Scholes equation
f t +r-qS f S +σ2S22 2f S2 =rf  
Smin<S<Smax,   tmin<t<tmax,  
for the value f of a European or American, put or call stock option. The parameters r, q and σ may each be either constant or time-dependent. The values of the Greeks are also returned.
In certain cases an analytic solution of the Black–Scholes equation is available. In these cases the solution may be computed by nag_pde_1d_blackscholes_closed (d03nd). More generally, Chapter S contains a set of option pricing functions that evaluate the closed form solutions or approximations to the equations that define mathematical models for the prices of selected financial option contracts, including the Black–Scholes equation (nag_specfun_opt_bsm_price (s30aa)).

First-order Systems in One Space Dimension

There are three functions available for solving systems of first-order partial differential equations:
Equations may include nonlinear terms but the time derivative should occur linearly. There are certain restrictions on the coefficients to ensure that the problems posed can be solved by the above functions.
The method of solution is to discretize the space derivatives using the Keller box scheme and to solve the resulting system of ordinary differential equations using a ‘stiff’ solver.
nag_pde_1d_parab_keller (d03pe) is designed to solve a system of the form
j = 1 n P i j x,t,U, U x U j t + Q i x,t,U, U x = 0 ,  
where i=1,2,,n, axb, tt0.
nag_pde_1d_parab_dae_keller (d03pk) is similar to nag_pde_1d_parab_keller (d03pe) except that it provides scope for coupled differential algebraic systems. This extended functionality allows for the solution of more complex problems.
nag_pde_1d_parab_remesh_keller (d03pr) is similar to nag_pde_1d_parab_dae_keller (d03pk) but allows remeshing to take place in the spatial direction. This facility can be very useful when the nature of the solution in the spatial direction varies considerably over time.
nag_pde_1d_parab_keller (d03pe), nag_pde_1d_parab_dae_keller (d03pk) or nag_pde_1d_parab_remesh_keller (d03pr) may also be used to solve systems of higher or mixed order partial differential equations which have been reduced to first-order. Note that in general these functions are unsuitable for hyperbolic first-order equations, for which an appropriate upwind discretization scheme should be used (see Convection-diffusion Systems for example).

Second-order Systems in Two Space Dimensions

There are two functions available for solving nonlinear second-order time-dependent systems in two space dimensions:
These functions are formally applicable to the general nonlinear system
F j t,x,y,u, u t , u x , u y , u x x , u x y , u y y = 0 ,  
where j=1,2,,npde, x,yΩ, t0ttout. However, they should not be used to solve purely hyperbolic systems, or time-independent problems.
nag_pde_2d_gen_order2_rectangle (d03ra) solves the nonlinear system in a rectangular domain, while nag_pde_2d_gen_order2_rectilinear (d03rb) solves in a rectilinear region, i.e., a domain bounded by perpendicular straight lines.
Both functions use the method of lines and solve the resulting system of ordinary differential equations using a backward differentiation formula (BDF) method, modified Newton method, and BiCGSTAB iterative linear solver. Local uniform grid refinement is used to improve accuracy.
Utility functions nag_pde_2d_gen_order2_checkgrid (d03ry) and nag_pde_2d_gen_order2_rectilinear_extractgrid (d03rz) may be used in conjunction with nag_pde_2d_gen_order2_rectilinear (d03rb) to check the user-supplied initial mesh, and extract mesh coordinate data.

Convection-diffusion Systems

There are three functions available for solving systems of convection-diffusion equations with optional source terms:
Equations may include nonlinear terms but the time derivative should occur linearly. There are certain restrictions on the coefficients to ensure that the problems posed can be solved by the above functions, in particular the system must be posed in conservative form (see below). The functions may also be used to solve hyperbolic convection-only systems.
Convection terms are discretized using an upwind scheme involving a numerical flux function based on the solution of a Riemann problem at each mesh point (see LeVeque (1990)); and diffusion and source terms are discretized using central differences. The resulting system of ordinary differential equations is solved using a ‘stiff’ solver. In the case of Euler equations for a perfect gas various approximate and exact Riemann solvers are provided in nag_pde_1d_parab_euler_roe (d03pu), nag_pde_1d_parab_euler_osher (d03pv), nag_pde_1d_parab_euler_hll (d03pw) and nag_pde_1d_parab_euler_exact (d03px). These functions may be used in conjunction with nag_pde_1d_parab_convdiff (d03pf), nag_pde_1d_parab_convdiff_dae (d03pl) and nag_pde_1d_parab_convdiff_remesh (d03ps).
nag_pde_1d_parab_convdiff (d03pf) is designed to solve systems of the form
j = 1 n P i j x,t,U U j t + x F i x,t,U = C i x,t,U x D i x,t,U, U x + S i x,t,U ,  
or hyperbolic convection-only systems of the form
j = 1 n P i j x,t,U U j t + F i x,t,U x = 0 ,  
where i=1,2,,n, axb, tt0.
nag_pde_1d_parab_convdiff_dae (d03pl) is similar to nag_pde_1d_parab_convdiff (d03pf) except that it provides scope for coupled differential algebraic systems. This extended functionality allows for the solution of more complex problems.
nag_pde_1d_parab_convdiff_remesh (d03ps) is similar to nag_pde_1d_parab_convdiff_dae (d03pl) but allows remeshing to take place in the spatial direction. This facility can be very useful when the nature of the solution in the spatial direction varies considerably over time.

Automatic Mesh Generation

The function nag_pde_2d_triangulate (d03ma) places a triangular mesh over a given two-dimensional region. The region may have any shape and may include holes. It may also be used in conjunction with functions from the NAG Finite Element Library. A wider range of mesh generation functions are available in Chapter D06.

Utility Functions

nag_pde_2d_ellip_fd_iter (d03ua) (nag_pde_3d_ellip_fd_iter (d03ub)) calculates, by the Strongly Implicit Procedure, an approximate correction to a current estimate of the solution of a system of simultaneous algebraic equations for which the iterative update matrix is of five (seven) point molecule form on a two- (three-) dimensional topologically-rectangular mesh.
Functions are available in the Linear Algebra Chapters for the direct and iterative solution of linear equations. Here we point to some of the functions that may be of use in solving the linear systems that arise from finite difference or finite element approximations to partial differential equation solutions. Chapters F01, F04, F07, F08 and F11 should be consulted for further information and for the appropriate function documents. Decision trees for the solution of linear systems are given in Decision Trees in the F04 Chapter Introduction.
The following functions allow the direct solution of symmetric positive definite systems:
Band nag_lapack_dpbtrf (f07hd) and nag_lapack_dpbtrs (f07he)
Variable band (skyline) nag_matop_real_vband_posdef_fac (f01mc) and nag_linsys_real_posdef_vband_solve (f04mc)
Tridiagonal nag_lapack_dptsv (f07ja), nag_lapack_dpttrf (f07jd) and nag_lapack_dpttrs (f07je)
Sparse f11ja* and nag_sparse_real_symm_precon_ichol_solve (f11jb)
(* the description of nag_sparse_real_symm_precon_ichol_solve (f11jb) explains how nag_sparse_real_symm_precon_ichol (f11ja) should be called to obtain a direct method) and the following functions allow the iterative solution of symmetric positive definite and symmetric-indefinite systems:
Sparse nag_sparse_real_symm_basic_setup (f11gd), nag_sparse_real_symm_basic_solver (f11ge), nag_sparse_real_symm_basic_diag (f11gf), nag_sparse_real_symm_precon_ichol (f11ja), nag_sparse_real_symm_solve_ichol (f11jc) and nag_sparse_real_symm_solve_jacssor (f11je).
The latter two functions above are black box functions which include Incomplete Cholesky, SSOR or Jacobi preconditioning.
The following functions allow the direct solution of nonsymmetric systems:
Band nag_lapack_dgbtrf (f07bd) and nag_lapack_dgbtrs (f07be)
Almost block-diagonal nag_matop_real_gen_blkdiag_lu (f01lh) and nag_linsys_real_blkdiag_fac_solve (f04lh)
Tridiagonal nag_matop_real_gen_tridiag_lu (f01le), nag_linsys_real_tridiag_fac_solve (f04le) or nag_lapack_dgtsv (f07ca)
Sparse nag_matop_real_gen_sparse_lu (f01br) (and nag_matop_real_gen_sparse_lu_reuse (f01bs)) and nag_linsys_real_sparse_fac_solve (f04ax)
and the following functions allow the iterative solution of nonsymmetric systems:
Sparse nag_sparse_real_gen_basic_setup (f11bd), nag_sparse_real_gen_basic_solver (f11be), nag_sparse_real_gen_basic_diag (f11bf), nag_sparse_real_gen_precon_ilu (f11da), nag_sparse_real_gen_solve_ilu (f11dc) and nag_sparse_real_gen_solve_jacssor (f11de).
The latter two functions above are black box functions which include incomplete LU, SSOR and Jacobi preconditioning.
The functions nag_pde_1d_parab_coll_interp (d03py) and nag_pde_1d_parab_fd_interp (d03pz) use linear interpolation to compute the solution to a parabolic problem and its first derivative at the user-specified points. nag_pde_1d_parab_fd_interp (d03pz) may be used in conjunction with nag_pde_1d_parab_fd (d03pc), nag_pde_1d_parab_keller (d03pe), nag_pde_1d_parab_dae_fd (d03ph), nag_pde_1d_parab_dae_keller (d03pk), nag_pde_1d_parab_remesh_fd (d03pp) and nag_pde_1d_parab_remesh_keller (d03pr). nag_pde_1d_parab_coll_interp (d03py) may be used in conjunction with nag_pde_1d_parab_coll (d03pd) and nag_pde_1d_parab_dae_coll (d03pj).
nag_pde_2d_gen_order2_checkgrid (d03ry) and nag_pde_2d_gen_order2_rectilinear_extractgrid (d03rz) are utility functions for use in conjunction with nag_pde_2d_gen_order2_rectilinear (d03rb). They can be called to check the user-specified initial mesh and to extract mesh coordinate data.

Decision Trees

Tree 1

Does PDE have a time derivative?   Does PDE have second derivatives?   see Tree 4 Parabolic branch
yesyes
  no   no
Is PDE hyperbolic?   see Tree 3 Hyperbolic branch
yes
  no
1 space dimension?   Does PDE have coupled ODEs?   Is a remeshing process required?   nag_pde_1d_parab_remesh_keller (d03pr)
yesyesyes
  no   no   no
nag_pde_1d_parab_dae_keller (d03pk)
nag_pde_1d_parab_keller (d03pe)
N/A
see Tree 2 Elliptic branch

Tree 2: Elliptic branch

2 space dimensions?   Is the domain arbitrary?   nag_pde_2d_laplace (d03ea)
yesyes
  no   no
Is the domain topologically rectangular?   Do you want to use a multigrid scheme?   nag_pde_2d_ellip_mgrid (d03ed) with nag_pde_2d_ellip_discret (d03ee)
yesyes
  no   no
nag_pde_2d_ellip_fd (d03eb) or nag_pde_2d_ellip_fd_iter (d03ua)
nag_pde_2d_laplace (d03ea)
3 space dimensions?   Is the domain topologically equivalent to a brick?   Is the PDE the Helmholtz equation?   nag_pde_3d_ellip_helmholtz (d03fa)
yesyesyes
  no   no   no
nag_pde_3d_ellip_fd (d03ec) or nag_pde_3d_ellip_fd_iter (d03ub)
N/A
N/A

Tree 3: Hyperbolic branch

1 space dimension?   Does PDE have coupled ODEs?   Is a remeshing process required?   nag_pde_1d_parab_convdiff_remesh (d03ps)
yesyesyes
  no   no   no
nag_pde_1d_parab_convdiff_dae (d03pl)
nag_pde_1d_parab_convdiff (d03pf)
N/A

Tree 4: Parabolic branch

1 space dimension?   Is PDE the Black–Scholes equations?   nag_pde_1d_blackscholes_fd (d03nc) or nag_pde_1d_blackscholes_closed (d03nd)
yesyes
  no   no
Is PDE in conservative form?   Does PDE have coupled ODEs?   Is a remeshing process required?   nag_pde_1d_parab_convdiff_remesh (d03ps)
yesyesyes
  no   no   no
nag_pde_1d_parab_convdiff_dae (d03pl)
nag_pde_1d_parab_convdiff (d03pf)
see Tree 5 Branch for parabolic PDE in non-conservative form
2 space dimensions?   Is the domain rectangular?   nag_pde_2d_gen_order2_rectangle (d03ra)
yesyes
  no   no
Is the domain rectilinear?   nag_pde_2d_gen_order2_rectilinear (d03rb)
yes
  no
N/A
N/A

Tree 5: Branch for parabolic PDE in non-conservative form

Do you want to use finite differences?   Does PDE have coupled ODEs?   Is a remeshing process required?   nag_pde_1d_parab_remesh_fd (d03pp)
yesyesyes
  no   no   no
nag_pde_1d_parab_dae_fd (d03ph)
nag_pde_1d_parab_fd (d03pc)
Do you want to use Chebyshev collocation?   Does PDE have coupled ODEs?   nag_pde_1d_parab_dae_coll (d03pj)
yesyes
  no   no
nag_pde_1d_parab_coll (d03pd)
N/A

Functionality Index

Automatic mesh generation, 
    triangles over a plane domain nag_pde_2d_triangulate (d03ma)
Black–Scholes equation, 
    analytic nag_pde_1d_blackscholes_closed (d03nd)
    finite difference nag_pde_1d_blackscholes_fd (d03nc)
Convection-diffusion system(s), 
    nonlinear, 
        one space dimension, 
            using upwind difference scheme based on Riemann solvers nag_pde_1d_parab_convdiff (d03pf)
            using upwind difference scheme based on Riemann solvers, 
                with coupled differential algebraic system nag_pde_1d_parab_convdiff_dae (d03pl)
                with remeshing nag_pde_1d_parab_convdiff_remesh (d03ps)
Elliptic equations, 
    discretization on rectangular grid (seven-point two-dimensional molecule) nag_pde_2d_ellip_discret (d03ee)
    equations on rectangular grid (seven-point two-dimensional molecule) nag_pde_2d_ellip_mgrid (d03ed)
    finite difference equations (five-point two-dimensional molecule) nag_pde_2d_ellip_fd (d03eb)
    finite difference equations (seven-point three-dimensional molecule) nag_pde_3d_ellip_fd (d03ec)
    Helmholtz's equation in three dimensions nag_pde_3d_ellip_helmholtz (d03fa)
    Laplace's equation in two dimensions nag_pde_2d_laplace (d03ea)
First-order system(s), 
    nonlinear, 
        one space dimension, 
            using Keller box scheme nag_pde_1d_parab_keller (d03pe)
            using Keller box scheme, 
                with coupled differential algebraic system nag_pde_1d_parab_dae_keller (d03pk)
                with remeshing nag_pde_1d_parab_remesh_keller (d03pr)
PDEs, general system, one space variable, method of lines, 
    parabolic, 
        collocation spatial discretization, 
            coupled DAEs, comprehensive nag_pde_1d_parab_dae_coll (d03pj)
            easy-to-use nag_pde_1d_parab_coll (d03pd)
        finite differences spatial discretization, 
            coupled DAEs, comprehensive nag_pde_1d_parab_dae_fd (d03ph)
            coupled DAEs, remeshing, comprehensive nag_pde_1d_parab_remesh_fd (d03pp)
            easy-to-use nag_pde_1d_parab_fd (d03pc)
Second order system(s), 
    nonlinear, 
        two space dimensions, 
            in rectangular domain nag_pde_2d_gen_order2_rectangle (d03ra)
            in rectilinear domain nag_pde_2d_gen_order2_rectilinear (d03rb)
Utility function, 
    average values for nag_pde_1d_blackscholes_closed (d03nd) nag_pde_1d_blackscholes_means (d03ne)
    basic SIP for five-point two-dimensional molecule nag_pde_2d_ellip_fd_iter (d03ua)
    basic SIP for seven-point three-dimensional molecule nag_pde_3d_ellip_fd_iter (d03ub)
    check initial grid data for nag_pde_2d_gen_order2_rectilinear (d03rb) nag_pde_2d_gen_order2_checkgrid (d03ry)
    exact Riemann solver for Euler equations nag_pde_1d_parab_euler_exact (d03px)
    HLL Riemann solver for Euler equations nag_pde_1d_parab_euler_hll (d03pw)
    interpolation function for collocation scheme nag_pde_1d_parab_coll_interp (d03py)
    interpolation function for finite difference, 
        Keller box and upwind scheme nag_pde_1d_parab_fd_interp (d03pz)
    Osher's Riemann solver for Euler equations nag_pde_1d_parab_euler_osher (d03pv)
    return coordinates of grid points for nag_pde_2d_gen_order2_rectilinear (d03rb) nag_pde_2d_gen_order2_rectilinear_extractgrid (d03rz)
    Roe's Riemann solver for Euler equations nag_pde_1d_parab_euler_roe (d03pu)

References

Ames W F (1977) Nonlinear Partial Differential Equations in Engineering (2nd Edition) Academic Press
Berzins M (1990) Developments in the NAG Library software for parabolic equations Scientific Software Systems (eds J C Mason and M G Cox) 59–72 Chapman and Hall
Jaswon M A and Symm G T (1977) Integral Equation Methods in Potential Theory and Elastostatics Academic Press
LeVeque R J (1990) Numerical Methods for Conservation Laws Birkhäuser Verlag
Mikhlin S G and Smolitsky K L (1967) Approximate Methods for the Solution of Differential and Integral Equations Elsevier
Mitchell A R and Griffiths D F (1980) The Finite Difference Method in Partial Differential Equations Wiley
Pennington S V and Berzins M (1994) New NAG Library software for first-order partial differential equations ACM Trans. Math. Softw. 20 63–99
Richtmyer R D and Morton K W (1967) Difference Methods for Initial-value Problems (2nd Edition) Interscience
Smith G D (1985) Numerical Solution of Partial Differential Equations: Finite Difference Methods (3rd Edition) Oxford University Press
Swarztrauber P N and Sweet R A (1979) Efficient Fortran subprograms for the solution of separable elliptic partial differential equations ACM Trans. Math. Software 5 352–364
Wait R and Mitchell A R (1985) Finite Element Analysis and Application Wiley

PDF version (NAG web site, 64-bit version, 64-bit version)
Chapter Contents
Chapter Introduction
NAG Toolbox

© The Numerical Algorithms Group Ltd, Oxford, UK. 2009–2015