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_ode_bvp_shoot_genpar_intern (d02ag)

 Contents

    1  Purpose
    2  Syntax
    7  Accuracy
    9  Example

Purpose

nag_ode_bvp_shoot_genpar_intern (d02ag) solves a two-point boundary value problem for a system of ordinary differential equations, using initial value techniques and Newton iteration; it generalizes nag_ode_bvp_shoot_bval (d02ha) to include the case where parameters other than boundary values are to be determined.

Syntax

[h, param, c, ifail] = d02ag(h, e, parerr, param, m1, aux, bcaux, raaux, prsol, 'n', n, 'n1', n1)
[h, param, c, ifail] = nag_ode_bvp_shoot_genpar_intern(h, e, parerr, param, m1, aux, bcaux, raaux, prsol, 'n', n, 'n1', n1)

Description

nag_ode_bvp_shoot_genpar_intern (d02ag) solves a two-point boundary value problem by determining the unknown parameters p1,p2,,pn1 of the problem. These parameters may be, but need not be, boundary values (as they are in nag_ode_bvp_shoot_bval (d02ha)); they may include eigenvalue parameters in the coefficients of the differential equations, length of the range of integration, etc. The notation and methods used are similar to those of nag_ode_bvp_shoot_bval (d02ha) and you are advised to study this first. (There the parameters p1,p2,,pn1 correspond to the unknown boundary conditions.) It is assumed that we have a system of n first-order ordinary differential equations of the form
dyi dx =fix,y1,y2,,yn,  i=1,2,,n,  
and that derivatives fi are evaluated by aux. The system, including the boundary conditions given by bcaux, and the range of integration and matching point, r, given by raaux, involves the n1 unknown parameters p1,p2,,pn1 which are to be determined, and for which initial estimates must be supplied. The number of unknown parameters n1 must not exceed the number of equations n. If n1<n, we assume that n-n1 equations of the system are not involved in the matching process. These are usually referred to as ‘driving equations’; they are independent of the parameters and of the solutions of the other n1 equations. In numbering the equations for aux, the driving equations must be put last.
The estimated values of the parameters are corrected by a form of Newton iteration. The Newton correction on each iteration is calculated using a matrix whose i,jth element depends on the derivative of the ith component of the solution, yi, with respect to the jth parameter, pj. This matrix is calculated by a simple numerical differentiation technique which requires n1 evaluations of the differential system.

References

None.

Parameters

You are strongly recommended to read Description and Further Comments in conjunction with this section.

Compulsory Input Parameters

1:     h – double scalar
h must be set to an estimate of the step size, h, needed for integration.
2:     en – double array
ei must be set to a small quantity to control the ith solution component. The element ei is used:
(i) in the bound on the local error in the ith component of the solution yi during integration,
(ii) in the convergence test on the ith component of the solution yi at the matching point in the Newton iteration.
The elements ei should not be chosen too small. They should usually be several orders of magnitude larger than machine precision.
3:     parerrn1 – double array
parerri must be set to a small quantity to control the ith parameter component. The element parerri is used:
(i) in the convergence test on the ith parameter in the Newton iteration,
(ii) in perturbing the ith parameter when approximating the derivatives of the components of the solution with respect to the ith parameter, for use in the Newton iteration.
The elements parerri should not be chosen too small. They should usually be several orders of magnitude larger than machine precision.
4:     paramn1 – double array
parami must be set to an estimate for the ith parameter, pi, for i=1,2,,n1.
5:     m1 int64int32nag_int scalar
Determines whether or not the final solution is computed as well as the parameter values.
m1=1
The final solution is not calculated;
m1>1
The final values of the solution at interval (length of range)/m1-1 are calculated and stored sequentially in the array c starting with the values of yi evaluated at the first end point (see raaux) stored in c1i.
6:     aux – function handle or string containing name of m-file
aux must evaluate the functions fi (i.e., the derivatives yi) for given values of its arguments, x,y1,,yn, p1,,pn1.
[f] = aux(y, x, param)

Input Parameters

1:     y: – double array
yi, for i=1,2,,n, the value of the argument.
2:     x – double scalar
x, the value of the argument.
3:     param: – double array
pi, for i=1,2,,n1, the value of the parameters.

