Return to Article Details On the numerical Picard iterations with collocations for the initial value problem

On the numerical Picard iterations with collocations for the Initial Value Problem

Ernest Scheiber

January 21, 2018. Accepted: June 17, 2019. Published online: October 10, 2019.

e-mail: scheiber@unitbv.ro.

Some variants of the numerical Picard iterations method are presented to solve an IVP for an ordinary differential system. The term numerical emphasizes that a numerical solution is computed. The method consists in replacing the right hand side of the differential system by Lagrange interpolation polynomials followed by successive approximations. In the case when the number of interpolation point is fixed a convergence result is given. For stiff problems, starting from a stabilization principle, it is given a variant of the Picard iteration method.

Finally, some numerical experiments are reported.

MSC. 65L05, 65L60, 65L04.

Keywords. Picard iterations, initial value problem, collocation.

1 Introduction

This paper presents variants of the Picard iterations to solve an initial value problem (IVP) for ordinary differential equations. On subintervals the right hand side of the differential system is replaced by Lagrange interpolation polynomials and then successive approximations are used. The interpolation nodes are the images of a set of reference points. The number of these reference points can be fixed or variable, i.e. increasing in number [ 8 ] .

When the number of reference nodes is fixed the approximations of the solution of the IVP are computed by collocations. A convergence result is given. This case appears in [ 7 , p. 211 ] . In [ 3 ] the spectral deferred correction is defined adding a term to the iteration formula and the convergence of that method is proved.

If the number of reference points increases then the values of the unknown function are determined iteratively [ 8 ] .

The idea to replace the right hand side of a differential equation with an interpolation polynomial occurs in the multi-step methods, but instead of using the points of the main mesh a reference set of points is used. The usage of an iterative process to obtain some convergence is present in predictor-corrector methods.

We use the terminology numerical Picard iterations to emphasize that the method builds a numerical solution. For an IVP the usual Picard iterations are exemplified with Computer Algebra code in [ 12 ] .

For stiff problems, starting from a stabilization principle, [ 4 ] , [ 2 ] , we derived a variant of the Picard iteration method.

There is another approach to the numerical Picard iterations for an IVP, where the approximations are a linear form of Chebyshev polynomials [ 6 ] , [ 1 ] , [ 3 ] .

Sometimes to verify a numerical computation, it is a practical rule to use two different tools or methods. The presented methods offer an alternative to solve an IVP.

The paper is organized as follows. After introducing the numerical Picard iterations method in Section 2, two cases are presented in the next sections. In Section 3 the Picard iteration method is studied when the reference set contains a fixed number of points, while in Section 4 the Picard iteration method is considered with an increasing in number of points of the reference set. In Section 5 the case of a stiff problem is treated. In the last section some results of our computational experiments are presented.

2 Numerical Picard iterations

Let the IVP be given by

y˙(x)=f(x,y(x)),x[x0,xf],y(x0)=y0,

where the function f:[x0,xf]×RNRN has the components f=(f1,,fN).

In RN for y=(y1,,yN) we shall use the norm y=max1jN|yj|.

We assume that f is Lipschitz continuous, i.e. there exists L>0 such that

|fμ(x,y1)fμ(x,y2)|Lj=1N|y1jy2j| y1,y2RN, μ{1,2,,N}

and consequently

f(x,y1)f(x,y2)L~y1y2,

where L~=NL.

The IVP (2.1)-(2.2) may be reformulated as the integral equation

y(x)=y0+x0xf(s,y(s))ds.
2.3

Within these hypotheses the problem (2.1)-(2.2) or (2.3) has a unique solution. This solution may be obtained with the Picard iterations

y(n+1)(x)=y0+x0xf(s,y(n)(s))ds,nN,y(0)(x)=y0,

for x[x0,xf]. The sequence (y(n)(x))kN converges uniformly in [x0,xf] to the solution of IVP.

Let M be a positive integer, h=xfx0M and the mesh be defined as xi=x0+ih, i{0,1,,M}. The numerical solution is given by the sequence uh=(u0,u1,,uM), where each ui=u(xi) is an approximation of y(xi).

If ui was computed, on the interval [xi,xi+1] the function f(s,y(s)) under the integral in

