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_helmholtz (d03fa)

 Contents

    1  Purpose
    2  Syntax
    7  Accuracy
    9  Example

Purpose

nag_pde_3d_ellip_helmholtz (d03fa) solves the Helmholtz equation in Cartesian coordinates in three dimensions using the standard seven-point finite difference approximation. This function is designed to be particularly efficient on vector processors.

Syntax

[f, pertrb, ifail] = d03fa(xs, xf, l, lbdcnd, bdxs, bdxf, ys, yf, m, mbdcnd, bdys, bdyf, zs, zf, n, nbdcnd, bdzs, bdzf, lambda, f, 'lwrk', lwrk)
[f, pertrb, ifail] = nag_pde_3d_ellip_helmholtz(xs, xf, l, lbdcnd, bdxs, bdxf, ys, yf, m, mbdcnd, bdys, bdyf, zs, zf, n, nbdcnd, bdzs, bdzf, lambda, f, 'lwrk', lwrk)
Note: the interface to this routine has changed since earlier releases of the toolbox:
At Mark 23: lwrk was added as an optional parameter

Description

nag_pde_3d_ellip_helmholtz (d03fa) solves the three-dimensional Helmholtz equation in Cartesian coordinates:
2u x2 + 2u y2 + 2u z2 +λu=fx,y,z.  
This function forms the system of linear equations resulting from the standard seven-point finite difference equations, and then solves the system using a method based on the fast Fourier transform (FFT) described by Swarztrauber (1984). This function is based on the function HW3CRT from FISHPACK (see Swarztrauber and Sweet (1979)).
More precisely, the function replaces all the second derivatives by second-order central difference approximations, resulting in a block tridiagonal system of linear equations. The equations are modified to allow for the prescribed boundary conditions. Either the solution or the derivative of the solution may be specified on any of the boundaries, or the solution may be specified to be periodic in any of the three dimensions. By taking the discrete Fourier transform in the x- and y-directions, the equations are reduced to sets of tridiagonal systems of equations. The Fourier transforms required are computed using the multiple FFT functions found in Chapter C06.

References

Swarztrauber P N (1984) Fast Poisson solvers Studies in Numerical Analysis (ed G H Golub) Mathematical Association of America
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

Parameters

Compulsory Input Parameters