Output Parameters

1:     f: – double array
The value of fi, for i=1,2,,n.
7:     bcaux – function handle or string containing name of m-file
bcaux must evaluate the values of yi at the end points of the range given the values of p1,,pn1.
[g0, g1] = bcaux(param)

Input Parameters

1:     param: – double array
pi, for i=1,2,,n, the value of the parameters.

Output Parameters

1:     g0: – double array
The values yi, for i=1,2,,n, at the boundary point x0 (see raaux).
2:     g1: – double array
The values yi, for i=1,2,,n, at the boundary point x1 (see raaux).
8:     raaux – function handle or string containing name of m-file
raaux must evaluate the end points, x0 and x1, of the range and the matching point, r, given the values p1,p2,,pn1.
[x0, x1, r] = raaux(param)

Input Parameters

1:     param: – double array
pi, for i=1,2,,n1, the value of the parameters.

Output Parameters

1:     x0 – double scalar
Must contain the left-hand end of the range, x0.
2:     x1 – double scalar
Must contain the right-hand end of the range x1.
3:     r – double scalar
Must contain the matching point, r.
9:     prsol – function handle or string containing name of m-file
prsol is called at each iteration of the Newton method and can be used to print the current values of the parameters pi, for i=1,2,,n1, their errors, ei, and the sum of squares of the errors at the matching point, r.
prsol(param, res, n1, err)

Input Parameters

1:     paramn1 – double array
pi, for i=1,2,,n1, the current value of the parameters.
2:     res – double scalar
The sum of squares of the errors in the arguments, i=1n1ei2.
3:     n1 int64int32nag_int scalar
n1, the number of parameters.
4:     errn1 – double array
The errors in the parameters, ei, for i=1,2,,n1.

Optional Input Parameters

1:     n int64int32nag_int scalar
Default: the dimension of the array e.
n, the total number of differential equations.
2:     n1 int64int32nag_int scalar
Default: the dimension of the arrays parerr, param. (An error is raised if these dimensions are not equal.)
n1, the number of parameters.
If n1<n, the last n-n1 differential equations (in aux) are driving equations (see Description).
Constraint: n1n.

Output Parameters

1:     h – double scalar
The last step length used.
2:     paramn1 – double array
The corrected value for the ith parameter, unless an error has occurred, when it contains the last calculated value of the parameter (possibly perturbed by parerri×1+parami if the error occurred when calculating the approximate derivatives).
3:     cm1n – double array
The solution when m1>1 (see m1).
If m1=1, the elements of c are not used.
4:     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:
   ifail=1
This indicates that n1>n on entry, that is the number of parameters is greater than the number of differential equations.
   ifail=2
As for ifail=4 except that the integration failed while calculating the matrix for use in the Newton iteration.
   ifail=3
The current matching point r does not lie between the current end points x0 and x1. If the values x0, x1 and r depend on the parameters pi, this may occur at any time in the Newton iteration if care is not taken to avoid it when coding raaux.
   ifail=4
The step length for integration h has halved more than 13 times (or too many steps were needed to reach the end of the range of integration) in attempting to control the local truncation error whilst integrating to obtain the solution corresponding to the current values pi. If, on failure, h has the sign of r-x0 then failure has occurred whilst integrating from x0 to r, otherwise it has occurred whilst integrating from x1 to r.
   ifail=5
The matrix of the equations to be solved for corrections to the variable parameters in the Newton method is singular (as determined by nag_lapack_dgetrf (f07ad)).
   ifail=6
A satisfactory correction to the parameters was not obtained on the last Newton iteration employed. A Newton iteration is deemed to be unsatisfactory if the sum of the squares of the residuals (which can be printed using prsol) has not been reduced after three iterations using a new Newton correction.
   ifail=7
Convergence has not been obtained after 12 satisfactory iterations of the Newton method.
   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.
A further discussion of these errors and the steps which might be taken to correct them is given in Further Comments.

Accuracy

If the process converges, the accuracy to which the unknown parameters are determined is usually close to that specified by you; and the solution, if requested, is usually determined to the accuracy specified.

Further Comments

