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: nag_pde_3d_ellip_fd (d03ec)

 Contents

    1  Purpose
    2  Syntax
    7  Accuracy
    9  Example

Purpose

nag_pde_3d_ellip_fd (d03ec) uses the Strongly Implicit Procedure to calculate the solution to a system of simultaneous algebraic equations of seven-point molecule form on a three-dimensional topologically-rectangular mesh. (‘Topological’ means that a polar grid, for example, can be used if it is equivalent to a rectangular box.)

Syntax

[t, itcoun, itused, resids, chngs, ifail] = d03ec(n1, n2, n3, a, b, c, d, e, f, g, q, t, aparam, itmax, itcoun, ndir, ixn, iyn, izn, conres, conchn, 'sda', sda)
[t, itcoun, itused, resids, chngs, ifail] = nag_pde_3d_ellip_fd(n1, n2, n3, a, b, c, d, e, f, g, q, t, aparam, itmax, itcoun, ndir, ixn, iyn, izn, conres, conchn, 'sda', sda)

Description

Given a set of simultaneous equations
Mt=q (1)
(which could be nonlinear) derived, for example, from a finite difference representation of a three-dimensional elliptic partial differential equation and its boundary conditions, the function determines the values of the dependent variable t. M is a square n1×n2×n3 by n1×n2×n3 matrix and q is a known vector of length n1×n2×n3.
The equations must be of seven-diagonal form:
aijktij,k-1+bijkti,j-1,k+cijkti-1,jk+dijktijk+eijkti+1,jk+fijkti,j+1,k+gijktij,k+1=qijk  
for i=1,2,,n1, j=1,2,,n2 and k=1,2,,n3, provided that dijk0.0.
Indeed, if dijk=0.0, then the equation is assumed to be:
tijk=qijk.  
The system is solved iteratively from a starting approximation t 1  by the formulae:
r n = q-Mtn Msn = r n t n+1 = t n +s n .  
Thus r n  is the residual of the nth approximate solution t n , and s n  is the update change vector.
The calling program supplies an initial approximation for the values of the dependent variable in the array t, the coefficients of the seven-point molecule system of equations in the arrays a, b, c, d, e, f and g, and the source terms in the array q. The function derives the residual of the latest approximate solution, and then uses the approximate LU factorization of the Strongly Implicit Procedure with the necessary acceleration argument adjustment by calling nag_pde_3d_ellip_fd_iter (d03ub) at each iteration. nag_pde_3d_ellip_fd (d03ec) combines the newly derived change with the old approximation to obtain the new approximate solution for t. The new solution is checked for convergence against the user-supplied convergence criteria, and if these have not been satisfied, the iterative cycle is repeated. Convergence is based on both the maximum absolute normalized residuals (calculated with reference to the previous approximate solution as these are calculated at the commencement of each iteration) and on the maximum absolute change made to the values of t.
Problems in topologically non-rectangular-box-shaped regions can be solved using the function by surrounding the region by a circumscribing topologically rectangular box. The equations for the nodal values external to the region of interest are set to zero (i.e., dijk=tijk=0) and the boundary conditions are incorporated into the equations for the appropriate nodes.
If there is no better initial approximation when starting the iterative cycle, one can use an array of zeros as the initial approximation.
The function can be used to solve linear elliptic equations in which case the arrays a, b, c, d, e, f, g and q remain constant and for which a single call provides the required solution. It can also be used to solve nonlinear elliptic equations, in which case some or all of these arrays may require updating during the progress of the iterations as more accurate solutions are derived. The function will then have to be called repeatedly in an outer iterative cycle. Dependent on the nonlinearity, some under-relaxation of the coefficients and/or source terms may be needed during their recalculation using the new estimates of the solution.
The function can also be used to solve each step of a time-dependent parabolic equation in three space dimensions. The solution at each time step can be expressed in terms of an elliptic equation if the Crank–Nicolson or other form of implicit time integration is used.
Neither diagonal dominance, nor positive-definiteness, of the matrix M formed from the arrays a, b, c, d, e, f and g is necessary to ensure convergence.
For problems in which the solution is not unique in the sense that an arbitrary constant can be added to the solution (for example Poisson's equation with all Neumann boundary conditions), a argument is incorporated so that the solution can be rescaled. A specified nodal value is subtracted from the whole solution t after the completion of every iteration. This keeps rounding errors to a minimum for those cases when convergence is slow. For such problems there is generally an associated compatibility condition. For the example mentioned this compatibility condition equates the total net source within the region (i.e., the source integrated over the region) with the total net outflow across the boundaries defined by the Neumann conditions (i.e., the normal derivative integrated along the whole boundary). It is very important that the algebraic equations derived to model such a problem implement accurately the compatibility condition. If they do not, a net source or sink is very likely to be represented by the set of algebraic equations and no steady-state solution of the equations exists.

References

Jacobs D A H (1972) The strongly implicit procedure for the numerical solution of parabolic and elliptic partial differential equations Note RD/L/N66/72 Central Electricity Research Laboratory
Stone H L (1968) Iterative solution of implicit approximations of multi-dimensional partial differential equations SIAM J. Numer. Anal. 5 530–558
Weinstein H G, Stone H L and Kwan T V (1969) Iterative procedure for solution of systems of parabolic and elliptic equations in three dimensions Industrial and Engineering Chemistry Fundamentals 8 281–287

Parameters

Compulsory Input Parameters

1:     n1 int64int32nag_int scalar
The number of nodes in the first coordinate direction, n1.
Constraint: n1>1.
2:     n2 int64int32nag_int scalar
The number of nodes in the second coordinate direction, n2.
Constraint: n2>1.
3:     n3 int64int32nag_int scalar
The number of nodes in the third coordinate direction, n3.
Constraint: n3>1.
4:     aldasdan3 – double array
lda, the first dimension of the array, must satisfy the constraint ldan1.
aijk must contain the coefficient of tij,k-1 in the i,j,kth equation of the system (1), for i=1,2,,n1, j=1,2,,n2 and k=1,2,,n3. The elements of a, for k=1, must be zero after incorporating the boundary conditions, since they involve nodal values from outside the box.
5:     bldasdan3 – double array
lda, the first dimension of the array, must satisfy the constraint ldan1.
bijk must contain the coefficient of ti,j-1,k in the i,j,kth equation of the system (1), for i=1,2,,n1, j=1,2,,n2 and k=1,2,,n3. The elements of b, for j=1, must be zero after incorporating the boundary conditions, since they involve nodal values from outside the box.
6:     cldasdan3 – double array
lda, the first dimension of the array, must satisfy the constraint ldan1.
cijk must contain the coefficient of ti-1,jk in the i,j,kth equation of the system (1), for i=1,2,,n1, j=1,2,,n2 and k=1,2,,n3. The elements of c, for i=1, must be zero after incorporating the boundary conditions, since they involve nodal values from outside the box.
7:     dldasdan3 – double array
lda, the first dimension of the array, must satisfy the constraint ldan1.
dijk must contain the coefficient of tijk (the ‘central’ term) in the i,j,kth equation of the system (1), for i=1,2,,n1, j=1,2,,n2 and k=1,2,,n3. The elements of d are checked to ensure that they are nonzero. If any element is found to be zero, the corresponding algebraic equation is assumed to be tijk=qijk. This feature can be used to define the equations for nodes at which, for example, Dirichlet boundary conditions are applied, or for nodes external to the problem of interest. Setting dijk=0.0 at appropriate points, and the corresponding value of qijk to the appropriate value, namely the prescribed value of tijk in the Dirichlet case, or to zero at an external point.
8:     eldasdan3 – double array
lda, the first dimension of the array, must satisfy the constraint ldan1.
eijk must contain the coefficient of ti+1,jk in the i,j,kth equation of the system (1), for i=1,2,,n1, j=1,2,,n2 and k=1,2,,n3. The elements of e, for i=n1, must be zero after incorporating the boundary conditions, since they involve nodal values from outside the box.
9:     fldasdan3 – double array
lda, the first dimension of the array, must satisfy the constraint ldan1.
fijk must contain the coefficient of ti,j+1,k in the i,j,kth equation of the system (1), , for i=1,2,,n1, j=1,2,,n2 and k=1,2,,n3. The elements of f, for j=n2, must be zero after incorporating the boundary conditions, since they involve nodal values from outside the box.
10:   gldasdan3 – double array
lda, the first dimension of the array, must satisfy the constraint ldan1.
gijk must contain the coefficient of tij,k+1 in the i,j,kth equation of the system (1), for i=1,2,,n1, j=1,2,,n2 and k=1,2,,n3. The elements of g, for k=n3, must be zero after incorporating the boundary conditions, since they involve nodal values from outside the box.
11:   qldasdan3 – double array
lda, the first dimension of the array, must satisfy the constraint ldan1.
qijk must contain qijk, for i=1,2,,n1, j=1,2,,n2 and k=1,2,,n3, i.e., the source-term values at the nodal points of the system (1).
12:   tldasdan3 – double array
lda, the first dimension of the array, must satisfy the constraint ldan1.
tijk must contain the element tijk of an approximate solution to the equations, for i=1,2,,n1, j=1,2,,n2 and k=1,2,,n3.
If no better approximation is known, an array of zeros can be used.
13:   aparam – double scalar
The iteration acceleration factor. A value of 1.0 is adequate for most typical problems. However, if convergence is slow, the value can be reduced, typically to 0.2 or 0.1. If divergence is obtained, the value can be increased, typically to 2.0, 5.0 or 10.0.
Constraint: 0.0<aparamn1-12+n2-12+n3-12/3.0.
14:   itmax int64int32nag_int scalar
The maximum number of iterations to be used by the function in seeking the solution. A reasonable value might be 20 for a problem with 3000 nodes and convergence criteria of about 10-3 of the original residual and change.
15:   itcoun int64int32nag_int scalar
On the first call of nag_pde_3d_ellip_fd (d03ec), itcoun must be set to 0. On subsequent entries, its value must be unchanged from the previous call.
16:   ndir int64int32nag_int scalar
Indicates whether or not the system of equations has a unique solution. For systems which have a unique solution, ndir must be set to any nonzero value. For systems derived from problems to which an arbitrary constant can be added to the solution, for example Poisson's equation with all Neumann boundary conditions, ndir should be set to 0 and the values of the next three arguments must be specified. For such problems the function subtracts the value of the function derived at the node (ixn, iyn, izn) from the whole solution after each iteration to reduce the possibility of large rounding errors. You must also ensure for such problems that the appropriate compatibility condition on the source terms q is satisfied. See the comments at the end of Description.
17:   ixn int64int32nag_int scalar
Is ignored unless ndir is equal to zero, in which case it must specify the first index of the nodal point at which the solution is to be set to zero. The node should not correspond to a corner node, or to a node external to the region of interest.
18:   iyn int64int32nag_int scalar
Is ignored unless ndir is equal to zero, in which case it must specify the second index of the nodal point at which the solution is to be set to zero. The node should not correspond to a corner node, or to a node external to the region of interest.
19:   izn int64int32nag_int scalar
Is ignored unless ndir is equal to zero, in which case it must specify the third index of the nodal point at which the solution is to be set to zero. The node should not correspond to a corner node, or to a node external to the region of interest.
20:   conres – double scalar
The convergence criterion to be used on the maximum absolute value of the normalized residual vector components. The latter is defined as the residual of the algebraic equation divided by the central coefficient when the latter is not equal to 0.0, and defined as the residual when the central coefficient is zero.
conres should not be less than a reasonable multiple of the machine precision.
21:   conchn – double scalar
The convergence criterion to be used on the maximum absolute value of the change made at each iteration to the elements of the array t, namely the dependent variable. conchn should not be less than a reasonable multiple of the machine accuracy multiplied by the maximum value of t attained.
Convergence is achieved when both the convergence criteria are satisfied. You can therefore set convergence on either the residual or on the change, or (as is recommended) on a requirement that both are below prescribed limits.

Optional Input Parameters

1:     sda int64int32nag_int scalar
Default: the second dimension of the arrays a, b, c, d, e, f, g, q, t. (An error is raised if these dimensions are not equal.)
The second dimension of the arrays a, b, c, d, e, f, g, q, t, wrksp1, wrksp2, wrksp3 and wrksp4.
Constraint: sdan2.

Output Parameters

1:     tldasdan3 – double array
The solution derived by the function.
2:     itcoun int64int32nag_int scalar
Its value is increased by the number of iterations used on this call (namely itused). It therefore stores the accumulated number of iterations actually used.
For subsequent calls for the same problem, i.e., with the same n1, n2 and n3 but possibly different coefficients and/or source terms, as occur with nonlinear systems or with time-dependent systems, itcoun should not be reset, i.e., it must contain the accumulated number of iterations. In this way a suitable cycling of the sequence of iteration arguments is obtained in the calls to nag_pde_3d_ellip_fd_iter (d03ub).
3:     itused int64int32nag_int scalar
The number of iterations actually used on that call.
4:     residsitmax – double array
The maximum absolute value of the residuals calculated at the ith iteration, for i=1,2,,itused. If the residual of the solution is sought you must calculate this in the function from which nag_pde_3d_ellip_fd (d03ec) is called. The sequence of values resids indicates the rate of convergence.
5:     chngsitmax – double array
The maximum absolute value of the changes made to the components of the dependent variable t at the ith iteration, for i=1,2,,itused. The sequence of values chngs indicates the rate of convergence.
6:     ifail int64int32nag_int scalar
ifail=0 unless the function detects an error (see Error Indicators and Warnings).

Error Indicators and Warnings

Note: nag_pde_3d_ellip_fd (d03ec) may return useful information for one or more of the following detected errors or warnings.
Errors or warnings detected by the function:
   ifail=1
On entry,n1<2,
orn2<2,
orn3<2.
   ifail=2
On entry,lda<n1,
orsda<n2.
   ifail=3
On entry,aparam0.0.
   ifail=4
On entry,aparam>n1-12+n2-12+n3-12/3.0.
   ifail=5
Convergence was not achieved after itmax iterations.
   ifail=-99
An unexpected error has been triggered by this routine. Please contact NAG.
   ifail=-399
Your licence key may have expired or may not have been installed correctly.
   ifail=-999
Dynamic memory allocation failed.

Accuracy

The improvement in accuracy for each iteration depends on the size of the system and on the condition of the update matrix characterised by the seven-diagonal coefficient arrays. The ultimate accuracy obtainable depends on the above factors and on the machine precision. The rate of convergence obtained with the Strongly Implicit Procedure is not always smooth because of the cyclic use of nine acceleration arguments. The convergence may become slow with very large problems. The final accuracy obtained may be judged approximately from the rate of convergence determined from the sequence of values returned in the arrays resids and chngs and the magnitude of the maximum absolute value of the change vector on the last iteration stored in chngsitused.

Further Comments

The time taken per iteration is approximately proportional to n1×n2×n3.
Convergence may not always be obtained when the problem is very large and/or the coefficients of the equations have widely disparate values. The latter case is often associated with a near ill-conditioned matrix.

Example

This example solves Laplace's equation in a rectangular box with a non-uniform grid spacing in the x, y, and z coordinate directions and with Dirichlet boundary conditions specifying the function on the surfaces of the box equal to
e1.0+x/yn2×cos2y/yn2×e-1.0-z/yn2.  
Note that this is the same problem as that solved in the example for nag_pde_3d_ellip_fd_iter (d03ub). The differences in the maximum residuals obtained at each iteration between the two test runs are explained by the fact that in nag_pde_3d_ellip_fd (d03ec) the residual at each node is normalized by dividing by the central coefficient, whereas this normalization has not been used in the example program for nag_pde_3d_ellip_fd_iter (d03ub).
function d03ec_example


fprintf('d03ec example results\n\n');

% Solve Laplace equation in a rectangular box using d03ec. 
% Diricchlet boundary conditions are given as eact soltion on boundary.

% Mesh size
n1 = int64(16);
n2 = int64(20);
n3 = int64(24);

% Allocate arrays and set up initial values.
a = zeros(n1, n2, n3);
b = a; c = a; c = a; e = a; f = a; g = a; q = a; u0 = a;
aparam = 1;
itmax = int64(100); itcoun = int64(0); ndir = int64(1);
ixn = int64(0); iyn = ixn; izn = ixn;
conres = 1e-06; conchn = 1e-06;

% Set up mesh coordinates.
delta = 12.0/double(n1*(n1-1));
for i = 1:n1    
  x(i) = delta*double(i*(i-1))/2;        
end
delta = 20.0/double(n2*(n2-1));
for i = 1:n2
  y(i) = delta*double(i*(i-1))/2;
end
delta = 30.0/double(n3*(n3-1));
for i = 1:n3
  z(i) = delta*double(i*(i-1))/2;
end

% Set up difference equation coefficients, source terms and initial
% approximation.
for k = 2:n3-1
  a(2:n1-1,2:n2-1,k) = 2/((z(k)-z(k-1))*(z(k+1)-z(k-1)));
  g(2:n1-1,2:n2-1,k) = 2/((z(k+1)-z(k))*(z(k+1)-z(k-1)));
end
for j = 2:n2-1
  b(2:n1-1,j,2:n3-1) = 2/((y(j)-y(j-1))*(y(j+1)-y(j-1)));
  f(2:n1-1,j,2:n3-1) = 2/((y(j+1)-y(j))*(y(j+1)-y(j-1)));
end
for i = 2:n1-1
  c(i,2:n2-1,2:n3-1) = 2/((x(i)-x(i-1))*(x(i+1)-x(i-1)));
  e(i,2:n2-1,2:n3-1) = 2/((x(i+1)-x(i))*(x(i+1)-x(i-1)));
end
d = - a - b - c - e - f - g;    

scale = 1/y(n2);
exact = @(x,y,z)(exp((x+1)*scale)* cos(sqrt(2)*y*scale)* exp((-z-1)*scale));
q(1,   1:n2, 1:n3) = exact(x(1), y',   z);
q(n1,  1:n2, 1:n3) = exact(x(n1),y',   z);
q(1:n1,1   , 1:n3) = exact(x',   y(1), z);
q(1:n1,n2  , 1:n3) = exact(x',   y(n2),z);
q(1:n1,1:n2, 1)    = exact(x',   y,    z(1));
q(1:n1,1:n2, n3)   = exact(x',   y,    z(n3));

[u, itcoun, itused, resids, chngs, ifail] = ...
d03ec( ...
       n1, n2, n3, a, b, c, d, e, f, g, q, u0, aparam, itmax, itcoun, ...
       ndir, ixn, iyn, izn, conres, conchn);

% Output solution statistics.
fprintf('Number of iterations  %4d\n',itused);
fprintf('Maximum residual       %8.3e\n',resids(itused));

% Plot results using slices on the (x,y)-plane.
fig1 = figure;
[xs,ys,zs] = meshgrid(y,x,z);
slice(xs,ys,zs,u,[],[],double([1 3 5 7]));
axis([y(1) y(end) x(1) x(end) 0 7]);
xlabel('x'); ylabel('y'); zlabel('z');
title('Laplace''s Equation in a rectangular box');
view(16, 14);
h = colorbar;
ylabel(h, 'U(x,y,z)')

d03ec example results

Number of iterations    12
Maximum residual       1.193e-07
d03ec_fig1.png

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