y(x)=y(xi)+xixf(s,y(s))ds
2.4

will be replaced by a Lagrange interpolation polynomial

u(x)=u(xi)+xixL(Pm1;xi,1,xi,2,,xi,m;f(,u()))(s)ds,x[xi,xi+1].
2.5

The interpolation nodes xixi,1<xi,2<<xi,mxi+1 are fixed by a certain rule. The used notation states the interpolation constraints

L(Pm1;xi,1,xi,2,,xi,m;f(,u()))(xi,j)=f(xi,j,u(xi,j)),j{1,2,,m}.

From (2.5) we deduce

u(x)=u(xi)+j=1m(xixlj(s)ds)f(xi,j,u(xi,j)),
2.6

where (lj)1jm are the Lagrange fundamental polynomials

lj(x)=(xxi,1)(xxi,j1)(xxi,j+1)(xxi,m)(xi,jxi,1)(xi,jxi,j1)(xi,jxi,j+1)(xi,jxi,m).
2.7

3 Picard iterations with a fixed reference set

In (2.6) the values

u(xi,1),u(xi,2),,u(xi,m)

are unknown. To compute these vectors the collocation method will be used.

Choosing x:=xi,k in (2.6) we get

u(xi,k)=u(xi)+j=1m(xixi,klj(s)ds)f(xi,j,u(xi,j)),k{1,2,,m}.
3.8

The relations (3.8) form a nonlinear system with the unknowns u(xi,1),,u(xi,m)RN××RNmRmN.

In order to simplify and provides a unitary approach to the computation of the integrals from (3.8) we fix the nodes ξ1<ξ2<<ξm within an interval [a,b]. We call these nodes the reference interpolation nodes. The function

φi(ξ)=xi+hba(ξa)

maps the interval [a,b] into [xi,xi+1]. For any i{0,1,,M1} the nodes xi,j will be defined as

xi,j=φi(ξj), j{1,2,,m}.

If s=φi(ξ) then

lj(s)=(ξξ1)(ξξj1)(ξξj+1)(ξξm)(ξjξ1)(ξjξj1)(ξjξj+1)(ξjξm)=l~j(ξ)

and

xixi,klj(s)ds=hbaaξkl~j(ξ)dξ.

Denoting

wj,k=1baaξkl~j(ξ)dξ

the nonlinear system (3.8) becomes

u(xi,k)=u(xi)+hj=1mwj,kf(xi,j,u(xi,j)),k{1,2,,m}.
3.9

In order to prove the existence of a solution of the nonlinear system we shall use a simplified notation u(xi,k)=uk, k{1,2,,m}. Then the system (3.9) is written as

uk=u(xi)+hj=1mwj,kf(xi,j,uj),k{1,2,,m}.
3.10

The operator

Φ=(Φk)1km,whereΦk:RN××RNmRN

is defined by

Φk(u)=u(xi)+hj=1mwj,kf(xi,j,uj),u=(u1,,um).

The used norm in RN××RNm will be

|||u|||=|||(u1,,um)|||=j=1muj.

If u=(u1,,um) and v=(v1,,vm) then following equality is valid

Φk(u)Φk(v)=hj=1mwj,k(f(xi,j,uj)f(xi,j,vj)),k{1,2,,m}.

Then

Φk(u)Φk(v)hL~j=1m|wj,k|ujvj

and

k=1mΦk(u)Φk(v)hL~k,j=1m|wj,k|ujvj.

If ω=max1jmk=1m|wj,k| the above inequality gives

|||Φ(u)Φ(v)|||hωL~|||uv|||.
3.11

Thus, if hωL~<1 then Φ is a contraction. Following theorem is a consequence of the above:

Theorem 3.1

For h small enough (h<1ωL) the nonlinear system 3.9 has a unique solution.

In the hypothesis of the above theorem, the nonlinear system (3.9) may be solved using the successive approximation method

u(n+1)(xi,k)=u(xi)+hj=1mwj,kf(xi,j,u(n)(xi,j)),nNu(0)(xi,k)=u(xi)

for k{1,2,,m}. Because Φ is contraction, (3.11), the sequences

ui,j(n)=defu(n)(xi,j),nN,j{1,2,,m}