The time taken by nag_ode_bvp_shoot_genpar_intern (d02ag) depends on the complexity of the system, and on the number of iterations required. In practice, integration of the differential equations is by far the most costly process involved.
There may be particular difficulty in integrating the differential equations in one direction (indicated by ifail=2 or 4). The value of r should be adjusted to avoid such difficulties.
If the matching point r is at one of the end points x0 or x1 and some of the parameters are used only to determine the boundary values at this point, then good initial estimates for these parameters are not required, since they are completely determined by the function (for example, see p2 in EX1 of Example).
Wherever they occur in the procedure, the error parameters contained in the arrays e and parerr are used in ‘mixed’ form; that is ei always occurs in expressions of the form ei×1+yi, and parerri always occurs in expressions of the form parerri×1+pi. Though not ideal for every application, it is expected that this mixture of absolute and relative error testing will be adequate for most purposes.
Note that convergence is not guaranteed. You are strongly advised to provide an output prsol, as shown in EX1 of Example, in order to monitor the progress of the iteration. Failure of the Newton iteration to converge (see ifail=6 or 7) usually results from poor starting approximations to the parameters, though occasionally such failures occur because the elements of one or both of the arrays parerr or e are too small. (It should be possible to distinguish these cases by studying the output from prsol.) Poor starting approximations can also result in the failure described under ifail=4 and 5 in Error Indicators and Warnings (especially if these errors occur after some Newton iterations have been completed, that is, after two or more calls of prsol). More frequently, a singular matrix in the Newton method (monitored as ifail=5) occurs because the mathematical problem has been posed incorrectly. The case ifail=4 usually occurs because h or r has been poorly estimated, so these values should be checked first. If ifail=2 is monitored, the solution y1,y2,,yn is sensitive to perturbations in the parameters pi. Reduce the size of one or more values parerri to reduce the perturbations. Since only one value pi is perturbed at any time when forming the matrix, the perturbation which is too large can be located by studying the final output from prsol and the values of the parameters returned by nag_ode_bvp_shoot_genpar_intern (d02ag). If this change leads to other types of failure improve the initial values of pi by other means.
The computing time for integrating the differential equations can sometimes depend critically on the quality of the initial estimates for the parameters pi. If it seems that too much computing time is required and, in particular, if the values erri (available on each call of prsol) are much larger than the expected values of the solution at the matching point r, then the coding of aux, bcaux and raaux should be checked for errors. If no errors can be found, an independent attempt should be made to improve the initial estimates for parami.
The function can be used to solve a very wide range of problems, for example:
(a) eigenvalue problems, including problems where the eigenvalue occurs in the boundary conditions;
(b) problems where the differential equations depend on some parameters which are to be determined so as to satisfy certain boundary conditions (see EX1 in Example);
(c) problems where one of the end points of the range of integration is to be determined as the point where a variable yi takes a particular value (see EX2 in Example);
(d) singular problems and problems on infinite ranges of integration where the values of the solution at x0 or x1 or both are determined by a power series or an asymptotic expansion (or a more complicated expression) and where some of the coefficients in the expression are to be determined (see EX1 in Example); and
(e) differential equations with certain terms defined by other independent (driving) differential equations.

Example

For this function two examples are presented. There is a single example program for nag_ode_bvp_shoot_genpar_intern (d02ag), with a main program and the code to solve the two example problems given in Example 1 (EX1) and Example 2 (EX2).
Example 1 (EX1)
This example finds the solution of the differential equation
y=y3-y 2x  
on the range 0x16, with boundary conditions y0=0.1 and y16=1/6.
We cannot use the differential equation at x=0 because it is singular, so we take the truncated series expansion
yx=110+p1x10+x100  
near the origin (which is correct to the number of terms given in this case). Here p1 is one of the parameters to be determined. We choose the range as 0.1,16 and setting p2=y16, we can determine all the boundary conditions. We take the matching point to be 16, the end of the range, and so a good initial guess for p2 is not necessary. We write y=y1, y=y2, and estimate p1=param1=0.2, p2=param2=0.0.
Example 2 (EX2)
This example finds the gravitational constant p1 and the range p2 over which a projectile must be fired to hit the target with a given velocity. The differential equations are
y=tanϕ v= -p1sinϕ+0.00002v2 vcosϕ ϕ=-p1v2k  
on the range 0<x<p2 with boundary conditions
y=0, v=500, ϕ=0.5 at x=0 y=0, v=450, ϕ=p3 at x=p2.  
We write y=y1, v=y2, ϕ=y3, and we take the matching point r=p2. We estimate p1=param1=32, p2=param2=6000 and p3=param3=0.54 (though this estimate is not important).
function d02ag_example


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