1:     xs – double scalar
The lower bound of the range of x, i.e., xsxxf.
Constraint: xs<xf.
2:     xf – double scalar
The upper bound of the range of x, i.e., xsxxf.
Constraint: xs<xf.
3:     l int64int32nag_int scalar
The number of panels into which the interval (xs,xf) is subdivided. Hence, there will be l+1 grid points in the x-direction given by xi=xs+i-1×δx, for i=1,2,,l+1, where δx=xf-xs/l is the panel width.
Constraint: l5.
4:     lbdcnd int64int32nag_int scalar
Indicates the type of boundary conditions at x=xs and x=xf.
lbdcnd=0
If the solution is periodic in x, i.e., uxs,y,z=uxf,y,z.
lbdcnd=1
If the solution is specified at x=xs and x=xf.
lbdcnd=2
If the solution is specified at x=xs and the derivative of the solution with respect to x is specified at x=xf.
lbdcnd=3
If the derivative of the solution with respect to x is specified at x=xs and x=xf.
lbdcnd=4
If the derivative of the solution with respect to x is specified at x=xs and the solution is specified at x=xf.
Constraint: 0lbdcnd4.
5:     bdxsldf2n+1 – double array
ldf2, the first dimension of the array, must satisfy the constraint ldf2m+1.
The values of the derivative of the solution with respect to x at x=xs. When lbdcnd=3 or 4, bdxsjk=uxxs,yj,zk, for j=1,2,,m+1 and k=1,2,,n+1.
When lbdcnd has any other value, bdxs is not referenced.
6:     bdxfldf2n+1 – double array
ldf2, the first dimension of the array, must satisfy the constraint ldf2m+1.
The values of the derivative of the solution with respect to x at x=xf. When lbdcnd=2 or 3, bdxfjk=uxxf,yj,zk, for j=1,2,,m+1 and k=1,2,,n+1.
When lbdcnd has any other value, bdxf is not referenced.
7:     ys – double scalar
The lower bound of the range of y, i.e., ysyyf.
Constraint: ys<yf.
8:     yf – double scalar
The upper bound of the range of y, i.e., ysyyf.
Constraint: ys<yf.
9:     m int64int32nag_int scalar
The number of panels into which the interval (ys,yf) is subdivided. Hence, there will be m+1 grid points in the y-direction given by yj=ys+j-1×δy, for j=1,2,,m+1, where δy=yf-ys/m is the panel width.
Constraint: m5.
10:   mbdcnd int64int32nag_int scalar
Indicates the type of boundary conditions at y=ys and y=yf.
mbdcnd=0
If the solution is periodic in y, i.e., ux,yf,z=ux,ys,z.
mbdcnd=1
If the solution is specified at y=ys and y=yf.
mbdcnd=2
If the solution is specified at y=ys and the derivative of the solution with respect to y is specified at y=yf.
mbdcnd=3
If the derivative of the solution with respect to y is specified at y=ys and y=yf.
mbdcnd=4
If the derivative of the solution with respect to y is specified at y=ys and the solution is specified at y=yf.
Constraint: 0mbdcnd4.
11:   bdysldfn+1 – double array
ldf, the first dimension of the array, must satisfy the constraint ldfl+1.
The values of the derivative of the solution with respect to y at y=ys. When mbdcnd=3 or 4, bdysik=uyxi,ys,zk, for i=1,2,,l+1 and k=1,2,,n+1.
When mbdcnd has any other value, bdys is not referenced.
12:   bdyfldfn+1 – double array
ldf, the first dimension of the array, must satisfy the constraint ldfl+1.
The values of the derivative of the solution with respect to y at y=yf. When mbdcnd=2 or 3, bdyfik=uyxi,yf,zk, for i=1,2,,l+1 and k=1,2,,n+1.
When mbdcnd has any other value, bdyf is not referenced.
13:   zs – double scalar
The lower bound of the range of z, i.e., zszzf.
Constraint: zs<zf.
14:   zf – double scalar
The upper bound of the range of z, i.e., zszzf.
Constraint: zs<zf.
15:   n int64int32nag_int scalar
The number of panels into which the interval (zs,zf) is subdivided. Hence, there will be n+1 grid points in the z-direction given by zk=zs+k-1×δz, for k=1,2,,n+1, where δz=zf-zs/n is the panel width.
Constraint: n5.
16:   nbdcnd int64int32nag_int scalar
Specifies the type of boundary conditions at z=zs and z=zf.
nbdcnd=0
if the solution is periodic in z, i.e., ux,y,zf=ux,y,zs.
nbdcnd=1
if the solution is specified at z=zs and z=zf.
nbdcnd=2
if the solution is specified at z=zs and the derivative of the solution with respect to z is specified at z=zf.
nbdcnd=3
if the derivative of the solution with respect to z is specified at z=zs and z=zf.
nbdcnd=4
if the derivative of the solution with respect to z is specified at z=zs and the solution is specified at z=zf.
Constraint: 0nbdcnd4.
17:   bdzsldfm+1 – double array
ldf, the first dimension of the array, must satisfy the constraint ldfl+1.
The values of the derivative of the solution with respect to z at z=zs. When nbdcnd=3 or 4, bdzsij=uzxi,yj,zs, for i=1,2,,l+1 and j=1,2,,m+1.
When nbdcnd has any other value, bdzs is not referenced.
18:   bdzfldfm+1 – double array
ldf, the first dimension of the array, must satisfy the constraint ldfl+1.
The values of the derivative of the solution with respect to z at z=zf. When nbdcnd=2 or 3, bdzfij=uzxi,yj,zf, for i=1,2,,l+1 and j=1,2,,m+1.
When nbdcnd has any other value, bdzf is not referenced.
19:   lambda – double scalar
The constant λ in the Helmholtz equation. For certain positive values of λ a solution to the differential equation may not exist, and close to these values the solution of the discretized problem will be extremely ill-conditioned. If λ>0, then nag_pde_3d_ellip_helmholtz (d03fa) will set ifail=3, but will still attempt to find a solution. However, since in general the values of λ for which no solution exists cannot be predicted a priori, you are advised to treat any results computed with λ>0 with great caution.
20:   fldfldf2n+1 – double array
ldf, the first dimension of the array, must satisfy the constraint ldfl+1.
The values of the right-side of the Helmholtz equation and boundary values (if any).
fijk = fxi,yj,zki=2,3,,l, j=2,3,,m ​ and ​ k=2,3,,n.  
On the boundaries f is defined by
lbdcnd f1jk fl+1jk
0 fxs,yj,zk fxs,yj,zk  
1 uxs,yj,zk uxf,yj,zk
2 uxs,yj,zk fxf,yj,zk j=1,2,,m+1
3 fxs,yj,zk fxf,yj,zk k=1,2,,n+1
4 fxs,yj,zk uxf,yj,zk
       
mbdcnd fi1k fim+1k
0 fxi,ys,zk fxi,ys,zk
1 uys,xi,zk uyf,xi,zk
2 uxi,ys,zk fxi,yf,zk i=1,2,,l+1
3 fxi,ys,zk fxi,yf,zk k=1,2,,n+1
4 fxi,ys,zk uxi,yf,zk
       
nbdcnd fij1 fijn+1
0 fxi,yj,zs fxi,yj,zs
1 uxi,yj,zs uxi,yj,zf
2 uxi,yj,zs fxi,yj,zf i=1,2,,l+1
3 fxi,yj,zs fxi,yj,zf j=1,2,,m+1
4 fxi,yj,zs uxi,yj,zf
Note: if the table calls for both the solution u and the right-hand side f on a boundary, then the solution must be specified.