will converge to the solution of the system (3.9).

The iterative relations (3.12) can be written in matrix form

[ui,1(n+1) ui,2(n+1)ui,m(n+1)]=[ui uiui]m+h[fi,1 fi,2fi,m](w1,1w1,mw2,1w2,mwm,1wm,m),
3.14

where fi,j=f(xi,j,ui,j(n)), j{1,,m}. Denoting ui(n)=(ui,j(n))1jm the iterations stop when the following condition is fulfilled ui(n)ui(n1)<ε, where ε>0 is a tolerance. The initial approximations are chosen as ui,j(0)=u(xi) for any j{1,2,,m}.

This method to solve the nonlinear system (3.9) leads to an approximation to the solution of the IVP in the most right node which may differ from xi+1. We point out two variants of the computations:

  • We change the initial mesh such that xi+1 will be the most right node (xi+1=φi(ξm)) and the computation continue in the interval [xi+1,xi+1+h]. In this case we have

    ui+1=defu(xi+1)=ui,m(n).
  • In (2.5) we set x:=xi+1=φi(b) and

    ui+1=defu(xi+1)=u(xi)+hbaj=1m(abl~j(ξ)dξ)f(xi,j,ui,j(n)).

    In this way m new integrals must be computed additionally.

With the new notations we have u0=defu(x0)=y0.

The coefficients wj,k do not depend on the computation interval. We highlight some cases when these coefficients may be easily computed.