% For communication with prsol.
global iprint;

% Set up initial values before calling NAG routine for the first time.
h = 0.1;
e = [0.0001; 0.0001];
parerr = [1e-05; 0.001];
param = [0.2; 0];
m1 = 6;
n = 2;
marray = zeros(1,m1);

% First example - parameterized two-point boundary-value problem.
fprintf('Case 1 \n\n');

% Set iprint to 1 to obtain output from prsol at each iteration.
iprint = 0;

[h, param, c, ifail] = ...
d02ag(...
       h, e, parerr, param, int64(m1), @aux1, @bcaux1, @raaux1, @prsol);

% Output results.
fprintf('Final parameters \n');
disp(sprintf('   %10.2e',param));
fprintf('\n Final solution \n');
fprintf('   X-value      Components of solution\n');

% Call the aux routine to evaluate the derivatives.
[x0, x1, r] = raaux1(param);

% h is steplength for which derivatives were evaluated.
h = (x1-x0)/double(m1-1);
for i = 1:m1;
  m = x0 + double(i-1)*h;
  fprintf('%8.2f    ',m);
  fprintf('%14.4e',c(i,1:n));
  fprintf('\n');
  % Store the m values so they can be plotted.
  marray(i) = m;
end

% Second example - find gravitational constant and range given
% projectile terminal velocity.
fprintf('\n\n Case 2 \n\n');

% Set iprint to 1 to obtain output from prsol at each iteration.
iprint = 0;

h = 10.0;
param = [32.0; 6000.0; 0.54];
parerr = [1.0e-5; 1.0e-4; 1.0e-4];
e = [1.0e-2; 1.0e-2; 1.0e-2];
n = 3;
m1 = 6;
qarray = zeros(1,m1);

[h, param, c1, ifail] = ...
d02ag( ...
       h, e, parerr, param, int64(m1), @aux2, @bcaux2, @raaux2, @prsol);

% Output results.
fprintf('Final parameters\n');
fprintf('   %10.2e',param);
fprintf('\n\nFinal solution\n');
fprintf('   X-value      Components of solution\n');

% Call the aux routine to evaluate the derivatives.
[x0, x1, r] = raaux2(param);

% h is steplength for which derivatives were evaluated.
h = (x1-x0)/double(m1-1);
for i = 1:m1;
  q = x0 + double(i-1)*h;
  fprintf('%8.0f    ',q);
  fprintf('%14.4e',c1(i,1:n));
  fprintf('\n');
  % Store the q values so they can be used for plotting.
  qarray(i) = q;
end

% Plot results.
fig1 = figure;
display_plot(marray, c, 'Solution and Derivative');
fig2 = figure;
display_plot(qarray, c1, 'Height and Velocity');


function [f] = aux1(y,x,param)
  % Evaluate the derivatives (case 1).
  f(1) = y(2);
  f(2) = (y(1)^3-y(2))/(2.0*x);

function [g0,g1] = bcaux1(param)
  % Evaluate the derivatives at the end-points (case 1).
  z = 0.1;
  g0(1) = 0.1 + param(1)*sqrt(z)*0.1 + 0.01*z;
  g0(2) = param(1)*0.05/sqrt(z) + 0.01;
  g1(1) = 1.0/6.0;
  g1(2) = param(2);

function [] = prsol(param, resid, n, err)
  % For communication with main routine.
  global iprint;
  if iprint == 1
    fprintf('Current parameters: ');
    fprintf('%15.6e ', param(1:n));
    fprintf('\nResiduals: ');
    fprintf('%13.6e ', err(1:n));
    fprintf('\nSum of residuals squared = %13.6e\n', resid);
  end

function [x0, x1, r] = raaux1(param)
  % Evaluate the end-points (case 1).
  x0 = 0.1;
  x1 = 16;
  r  = 16;