Optional Input Parameters

1:     lwrk int64int32nag_int scalar
Default: 2×n+1×maxl,m+3×l+3×m+4×n+6
The dimension of the array w. 2×n+1×maxl,m+3×l+3×m+4×n+6 is an upper bound on the required size of w. If lwrk is too small, the function exits with ifail=2, and if on entry ifail=0 or -1, a message is output giving the exact value of lwrk required to solve the current problem.

Output Parameters

1:     fldfldf2n+1 – double array
ldf2=m+1.
Contains the solution ui,j,k of the finite difference approximation for the grid point xi,yj,zk, for i=1,2,,l+1, j=1,2,,m+1 and k=1,2,,n+1.
2:     pertrb – double scalar
pertrb=0, unless a solution to Poisson's equation λ=0 is required with a combination of periodic or derivative boundary conditions (lbdcnd, mbdcnd and nbdcnd=0 or 3). In this case a solution may not exist. pertrb is a constant, calculated and subtracted from the array f, which ensures that a solution exists. nag_pde_3d_ellip_helmholtz (d03fa) then computes this solution, which is a least squares solution to the original approximation. This solution is not unique and is unnormalized. The value of pertrb should be small compared to the right-hand side f, otherwise a solution has been obtained to an essentially different problem. This comparison should always be made to ensure that a meaningful solution has been obtained.
3:     ifail int64int32nag_int scalar
ifail=0 unless the function detects an error (see Error Indicators and Warnings).

Error Indicators and Warnings

Errors or warnings detected by the function:

Cases prefixed with W are classified as warnings and do not generate an error of type NAG:error_n. See nag_issue_warnings.

   ifail=1
On entry,xsxf,
orl<5,
orlbdcnd<0,
orlbdcnd>4,
orysyf,
orm<5,
ormbdcnd<0,
ormbdcnd>4,
orzszf,
orn<5,
ornbdcnd<0,
ornbdcnd>4,
orldf<l+1,
orldf2<m+1.
   ifail=2
On entry,lwrk is too small.
W  ifail=3
On entry,λ>0.
   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

Not applicable.

Further Comments

The execution time is roughly proportional to l×m×n× log2l + log2m +5 , but also depends on input arguments lbdcnd and mbdcnd.

Example

This example solves the Helmholz equation
2u x2 + 2u y2 + 2u z2 +λ u=fx,y,z  
for x,y,z0,1×0,2π×0,π2, where λ=-2, and fx,y,z is derived from the exact solution
ux,y,z=x4sinycosz.  
The equation is subject to the following boundary conditions, again derived from the exact solution given above.
function d03fa_example


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

xs = 0; xf = 1;    l = 16;
ys = 0; yf = 2*pi; m = 32;
zs = 0; zf = pi/2; n = 20;

bdxs = zeros(m+1, n+1); bdxf = zeros(m+1, n+1);
bdys = zeros(l+1, n+1); bdyf = zeros(l+1, n+1);
bdzs = zeros(l+1, m+1); bdzf = zeros(l+1, m+1);

lbdcnd = int64(1); 
mbdcnd = int64(0); 
nbdcnd = int64(2); 
lambda = -2;

% Define the grid points for later use.
dx = (xf-xs)/l;  x  = [xs:dx:xf];
dy = (yf-ys)/m;  y  = [ys:dy:yf];
dz = (zf-zs)/n;  z  = [zs:dz:zf];

% Define the array of derivative boundary values (z only here).
XY = [x.^4]'*sin(y);
bdzf = -XY;

% Define the f array including boundary conditions.
YZ = [sin(y)]'*cos(z);
for i = 1:l
  f(i,:,:) = (4*x(i)^2*(3-x(i)^2))*YZ;
  g(i,:,:) = x(i)^4*YZ;
end
g(l+1,:,:) = YZ;
f(1,:,:)   = 0;
f(l+1,:,:) = YZ;
f(:,:,1)   = XY;

[u, pertrb, ifail] = d03fa( ...
                            xs, xf, int64(l), lbdcnd, bdxs, bdxf, ...
                            ys, yf, int64(m), mbdcnd, bdys, bdyf, ...
                            zs, zf, int64(n), nbdcnd, bdzs, bdzf, lambda, f);
% calculate error
maxerr   = max(max(max(abs(u - g))));
fprintf('Maximum error in computed solution = %10.3e\n',maxerr);

fig1 = figure;
[xs,ys,zs] = meshgrid(y,x,z);
slice(xs,ys,zs,u,[1.8 5],[0.95],[0.78]);
axis([y(1) y(end) x(1) x(end) 0 2]);
xlabel('y'); ylabel('x'); zlabel('z');
title('Helholtz Equation solution in a box');
view(111, 26);
h = colorbar;
ylabel(h, 'u(x,y,z)')

d03fa example results

Maximum error in computed solution =  5.177e-04
d03fa_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