Some particular cases

  1. Equidistant nodes. If ξj=j1m1, j{1,2,,m}, then

    wj,k=0ξkl~j(ξ)dξ=(1)mj(j1)!(mj)!0k1m1μj1μ=0m1((m1)ξμ)dξ.

    The following Mathematica code computes these coefficients:

    Wcoeff[j_,k_,m_]:=Wcoeff[j_,k_,m_]:=Module[{x,w},Module[{x,w},w=Integrate[Product[If[ij1,(m1)xi,1],{i,0,m1}],w=Integrate[Product[If[ij1,(m1)xi,1],{i,0,m1}],{x,0,(k1)/(m1)}];(1)(mj)w/((j1)!(mj)!)]{x,0,(k1)/(m1)}];(1)(mj)w/((j1)!(mj)!)]

    The results obtained for m=2 are

    MatrixForm[Table[Wcoeff[j,k,2],{k,1,2},{j,1,2}]]MatrixForm[Table[Wcoeff[j,k,2],{k,1,2},{j,1,2}]]

    (001212)

    Because xi,1=xi şi xi,2=xi+1 the recurrence formula (3.12)-(3.13) becomes

    ui+1(n+1)=ui+h2(f(xi,ui)+f(xi+1,ui+1(n)));ui+1(0)=ui.

    For m=3 the results are

    MatrixForm[Table[Wcoeff[j,k,3],{k,1,3},{j,1,3}]]MatrixForm[Table[Wcoeff[j,k,3],{k,1,3},{j,1,3}]]

    (00052413124162316)

    In this case xi,1=xi,xi,2=12(xi+xi+1)=defxi+12,xi,3=xi+1 and the recurrence formulas (3.12)-(3.13) become

    ui+12(n+1)=ui+h(524f(xi,ui)+13f(xi+12,ui+12(n)))124f(xi+1,ui+1(n)));ui+1(n+1)=ui+h6(f(xi,ui)+4f(xi+12,ui+12(n))+f(xi+1,ui+1(n)));ui+12(0)=ui;ui+1(0)=ui.

    In matrix form the above relations are

    [uiui+12(n+1)ui+1(n+1)]=[uiuiui]+h(00052413124162316)[f(xi,ui)f(xi+12,ui+12(n))f(xi+1,ui+1(n))].

    Transposing the above equality we get the form corresponding to (3.14).

    To compute ui+1 we observe that for m=2 the trapezoidal rule (3.15), while for m=3 the Simpson integration formula (3.16) are used.

    Chebyshev points of second kind ξj=cos(j1)πm1, j{1,,m}. Then

    wj,k=121ξkl~j(ξ)dξ=(1)j12m3γjm11ξkk=1,kjm(ξξk)dξ

    with γj={0.5ifj{1,m}1ifj{2,,m1}.

    The nodes are the roots of an orthogonal polynomial. Now we suppose that the polynomial pm(ξ)=j=1m(ξξj) is orthogonal to Pm1, the set of polynomials of degree at most m1, with the weight ρ(ξ) on the interval I=[a,b]. In this case the Lagrange fundamental polynomials l~j(ξ), j{1,,m} are orthogonal.

    • If ρ(ξ)=1,I=[a,b] then pm(ξ)=m!(2m)!dmdmξ(ξa)m(ξb)m is the Laguerre polynomial. For a=0,b=1 and m=1 following results are obtained

      p1(ξ)=ξ12ξ1=12w1,1=012dξ=12ui+12(n+1)=ui+h2f(xi+12,ui+12(n))

      Again we observe that u(xi+12) is computed using the rectangle rule in the right hand side of (2.5).

    • The Chebyshev polynomials pm(ξ)=12m1cos(marccosξ), mN, are orthogonal with the weight ρ(ξ)=11ξ2 in I=[1,1].

      The nodes will be

      ξj=cos(2j1)π2mxi,j=xi+h2(ξj+1), j{1,2,,m}.

      The biggest node is xi,1. The Lagrange fundamental polynomials are

      l~j(ξ)=2m1m(1)j1sin(2j1)π2mμjμ=1m(ξcos(2μ1)π2m)

      and

      wj,k=2m2m(1)j1sin(2j1)π2m1cos(2k1)π2mμjμ=1m(ξcos(2μ1)π2m)dξ

      The integral can be analytically computed but it involves rounding errors.

3.1 The convergence of the method

When h, the distance between two mesh points xi and xi+1=xi+h, is small enough the convergence of Picard iterations is provided by the contraction condition. We recall that m, the number of the reference set is fixed. The convergence problem refers to the behavior of the numerical solution (u0,u1,,uM) to the analytical solution (y(x0),y(x1),,y(xM)).

We suppose that:

  • The function f(x,y(x)) is continuous and then there exists a constant K1>0 such that

    max1μNmaxx[x0,xf]|fμ(x,y(x))|K1.
  • The function f(x,y) have continuous partial derivatives of order m for any x[x0,xf],yRN. There exists Km>0 such that

    max1μNmaxx[x0,xf]|dmfμ(x,y(x))|dxm|Km.

In any interval [xi,xi+1] the following equality is valid, [ 10 , Th. 2.1.4.1 ] ,

fμ(x,y(x))L(Pm1;xi,1,xi,2,,xi,m;fμ(,y()))(x)==1m!j=1m(xxi,j)dmfμ(x,y(x))dxm|x=ημ

where ημ[xi,xi+1].

We denote by Rμ(x) the right hand side of the above equality and then maxx[xi,xi+1]|Rμ(x)|Kmm!hm. If R(x)=(R1(x),,RN(x)) then (2.4) implies the vectorial relation

y(x)=y(xi)+xixL(Pm1;xi,1,xi,2,,xi,m;f(,y()))(s)ds+xixR(s)ds
3.17

and xixR(s)dsKmm!hm+1.

We make the following notations

ei=y(xi)ui,i{0,1,,M};ri,j(n)=y(xi,j)ui,j(n),j{1,2,,m};ri(n)=max1jmri,j(n).

and additionally

w=max{max1j,km|wj,k|,max1jm1ba|abl~j(ξ)dξ|},w~=mw.

We emphasize that n represents the number of iterations on an interval [xi,xi+1]. This number differs from one interval to another. For simplicity we omitted the index i when n is written.

Several times the following theorem will be used

Theorem 3.2

If (zk)kN is a sequence of nonnegative numbers such that

zk+1azk+b kN\c{s}ia,b>0, a1,

then

zkakz0+bak1a1, kN.

The above inequality implies: if a>1 then zkak(z0+ba1) and if a<1 then zkakz0+b1a.

The following result of convergence occurs:

Theorem 3.3

If the above assumptions take place then

limh0maxi{0,1,,M}y(xi)ui=0,

that is, the convergence of the method.

Proof â–¼
In the beginning we determine an evaluation for ri(n).

For n=0 the equalities hold:

y(xi,j)ui,j(0)=y(xi,j)ui=(y(xi,j)y(xi))+(y(xi)ui)=xixi,jf(s,y(s))ds+(y(xi)ui)

and then we deduce

ri,j(0)K1h+ei,  j{1,2,,m}ri(0)K1h+ei.

If n>0, for x=xi,k the equality (3.17) may be written as

y(xi,k)=y(xi)+hj=1mwj,kf(xi,j,y(xi,j))+xixi,kR(s)ds.
3.18

Subtracting (3.12) from (3.18)we obtain

y(xi,k)ui,k(n+1)==y(xi)ui+hj=1mwj,k(f(xi,j,y(xi,j))f(xi,j,ui,j(n)))+xixi,kR(s)ds.

It follows that

ri,k(n+1)ei+hL~w~ri(n)+Kmm!hm+1ri(n+1)ei+hL~w~ri(n)+Kmm!hm+1

If h is small enough (hL~w~<1) then

ri(n)(hL~w~)nri(0)+11hL~w~(ei+Kmm!hm+1)(hL~w~)n(K1h+ei)+11hL~w~(ei+Kmm!hm+1)=((hL~w~)n+11hL~w~)ei+hn+1(L~w~)nK1+Kmhm+1m!(1hL~w~).

Evaluating ei we distinguish two cases depending on the definition of ui+1:

ui+1=ui,m(n)=ui+hj=1mwj,mf(xi,j,ui,j(n1)),(xi+1=φi(ξm))

or

ui+1=ui+hbaj=1m(abl~j(ξ)dξ)f(xi,j,ui,j(n)),(xi+1=φi(b)).

Corresponding to the two cases, from (3.17) we obtain the equalities

y(xi+1)=y(xi)+hj=1mwj,mf(xi,j,y(xi,j))+xixi,mR(s)ds

and respectively

y(xi+1)=y(xi)+hbaj=1m(abl~j(ξ)dξ)f(xi,j,y(xi,j))+xixi+1R(s)ds.

Computing y(xi+1)ui+1 it results

y(xi+1)ui+1=y(xi)ui+hj=1mwj,m(f(xi,j,y(xi,j))ui,j(n1))+xixi,mR(s)ds,

respectively

y(xi+1)ui+1=y(xi)ui+hbaj=1m(abl~j(ξ)dξ)(f(xi,j,y(xi,j))ui,j(n))++xixi+1R(s)ds.

It follows that

ei+1ei+hL~w~ri(n1)+Kmm!hm+1

and

ei+1ei+hL~w~ri(n)+Kmm!hm+1.

We remark that between the two estimates only the upper index of ri differs. This justifies that in the second case m additional integrals must be computed.

From hereon it is sufficient to consider only the first case. Using (3.19) we obtain

ei+1ei+hL~w~(((hL~w~)n1+11hL~w~)ei+hn(L~w~)n1K1+Kmhm+1m!(1hL~w~))+Kmm!hm+1=ei(1+(hL~w~)n+hL~w~1hL~w~)+hn+1(L~w~)nK1+Kmhm+1m!(1hL~w~).

Because hL~w~<1  (hL~w~)nhL~w~ the above inequality becames

ei+1ei(1+hL~w~+hL~w~1hL~w~)+h2L~w~K1+Kmhm+1m!(1hL~w~).

Consequently

ei(1+hL~w~+hL~w~1hL~w~)i(e0+h2L~w~K1+Kmhm+1m!(1hL~w~)hL~w~+hL~w~1hL~w~)ei(hL~w~+hL~w~1hL~w~)(e0+hL~w~K1+Kmhmm!(1hL~w~)L~w~+L~w~1hL~w~).

Because e0=0, from the above inequality it results that:

max1iMeie(xfx0)L~w~(1+11hL~w~)(hL~w~K1+Kmhmm!(1hL~w~)L~w~+L~w~1hL~w~)0,

for h0  M.

Proof â–¼

4 Picard iterations with a variable reference set

We shall keep some of the above introduced notations and we shall define those that differ.

Let aξ1m<ξ2m<<ξmmb be the roots of the polynomial pm(x), where (pm)mN is a sequence of orthogonal polynomials with the weight ρL2[a,b] on the interval [a,b]. It is assumed that 1ρL2[a,b], too. These are requirements of the convergence theorem [ 8 ] .

If φi is the affine function transforming [a,b] onto [xi,xi+1] then the nodes are introduced

xi,jm=φi(ξjm),j{1,2,,m},mN.

For x[xi,xi+1], we define

um+1(x)=ui+xixL(Pm1;xi,1m,xi,2m,,xi,mm;f(,um()))(s)ds==ui+j=1m(xixljm(s)ds)f(xi,jm,u(xi,jm))=ui+hbaj=1m(aζl~jm(ξ)dξ)f(xi,jm,u(xi,jm)),

where ζ=φi1(x) and

l~jm(ξ)=(ξξ1m)(ξξj1m)(ξξj+1m)(ξξmm)(ξjmξ1m)(ξjmξj1m)(ξjmξj+1m)(ξjmξmm).

The vectors ui,jm are defined iteratively

ui,11=ui,ui,12=ui+hba(aξ12l~11(ξ)dξ)f(xi,11,ui,11)=ui+hba(ξ12a)f(xi,11,ui,11);ui,22=ui+hba(aξ22l~11(ξ)dξ)f(xi,11,ui,11)=ui+hba(ξ22a)f(xi,11,ui,11).

It was taken into account that l~1(ξ)=1. As a rule

ui,km+1=um+1(xi,km+1)=ui+hbaj=1m(axi,km+1l~jm(ξ)dξ)f(xi,jm,u(xi,jm)),

for k{1,2,,m+1} şi mN.

We must compute

ui+1m+1=um+1(xi+1)=ui+hbaj=1m(abl~jm(ξ)dξ)f(xi,jm,u(xi,jm)),

too.

The computation of the vectors ui,km+1, k{1,2,,m+1}, ui+1m+1 can be written in matrix form. For simplicity we denote

wj,k=axi,km+1l~jm(ξ)dξ,j{1,,m}, k{1,,m+1},wj=abl~jm(ξ)dξ,j{1,,m}

and the matrix

W=hba(w1,1w2,1wm,1w1,2w2,2wm,2w1,k+1w2,k+1wm,k+1w1w2wm)Mm+2,m(R)
F=[f(xi,1m,ui,1m),f(xi,2,ui,2m),,f(xi,mm,ui,mm)]MN,m(R)

The following equality holds

[ui,1m+1,ui,2m+1,,ui,m+1m+1,ui+1m+1]T=[ui,,ui]m+2T+WFT.

For an imposed tolerance ε>0, the iterations occurs until the condition ui+1m+1uim<ε is fulfilled. The initial approximation is ui+11=ui. If the above condition is fulfilled then we set ui+1=ui+1m+1.

A convergence result is given in [ 8 ] .

5 Stiff problems

From (2.3), if s=x0+hσ then

y(x)=y(x0)+h0xx0hf(x0+hσ,y(x0+hσ))dσ,

with x[x0,x0+h]  σ[0,1].

Setting

y(x0+hσ)=y0+hv(σ)

we derive that v(0)=0 and

dv(σ)dσ=f(x0+hσ,y0+hv(σ))v(s)=0sf(x0+hσ,y0+hv(σ))dσ.

Following [ 4 ] , [ 2 ] , by the stabilization principle, the solution of the partial differential system

w(ζ,t)t=w(ζ,t)+0ζf(x0+hσ,y0+hw(σ,t))dσ
5.19

has the property, cf. [ 4 ] , [ 2 ] ,

limtw(ζ,t)v(ζ)=0,forζ[0,1].
5.20

We give a numerical solution to find an approximation of the solution of (5.19).

Let be τ>0 and the sequence tn=nτ, nN. The equation (5.19) may be rewritten as

etw(ζ,t)t=et0ζf(x0+hσ,y0+hw(σ,t))dσ

and integrating from nτ to (n+1)τ it results

w(ζ,tn+1)=eτw(ζ,tn)+e(n+1)τnτ(n+1)τeη(0ζf(x0+hσ,y0+hw(σ,η))dσ)dη.
5.21

Without changing the notation for w, we substitute in (5.21) f(x0+hσ,y0+hw(σ,η)) by a Lagrange interpolation polynomial

w(ζ,tn+1)==eτw(ζ,tn)++e(n+1)τnτ(n+1)τeη(0ζL(Pm1;ξ1,,ξm;f(x0+h ,y0+hw(,η))dσ)dη=eτw(ζ,tn)+e(n+1)τj=1mnτ(n+1)τeη(0ζf(x0+hξj,y0+hw(ξj,η))lj(σ)dσ)dη,

where 0=ξ1<ξ2<<ξm=1.

We denote wn(ζ)=w(ζ,tn) and in the right hand side of (5.22) we take w(ξj,η)=wn(ξj), for any j{1,2,,m} and η[nτ,(n+1)τ]. Then

wn+1(ζ)=eτwn(ζ)+(1eτ)j=1mf(x0+hξj,y0+hwn(ξj))0ζlj(σ)dσ.

Denoting wjn=wn(ξj), for ζ=ξk, k{1,2,,m} we obtain the iterative relations

wkn+1=eτwkn+(1eτ)j=1mf(x0+hξj,y0+hwjn)0ξklj(σ)dσ.

The iterations occurs until the stopping condition max1jmwjn+1wjn<ε is fulfilled. Here ε>0 is a tolerance. According to (5.20) we consider v(1)=wjn+1 and the procedure continues with ui+1=ui+hwmn+1.

6 Numerical experiments

Using computer programs based on these methods we solved the following IVPs:

  1. ( [ 9 , p. 234 ] )

    {y˙=y4(x+2)3y(x+2)41,x[0,1],y(0)=15

    with the solution y(x)=1+(x+2)+(x+2)2+(x+2)3.

    For M=5 and the tolerance ε=105 the maximum error
    max0iMy(xi)ui and Nf, the number of calling the function f, are given in Table 6..

    Fixed equidistant

    Variable reference set

    reference set m=3

     

    Error

    Nf

    Error

    Nf

    1.82591e-08

    75

    8.94274e-08

    99

    Table 6. Results for Example (1).
  2. ( [ 9 , p. 244 ] )

    {y1˙=y2,y1(0)=1,x[0,xf],y2˙=y1r3,y2(0)=0,y3˙=y4,y3(0)=0,y4˙=y3r3,y4(0)=1,

    where r=y12+y32 and with the solution y1=cosx,y2=sinx,y3=sinx,y4=cosx.

    The results of our numerical experiments are listed in Table 6..

         

    Fixed equidistant

    Variable reference set

         

    reference set m=3

     

    xf

    M

    ε

    Error

    Nf

    Error

    Nf

    2π

    10

    105

    0.0247309

    300

    6.47998e-05

    550

    2π

    10

    109

    0.0246415

    480

    2.24345e-09

    1050

    4π

    10

    105

    0.888217

    534

    0.000142862

    966

    4π

    20

    109

    0.0496889

    960

    1.05491e-08

    2100

    6π

    10

    105

    14.4197

    762

    6.23799e-05

    1530

    6π

    40

    109

    0.0232977

    1560

    3.06542e-09

    3640

    Table 6. Results for Example (2).

    Now we compare the results obtained using equidistant nodes and Chebyshev points of second kind for the reference set. For the same example the obtained results are given in Table 6..

         

    Fixed equidistant

    Chebyshev fixed

         

    reference set m=5

    xf

    M

    ε

    Error

    Nf

    Error

    Nf

    2π

    10

    105

    6.93002e-05

    400

    2.69646e-05

    400

    2π

    10

    109

    1.91509e-05

    650

    8.13527e-06

    650

    4π

    10

    105

    0.00215349

    600

    0.000338729

    551

    4π

    20

    109

    3.85763e-05

    1300

    1.6391e-05

    1300

    6π

    10

    105

    0.0275954

    900

    0.0164587

    820

    6π

    40

    109

    1.00764e-05

    2200

    4.18516e-06

    2200

    Table 6. Results for Example (2).

    As expected, the results using Chebyshev points of second kind are better than that obtained using equidistant nodes, due to the better approximation property of Lagrange interpolation polynomial with Chebyshev points of second kind toward the equidistant points, [ 11 ] .

  3. ( [ 9 , p. 245 ] ) Keeping the differential system as in the previous example but changing the initial value conditions to y(0)=[0.4,0,0,2], for xf=2π, M=20 and ε=109 with the method based on variable reference set we obtained max0iMy(xi)ui=2.94126109 and Nf=1400.

    In this case the solution is

    y(x)=[cosu0.6,sinu10.6cosu,0.8sinu,0.8cosu10.6cosu],

    where x=u0.6sinu.

    Based on the previous examples the method with variable number of reference points is more efficient than the method with fixed number reference points, but we cannot deduce theoretically such a conclusion.

Using the method for stiff problems presented above we solved:

  1. {y1˙=998y1+1998y2,y1(0)=1,x[0,1],y2˙=999y11999y2,y2(0)=0,

    with the solution y1=2exe1000x,y2=ex+e1000x.

    For τ=10 the results are given in Table 6.. We recall that τ is the length of the step for the t variable of the stabilization principle.

       

    Fixed equidistant

    Chebyshev fixed

       

    reference set m=5

    M

    ε

    Error

    Nf

    Error

    Nf

    300

    105

    0.00164977

    8585

    0.000402419

    8435

    500

    107

    0.000128781

    10700

    4.35037e-05

    10555

    Table 6. Results for Example (4).
  2. y˙=20y,y(0)=1,x[0,1].

    For τ=10,M=20 and ε=107 the results are given in Table 6..

    Fixed equidistant

    Chebyshev fixed

    reference set m=5

    Error

    Nf

    Error

    Nf

    1.19382e-06

    800

    4.58431e-07

    785

    Table 6. Results for Example 5.

To make the results reproducible we provide some code at https://github.com/e-scheiber/scilab-ivpsolvers.git.

Acknowledgement

The author wishes to thank the referee for suggesting many improvements of this paper.

Bibliography

1

X. Bai, Modified Chebyshev-Picard Iteration Methods for Solution of Initial Value and Boundary Value Problems. PhD Dissertation, 2010, Texas A&M University.

2

V.V. Bobkov, B.V. Faleichik, P.A. Mandrik, V.I. Repnikov, Solving Stiff Problems Using Generalized Picard Iterations, AIP Conference Proceeding 1168, 65 (2009), \includegraphics[scale=0.1]{ext-link.png}

3

F.M. Causley, C.D. Seal, On the Convergence of Spectral Deferred Correction Methods. arXiv:1706.06245v1 [math.NA], 2017.

4

B.V. Faleichik, Analytic Iterativ Processes and Numerical Algorithms for Stiff Problems. Computational Methods in Applied Mathematics, 8 (2008) no. 2, 116–129. \includegraphics[scale=0.1]{ext-link.png}

5

T. Fukushima, Picard Iteration Method, Chebyshev Polynomial Approximation, and Global Numerical Integration of Dynamical Motions. The Astronomical J., 113 (1997) no. 5, 1909–1914. \includegraphics[scale=0.1]{ext-link.png}

6

T. Fukushima, Vector integration of dynamical motions by the Picard-Chebyshev method, The Astronomical J., 113 (1997) no. 6, 2325–2328. \includegraphics[scale=0.1]{ext-link.png}

7

E. Hairer, G. Wanner, S. Nørsett, Solving Ordinary Differential Equations. I Nonstiff Problems, Second Ed, Springer, Berlin, 1993.

8

E. Scheiber, A multistep method to solve the initial value problem. The 4th Romanian-German Seminar on Approximation Theory and its Applications. Braşov, 2000 (ed. H. Gonska, D. Kacso, L. Beutel) Gerhard Mercator Universitat, Duisburg, 124–132.

9

L.F. Shampine, M.K. Gordon, Computer solution of ordinary differential equation. The initial value problem, W.H. Freeman and Company, San Francisco, 1975.

10

J. Stoer, R. Bulirsch, Introduction to Numerical Analysis, Springer-Verlag, New York, 1993.

11

N.L. Trefethen, ApproximationTheory and Approximation Practice, SIAM, Philadelphia, 2012.

12

***, http://mathfaculty.fullerton.edu/mathews/n2003/PicardIterationMod.html, 2017.