function [f] = aux2(y,x,param)
  % Evaluate the derivatives (case 2).
  c = cos(y(3));
  s = sin(y(3));
  f(1) = s/c;
  f(2) = -(param(1)*s+0.00002*y(2)*y(2))/(y(2)*c);
  f(3) = -param(1)/(y(2)*y(2));
  
function [g0,g1] = bcaux2(param)
  % Evaluate the derivatives at the end-points (case 2).
  g0(1) = 0;
  g0(2) = 500;
  g0(3) = 0.5;
  g1(1) = 0;
  g1(2) = 450;
  g1(3) = param(3);

function [x0, x1, r] = raaux2(param)
  % Evaluate the end-points (case 2).
  x0 = double(0);
  x1 = param(2);
  r  = param(2);

function display_plot(data, index, ylabelString)
  % Choose the type of plot based on y axis label.
  if strncmp(ylabelString, 'Solution', 8)
    % Plot the results as a linear graph.
    plot(data,index(:,1),'-+',data,index(:,2),'--x');
    % Set the axis limits and the tick specifications to beautify the plot.
    set(gca, 'XLim', [0 16]);
    set(gca, 'XTick', [0 4 8 12 16]);
    % Set the title.
    title('Parameterized Two-point Boundary-value Problem');
    % Label the axes.
    xlabel('x');
    ylabel(ylabelString);
    % Add a legend.
    legend('solution y(x)','derivative y''(x)','Location','Best');
  else
    % Plot the results as a linear graph (2 y axes).
    [haxes, hline1, hline2] = plotyy(data,index(:,1),data,index(:,3));
    hold on
    % Add a third curve.
    hline3 = plot(data,index(:,2));
    % Set the axis limits and the tick specifications to beautify the plot.
    set(haxes(1), 'YLim', [0 850]);
    set(haxes(1), 'YMinorTick', 'on');
    set(haxes(1), 'YTick', [0 200 400 600 800]);
    set(haxes(2), 'YLim', [-1 1]);
    set(haxes(2), 'YMinorTick', 'on');
    set(haxes(2), 'YTick', [-1 -0.5 0 0.5 1]);
    for iaxis = 1:2
        % These properties must be the same for both sets of axes.
        set(haxes(iaxis), 'XLim', [0 6000]);
        set(haxes(iaxis), 'XTick', [0 1000 2000 3000 4000 5000 6000]);
    end
    set(gca, 'box', 'off'); % no ticks on opposite axes.
    % Set the title.
    title(['Range from Projectile Terminal Velocity']);
    % Label the axes.
    xlabel('x');
    ylabel(haxes(1),ylabelString);
    ylabel(haxes(2),'Angle');
    % Add a legend.
    legend('angle','height','velocity','Location','Best');
    % Set some features of the three lines.
    set(hline1, 'Linewidth', 0.5, 'Marker', '+', 'LineStyle', '-');
    set(hline2, 'Linewidth', 0.5, 'Marker', '*', 'LineStyle', '-');
    set(hline3, 'Linewidth', 0.5, 'Marker', 'x', 'LineStyle', '--', ...
        'Color', 'Magenta');
  end
d02ag example results

Case 1 

Final parameters 
     4.64e-02     3.49e-03

 Final solution 
   X-value      Components of solution
    0.10        1.0247e-01    1.7341e-02
    3.28        1.2170e-01    4.1796e-03
    6.46        1.3382e-01    3.5764e-03
    9.64        1.4488e-01    3.4178e-03
   12.82        1.5572e-01    3.4142e-03
   16.00        1.6667e-01    3.4943e-03


 Case 2 

Final parameters
     3.24e+01     5.96e+03    -5.35e-01

Final solution
   X-value      Components of solution
       0        0.0000e+00    5.0000e+02    5.0000e-01
    1193        5.2981e+02    4.5156e+02    3.2807e-01
    2385        8.0765e+02    4.2030e+02    1.2315e-01
    3578        8.2080e+02    4.0944e+02   -1.0316e-01
    4771        5.5625e+02    4.2001e+02   -3.2958e-01
    5963        0.0000e+00    4.5000e+02   -5.3523e-01
d02ag_fig1.png
d02ag_fig2.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