Local linearization method explained
In numerical analysis, the local linearization (LL) method is a general strategy for designing numerical integrators for differential equations based on a local (piecewise) linearization of the given equation on consecutive time intervals. The numerical integrators are then iteratively defined as the solution of the resulting piecewise linear equation at the end of each consecutive interval. The LL method has been developed for a variety of equations such as the ordinary, delayed, random and stochastic differential equations. The LL integrators are key component in the implementation of inference methods for the estimation of unknown parameters and unobserved variables of differential equations given time series of (potentially noisy) observations. The LL schemes are ideals to deal with complex models in a variety of fields as neuroscience, finance, forestry management, control engineering, mathematical statistics, etc.
Background
Differential equations have become an important mathematical tool for describing the time evolution of several phenomenon, e.g., rotation of the planets around the sun, the dynamic of assets prices in the market, the fire of neurons, the propagation of epidemics, etc. However, since the exact solutions of these equations are usually unknown, numerical approximations to them obtained by numerical integrators are necessary. Currently, many applications in engineering and applied sciences focused in dynamical studies demand the developing of efficient numerical integrators that preserve, as much as possible, the dynamics of these equations. With this main motivation, the Local Linearization integrators have been developed.
High-order local linearization method
High-order local linearization (HOLL) method is a generalization of the Local Linearization method oriented to obtain high-order integrators for differential equations that preserve the stability and dynamics of the linear equations. The integrators are obtained by splitting, on consecutive time intervals, the solution x of the original equation in two parts: the solution z of the locally linearized equation plus a high-order approximation of the residual
.
Local linearization scheme
A Local Linearization (LL) scheme is the final recursive algorithm that allows the numerical implementation of a discretization derived from the LL or HOLL method for a class of differential equations.
LL methods for ODEs
Consider the d-dimensional Ordinary Differential Equation (ODE)
=f\left(t,x\left(t\right)\right), t\in\left[t0,T\right], (4.1)
with initial condition
, where
is a differentiable function.
Let
\left(t\right)h=\{tn:n=0,..,N\}
be a time discretization of the time interval
with maximum stepsize
h such that
and
. After the local linearization of the equation (4.1) at the time step
the variation of constants formula yields
x(tn+h)=x(tn)+\phi(tn,x(tn);h)+r(tn,x(tn);h),
where
\phi(tn,zn;h)=\int\limits
(f(tn,zn)+ft(tn,zn)s)ds
results from the linear approximation, and
r(tn,zn;h)=\int\limits
gn(s,x(tn+s))ds, (4.2)
is the residual of the linear approximation. Here,
and
denote the partial derivatives of
f with respect to the variables
x and
t, respectively, and
gn(s,u)=f(s,u)-fx(tn,zn)u-ft(tn,zn)(s-tn)-f(tn,zn)+fx(tn,zn)zn.
Local linear discretization
For a time discretization
, the
Local Linear discretization of the ODE (4.1) at each point
is defined by the recursive expression
[1] zn+1=zn+\phi(tn,zn;hn),
with z0=x0. (4.3)
The Local Linear discretization (4.3) converges with order 2 to the solution of nonlinear ODEs, but it match the solution of the linear ODEs. The recursion (4.3) is also known as Exponential Euler discretization.
High-order local linear discretizations
For a time discretization
a
high-order local linear (HOLL) discretization of the ODE (4.1) at each point
is defined by the recursive expression
[1] zn+1=zn+\phi(tn,zn;hn)+\widetilde{r
}(t_n,\mathbf_n;h_n),\qquad \text \quad \mathbf_0=\mathbf_0, \qquad \qquad \qquad(4.4)
where
is an order
(>
2) approximation to the residual
r (i.e.,\left\vertr(tn,zn;h)-\widetilde{r
}(t_n,\mathbf_n;h)\right\vert \propto h^). The HOLL discretization (4.4)
converges with order
to the solution of nonlinear ODEs, but it match the solution of the linear ODEs.
HOLL discretizations can be derived in two ways:[1] 1) (quadrature-based) by approximating the integral representation (4.2) of r; and 2) (integrator-based) by using a numerical integrator for the differential representation of r defined by
=q(tn,zn;t,r(t)), with r(tn)=0, (4.5)
for all
, where
q(tn,zn;s,\xi)=f(s,zn+
\phi\left(tn,zn;s-tn\right)+\xi)-
fx(tn,zn)\phi(tn,
zn;s-tn)-ft(tn,zn)(s-tn)-f(tn,zn).
HOLL discretizations are, for instance, the followings:
- Locally Linearized Runge Kutta discretization[2] [3]
zn+1=zn+\phi(tn,zn;hn)+hn
bjkj, with ki=q(tn,zn;tn+cihn,hn
aijkj),
which is obtained by solving (4.5) via a s-stage explicit Runge–Kutta (RK) scheme with coefficients
c=\left[ci\right],A=\left[aij\right] and b=\left[bj\right]
.
- Local linear Taylor discretization
which results from the approximation of
in (4.2) by its order-
p truncated
Taylor expansion.
- Multistep-type exponential propagation discretization
which results from the interpolation of
in (4.2) by a polynomial of degree
p on
, where
denotes the
j-th
backward difference of
.
- Runge Kutta type Exponential Propagation discretization [4]
which results from the interpolation of
in (4.2) by a polynomial of degree
p on
,
- Linealized exponential Adams discretization[5]
which results from the interpolation of
in (4.2) by a
Hermite polynomial of degree
p on
.
Local linearization schemes
All numerical implementation
of the LL (or of a HOLL) discretization
involves approximations
to integrals
of the form
\phij(A,h)=\int\limits
e(h-s)Asj-1ds, j=1,2\ldots,
where A is a d × d matrix. Every numerical implementation
of the LL (or of a HOLL)
of any order is generically called
Local Linearization scheme.
[1] [6] Computing integrals involving matrix exponential
Among a number of algorithms to compute the integrals
, those based on rational Padé and Krylov subspaces approximations for exponential matrix are preferred. For this, a central role is playing by the expression
[7] [8] [9]
where
are
d-dimensional vectors,
H=\begin{bmatrix}A&vl&vl-1& … &v1\
0&0&1& … &0\
0&0&0&\ddots&0\
\vdots&\vdots&\vdots&\ddots&1\
0&0&0& … &0\end{bmatrix}
\inR(d+l) x ,
,
, being
the
d-dimensional identity matrix.
If
denotes the (
p;
q)-
Padé approximation of
and
k is the smallest natural number such that
[10] \left\vert
\phii(A,h)ai-
L\left(Pp,q(2-k
r\right\vert\varproptohp+q+1.
If
denotes the
(m; p; q; k) Krylov-Padé approximation of
, then
[10] \left\vert
\phii(A,h)ai-
(h,H,r)\right\vert\varproptohmin)},
where
is the dimension of the Krylov subspace.
Order-2 LL schemes
[11] [6]
where the matrices
,
L and
r are defined as
Mn=\begin{bmatrix}fx(tn,yn)&ft(tn,yn)&f(tn,yn)\
0&0&1\
0&0&0
\end{bmatrix}
\inR(d+2) x ,
L=\left[
\begin{array}{ll}
I&0d x \end{array}
\right]
and
r\intercal=\left[\begin{array}{ll}
01 x &1
\end{array}
\right]
with
. For large systems of ODEs
yn+1=yn
(hn,Mn,r), with mn>2.
Order-3 LL-Taylor schemes
where for autonomous ODEs the matrices
and
are defined as
Tn=\left[\begin{array}{cccc}
fx(yn)&(I ⊗ f
\intercal(yn))fxx(yn)
f(yn)&0&f(yn)\
0&0&0&0\
0&0&0&1\
0&0&0&0
\end{array}
\right]\inR(d+3) x ,
L1=\left[\begin{array}{ll}
I&0d x \end{array}
\right] and
=\left[\begin{array}{ll}
01 x &1
\end{array}
\right]
. Here,
denotes the second derivative of
f with respect to
x, and
p + q > 2. For large systems of ODEs
yn+1=yn
(hn,Tn,r), with mn>3.
Order-4 LL-RK schemes
yn+1=yn+u4+
(2k
2+2k3+k4),
where
and
kj=f\left(tn+cjhn,yn+u
j+cjhnkj-1\right)-f\left(tn,y
n\right)-fx\left(tn,yn\right)uj -ft\left(tn,yn\right)
cjhn,
with
k1\equiv0,c=\left[\begin{array}{cccc}
0&
&
&1
\end{array}
\right],
and
p + q > 3. For large systems of ODEs, the vector
in the above scheme is replaced by
with
Locally linearized Runge–Kutta scheme of Dormand and Prince
yn+1=yn+us+hn\sum
bjkj and \widehat{y
}_=\mathbf_n+\mathbf_s+h_n\sum_^s \widehat_j \mathbf_j,\quad
[12] [13]
where s = 7 is the number of stages,
kj=f(tn+cjhn,yn+uj+hn
aj,iki)-f\left(tn,
yn\right)-fx\left(tn,yn\right)uj -ft\left(tn,yn\right)cjhn,
with
, and
aj,i,bj,\widehat{b}j and cj
are the
Runge–Kutta coefficients of Dormand and Prince and
p +
q > 4. The vector
in the above scheme is computed by a Padé or Krylor–Padé approximation for small or large systems of ODE, respectively.
Stability and dynamics
By construction, the LL and HOLL discretizations inherit the stability and dynamics of the linear ODEs, but it is not the case of the LL schemes in general. With
, the LL schemes (4.6)-(4.9) are
A-stable. With
q =
p + 1 or
q =
p + 2, the LL schemes (4.6)–(4.9) are also
L-stable. For linear ODEs, the LL schemes (4.6)-(4.9) converge with order
p +
q. In addition, with
p = q = 6 and
=
d, all the above described LL schemes yield to the ″exact computation″ (up to the precision of the
floating-point arithmetic) of linear ODEs on the current personal computers. This includes
stiff and highly oscillatory linear equations. Moreover, the LL schemes (4.6)-(4.9) are regular for linear ODEs and inherit the
symplectic structure of
Hamiltonian harmonic oscillators. These LL schemes are also linearization preserving, and display a better reproduction of the
stable and unstable manifolds around
hyperbolic equilibrium points and
periodic orbits that
other numerical schemes with the same stepsize. For instance, Figure 1 shows the
phase portrait of the ODEs
\begin{align}
&
=-2x1+x2+1-\muf(x1,λ)
(4.10)\\[6pt]
&
=x1-2x2+1-\muf(x2,λ) (4.11)
\end{align}
with
,
and
, and its approximation by various schemes. This system has two
stable stationary points and one
unstable stationary point in the region
.
LL methods for DDEs
Consider the d-dimensional Delay Differential Equation (DDE)
=f(t,x(t),xt(-\tau1),\ldots,xt(-\taum)), t\in[t0,T], (5.1)
with m constant delays
and initial condition
for all
where
f is a differentiable function,
xt:[-\tau,0]\longrightarrowRd
is the segment function defined as
xt(s):=x(t+s),s\in[-\tau,0],
for all
t\in[t0,T],\varphi:[-\tau,0]\longrightarrowRd
is a given function, and
\tau=max\left\{\tau1,\ldots,\taum\right\}.
Local linear discretization
For a time discretization
, the
Local Linear discretization of the DDE (5.1) at each point
is defined by the recursive expression
zn+1=zn+\Phi(tn,zn,hn;\widetilde{z
}_^1, \ldots,\widetilde_^m),\qquad \qquad (5.2)
where
\Phi(tn,zn,hn;\widetilde{z
}_^1, \ldots, \widetilde_^) = \int\limits_0^e^ \left[\sum\limits_{i=1}^m \mathbf{B}_n^i (\widetilde{\mathbf{z}}_{t_n}^i (u-\tau_i) -\widetilde{\mathbf{z}}_{t_n}^i (-\tau_i))+\mathbf{d}_n\right] \, du + \int \limits_0^\int\limits_0^u e^\mathbf_n \, dr \, du
}_^i:\left[-\tau_i,0\right] \longrightarrow \mathbb^d is the segment function defined as
}_^i(s):=\widetilde^i(t_n+s), \text s\in [-\tau_i,0],
and
}^i:\left[t_n-\tau_i,t_n\right] \longrightarrow \mathbb^dis a suitable approximation to
for all
such that
}^i(t_n)=\mathbf_n. Here,
}_^1(-\tau_1),\ldots,\widetilde_^m(-\tau_d)),\text\mathbf_n^i=\mathbf_(t_n,\mathbf_n,\widetilde_^1(-\tau_1),\ldots,\widetilde_^m(-\tau_d))
are constant matrices and
}_^1 (-\tau_1),\ldots,\widetilde_^m(-\tau_d))\text\mathbf_n=\mathbft_n,\mathbf_n,\widetilde_^1(-\tau_1),\ldots,\widetilde_^m(-\tau_d))
are constant vectors.
denote, respectively, the partial derivatives of
f with respect to the variables
t and
x, and
. The Local Linear discretization (5.2) converges to the solution of (5.1) with order
if
}_^ approximates
with order
r (i.e.,\left\vert
(u-\taui)-\widetilde{z
}_^\mathbfu-\tau _\mathbf\right\vert \propto h_^ for all
.
Local linearization schemes
Depending on the approximations
}_^ and on the algorithm to compute
different Local Linearizations schemes can be defined. Every numerical implementation
of a Local Linear discretization
is generically called
local linearization scheme.
Order-2 polynomial LL schemes
where the matrices
and
are defined as
Mn=
\begin{bmatrix}
An&cn
&dn\
0&0&1\
0&0&0
\end{bmatrix}
\inR(d+2) x ,
L=\left[\begin{array}{ll}
I&0d x \end{array}
\right]
and
r\intercal=\left[\begin{array}{ll}
01 x &1
\end{array}
\right],hn\leq\tau
, and
. Here, the matrices
,
,
and
are defined as in (5.2), but replacing
by
and
=(y(tn+1-\taui)-y
(tn-\taui))/hn,
where
y\left(t\right)
+L(Pp,q
r,
with
nt=max\{n=0,1,2,...,:tn\leqtandtn\in\left(t\right)h\}
, is the
Local Linear Approximation to the solution of (5.1) defined through the LL scheme (5.3) for all
and by
y\left(t\right)=\varphi\left(t\right)
for
t\in\left[t0-\tau,t0\right]
. For large systems of DDEs
yn+1=yn
(hn,Mn,r) and y\left(t\right)
,r),
with
and
. Fig. 2 Illustrates the stability of the LL scheme (5.3) and of that of an explicit scheme of similar order in the integration of a stiff system of DDEs.
LL methods for RDEs
Consider the d-dimensional Random Differential Equation (RDE)
=f(x(t),\xi
(t)), t\in\left[t0,T\right], (6.1)
with initial condition
where
is a
k-dimensional
separable finite continuous stochastic process, and
f is a differentiable function. Suppose that a
realization (path) of
is given.
Local Linear discretization
For a time discretization
, the
Local Linear discretization of the RDE (6.1) at each point
is defined by the recursive expression
zn+1=zn+\phi(tn,zn;hn),
with z0=x0,
where
\phi(tn,zn;hn)=\int\limits
(f(zn,\xi(tn))+f\xi(zn,\xi(tn))(\widetilde{\xi
}(t_+u)-\widetilde(t_n))) \, du
and
} is an approximation to the process
for all
Here,
and
denote the partial derivatives of
with respect to
and
, respectively.
Local linearization schemes
Depending on the approximations
} to the process
and of the algorithm to compute
, different Local Linearizations schemes can be defined. Every numerical implementation
of the local linear discretization
is generically called
local linearization scheme.LL schemes
[14] where the matrices
are defined as
Mn=\left[\begin{array}{ccc}
fx\left(yn,\xi(tn)\right)&f\xi(yn,\xi(tn)(\xi
(tn+1)-\xi(tn))/hn&f\left(yn,
\xi(tn)\right)\
0&0&1\
0&0&0
\end{array}
\right]
L=\left[\begin{array}{ll}
I&0d x \end{array}
\right]
,
r\intercal=\left[\begin{array}{ll}
01 x &1
\end{array}
\right]
, and
p+q>1. For large systems of RDEs,
yn+1=yn
(hn,Mn,r), p+q>1
and mn>2.
The convergence rate of both schemes is
, where is
the exponent of the Holder condition of
.
Figure 3 presents the phase portrait of the RDE
=-x2+\left(
\right)x1\sin
(wH(t))2, x1(0)=0.8 (6.2)
=x1
)x2\sin(wH(t))2,
x2(0)=0.1, (6.3)
and its approximation by two numerical schemes, where
denotes a
fractional Brownian process with
Hurst exponent H=0.45.
Strong LL methods for SDEs
Consider the d-dimensional Stochastic Differential Equation (SDE)
| m |
dx(t)=f(t,x(t))dt+\sum\limits | |
| i=1 |
g
i(t)dwi(t), t\in\left[t0,T\right], (7.1)
with initial condition
, where the drift coefficient
and the diffusion coefficient
are differentiable functions, and
is an
m-dimensional standard
Wiener process.
Local linear discretization
For a time discretization
, the order-
(=1,1.5)
Strong Local Linear discretization of the solution of the SDE (7.1) is defined by the recursive relation
[15] zn+1=zn+\phi\gamma(tn,
zn;hn)+\xi(tn,zn;hn), with z0=x0,
where
\phi\gamma(tn,zn
(f(tn,zn)+a\gamma(tn,
zn)u)du
and
\xi\left(tn,zn;\delta\right)=
gi(u)dwi(u).
Here,
a\gamma(tn,zn)=\left\{
\begin{array}{cl}
ft(tn,zn)&for \gamma=1\\
ft(tn,zn)+
(I ⊗
(tn))fxx(tn,zn)gj(tn)&for \gamma=1.5,
\end{array}
\right.
denote the partial derivatives of
with respect to the variables
and
t, respectively, and
the Hessian matrix of
with respect to
. The strong Local Linear discretization
converges with order
(= 1, 1.5) to the solution of (7.1).
High-order local linear discretizations
After the local linearization of the drift term of (7.1) at
, the equation for the residual
is given by
dr(t)=q\gamma(tn,zn;t,r(t))dt+
gi(t)dwi(t), r(tn)=0
for all
, where
q\gamma(tn,zn;s,\xi)=f(s,zn+\phi\gamma(tn,zn;s-tn)+\xi)-fx(tn,zn)\phi\gamma(tn,zn;s-tn)-a\gamma(tn,zn)(s-tn)-f(tn,zn).
A high-order local linear discretization of the SDE (7.1) at each point
is then defined by the recursive expression
[16] zn+1=zn+\phi\gamma(tn,zn;hn)+\widetilde{r
}(t_n,\mathbf_n;h_n),\qquad \text \qquad \mathbf_0=\mathbf_0,
where
} is a strong approximation to the residual
of order
higher than
1.5. The strong HOLL discretization
converges with order
to the solution of (7.1).
Local linearization schemes
Depending on the way of computing
,
and
} different numerical schemes can be obtained. Every numerical implementation
of a strong Local Linear discretization
of any order is generically called
Strong Local Linearization (SLL) scheme.
Order 1 SLL schemes
yn+1=yn+L(Pp,q
Mnhn
gi(tn)\Delta
where the matrices
,
and
are defined as in (4.6),
is an
i.i.d. zero mean
Gaussian random variable with variance
, and
p +
q > 1. For large systems of SDEs, in the above scheme
is replaced by
.
Order 1.5 SLL schemes
yn+1=yn+L(Pp,q
Mn
gi(tn)\Delta
fx(tn,\widetilde{y
}_n)\mathbf_i(t_n)\Delta \mathbf_n^i+\frac (\Delta \mathbf_^h_-\Delta \mathbf_^)\right), \qquad \qquad (7.3)
where the matrices
,
and
are defined as
Mn=
\begin{bmatrix}
fx(tn,yn)&ft(tn,y
\left(I ⊗
(tn)\right)f(tn,yn)gj(tn)&f(tn,yn)\
0&0&1\
0&0&0
\end{bmatrix}
\inR(d+2) x ,
L=\left[\begin{array}{ll}
I&0d x \end{array}
\right],r\intercal=\left[\begin{array}{ll}
01 x &1
\end{array}
\right]
,
is a i.i.d. zero mean Gaussian random variable with variance
E\left((\Delta
)2\right)=
and covariance
and
p+q>1 . For large systems of SDEs, in the above scheme
is replaced by
.
Order 2 SLL-Taylor schemes
=yn+L(Pp,q
Mnhn
g
j\left(tn\right)\Delta
fx(tn,yn)gj\left(tn\right)\widetilde{J}\left(
\left(tn\right)\widetilde{J}\left(
\left(I ⊗
\left(tn\right)\right)fxx(tn,yn
\left(tn\right)
\widetilde{J} | |
| \left(j1,j2,0\right), |
(7.4)
where
,
,
and
are defined as in the order-1 SLL schemes, and
is order
2 approximation to the multiple
Stratonovish integral
.
Order 2 SLL-RK schemes
For SDEs with a single Wiener noise (m=1)
}(t_,\mathbf_;h_)+\frac\left(\mathbf_+\mathbf_\right) +\mathbf\left(t_\right) \Delta w_+\fracJ_ \quad (7.5)
where
k1=f(tn+
,yn+\widetilde{
\phi
}(t_,\mathbf_;\frac)+\gamma _)-\mathbf_(t_,\mathbf_)\widetilde(t_,\mathbf_;\frac)-\mathbf\left(t_,\mathbf_\right) -\mathbf_\left(t_,\mathbf_\right) \frac,
k2=f(tn+
,yn+\widetilde{
\phi
}(t_,\mathbf_;\frac)+\gamma _) -\mathbf_(t_,\mathbf_)\widetilde(t_,\mathbf_;\frac) -\mathbf\left(t_,\mathbf_\right) -\mathbf_\left(t_,\mathbf_\right) \frac,
with
\gamma\pm=
g\left(tn\right)l(\widetilde{J}\left(\pm\sqrt{2\widetilde{J}\left(1,1,0\right)hn
| 2 |
-
\widetilde{J} | |
| \left(1,0\right) |
} \Bigr) .
Here,
}(t_,\mathbf_;h_)=\mathbf(\mathbf_(2^\mathbf_h_))^\mathbf for low dimensional SDEs, and
}(t_,\mathbf_;h_)=\mathbf_^(h_,\mathbf_, \mathbf) for large systems of SDEs, where
,
,
,
and
are defined as in the order-
2 SLL-Taylor schemes,
p+q>1 and
.
Stability and dynamics
By construction, the strong LL and HOLL discretizations inherit the stability and dynamics of the linear SDEs, but it is not the case of the strong LL schemes in general. LL schemes (7.2)-(7.5) with
are
A-stable, including stiff and highly oscillatory linear equations. Moreover, for linear SDEs with
random attractors, these schemes also have a random attractor that converges in probability to the exact one as the stepsize decreases and preserve the
ergodicity of these equations for any stepsize. These schemes also reproduce essential dynamical properties of simple and coupled harmonic oscillators such as the linear growth of energy along the paths, the oscillatory behavior around 0, the symplectic structure of Hamiltonian oscillators, and the mean of the paths.
[17] For nonlinear SDEs with small noise (i.e., (7.1) with
), the paths of these SLL schemes are basically the nonrandom paths of the LL scheme (4.6) for ODEs plus a small disturbance related to the small noise. In this situation, the dynamical properties of that deterministic scheme, such as the linearization preserving and the preservation of the exact solution dynamics around hyperbolic equilibrium points and periodic orbits, become relevant for the paths of the SLL scheme. For instance, Fig 4 shows the evolution of domains in the phase plane and the energy of the stochastic oscillator
\begin{array}{ll}
dx(t)=y(t)dt,&x1(0)=0.01\
dy(t)=-(\omega2x(t)+\epsilonx4(t))dt+\sigmadwt,&x1(0)=0.1,
\end{array} (7.6)
and their approximations by two numerical schemes.
Weak LL methods for SDEs
Consider the d-dimensional stochastic differential equation
| m |
dx(t)=f(t,x(t))dt+\sum\limits | |
| i=1 |
g
i(t)dwi(t), t\in\left[t0,T\right], (8.1)
with initial condition
, where the drift coefficient
and the diffusion coefficient
are differentiable functions, and
is an
m-dimensional standard Wiener process.
Local Linear discretization
For a time discretization
, the order-
Weak Local Linear discretization of the solution of the SDE (8.1) is defined by the recursive relation
zn+1=zn+\phi\beta(tn,
zn;hn)+η(tn,zn;hn), with z0=x0,
where
\phi\beta(tn,zn
(f(tn,zn)+b\beta(tn,
zn)u)du
with
b\beta(tn,zn)=
\begin{cases}
ft(tn,zn)&for\beta=1\\
ft(tn,zn)+
\left(I ⊗
\left(tn\right)\right)fxx(tn,
zn)gj\left(tn\right)&for\beta
=2,
\end{cases}
and
is a zero mean stochastic process with variance matrix
\Sigma(tn,zn;\delta
G(tn+s)
G\intercal(tn
| | \intercal
| | f | | (tn,zn)(\delta-s) | | x | |
|
+s)e | |
ds.
Here,
,
denote the partial derivatives of
with respect to the variables
and
t, respectively,
the Hessian matrix of
with respect to
, and
G(t)=[g1(t),\ldots,gm(t)]
. The weak Local Linear discretization
converges with order
(=1,2) to the solution of (8.1).
Local Linearization schemes
Depending on the way of computing
and
different numerical schemes can be obtained. Every numerical implementation
of the Weak Local Linear discretization
is generically called
Weak Local Linearization (WLL) scheme.
Order 1 WLL scheme
yn+1=yn+B14+(B12
)1/2\xin
[18] [19] where, for SDEs with autonomous diffusion coefficients,
,
and
are the submatrices defined by the
partitioned matrix
, with
l{M}n=\left[\begin{array}{cccc}
fx(tn,yn)&GG\intercal&ft(tn,yn)&f(tn,yn)\
0&
(tn,yn)&0&0\
0&0&0&1\
0&0&0&0
\end{array}
\right]\inR(2d+2) x ,
and
is a sequence of
d-dimensional independent
two-points distributed random vectors satisfying
.
Order 2 WLL scheme
yn+1=yn+B16+(B14
)1/2\xin,
where
,
and
are the submatrices defined by the partitioned matrix
with
l{M}n=\left[\begin{array}{cccccc}
J&H2&H1&H0&a
2&a1\
0&-J\intercal&I&0&0
&0\
0&0&-J\intercal&I&0
&0\
0&0&0&-J\intercal&0
&0\
0&0&0&0&0&1\
0&0&0&0&0&0
\end{array}
\right]\inR(4d+2) x ,
J=fx(tn,yn)
a1=f(tn,yn) a
2=ft(tn,yn)+
(I ⊗ (gi(tn))\intercal)fxx
(tn,yn)gi(tn)
and
H0=G(tn)G\intercal(tn)
H1=G(tn)
G\intercal(tn)
H2=
.
Stability and dynamics
By construction, the weak LL discretizations inherit the stability and dynamics of the linear SDEs, but it is not the case of the weak LL schemes in general. WLL schemes, with
preserve the
first two moments of the linear SDEs, and inherits the mean-square stability or instability that such solution may have. This includes, for instance, the equations of coupled harmonic oscillators driven by random force, and large systems of stiff linear SDEs that result from the method of lines for linear stochastic partial differential equations. Moreover, these WLL schemes preserve the
ergodicity of the linear equations, and are geometrically ergodic for some classes of nonlinear SDEs.
[20] For nonlinear SDEs with small noise (i.e., (8.1) with
), the solutions of these WLL schemes are basically the nonrandom paths of the LL scheme (4.6) for ODEs plus a small disturbance related to the small noise. In this situation, the dynamical properties of that deterministic scheme, such as the linearization preserving and the preservation of the exact solution dynamics around hyperbolic equilibrium points and periodic orbits, become relevant for the mean of the WLL scheme. For instance, Fig. 5 shows the approximate mean of the SDE
dx=-t2xdt+
dwt, x(0)=1, (8.2)
computed by various schemes.
Historical notes
Below is a time line of the main developments of the Local Linearization (LL) method.
- Pope D.A. (1963) introduces the LL discretization for ODEs and the LL scheme based on Taylor expansion.[21]
- Ozaki T. (1985) introduces the LL method for the integration and estimation of SDEs. The term "Local Linearization" is used for first time.[22]
- Biscay R. et al. (1996) reformulate the strong LL method for SDEs.[23]
- Shoji I. and Ozaki T. (1997) reformulate the weak LL method for SDEs.[24]
- Hochbruck M. et al. (1998) introduce the LL scheme for ODEs based on Krylov subspace approximation.[25]
- Jimenez J.C. (2002) introduces the LL scheme for ODEs and SDEs based on rational Padé approximation.[26]
- Carbonell F.M. et al. (2005) introduce the LL method for RDEs.[27]
- Jimenez J.C. et al. (2006) introduce the LL method for DDEs.
- De la Cruz H. et al. (2006, 2007) and Tokman M. (2006) introduce the two classes of HOLL integrators for ODEs: the integrator-based and the quadrature-based.
- De la Cruz H. et al. (2010) introduce strong HOLL method for SDEs.
Notes and References
- Jimenez J.C. (2009). "Local Linearization methods for the numerical integration of ordinary differential equations: An overview". ICTP Technical Report. 035: 357–373.
- de la Cruz H.; Biscay R.J.; Carbonell F.; Jimenez J.C.; Ozaki T. (2006). "Local Linearization-Runge Kutta (LLRK) methods for solving ordinary differential equations". Lecture Note in Computer Sciences 3991: 132–139, Springer-Verlag. . .
- de la Cruz H.; Biscay R.J.; Jimenez J.C.; Carbonell F. (2013). "Local Linearization - Runge Kutta Methods: a class of A-stable explicit integrators for dynamical systems". Math. Comput. Modelling. 57 (3–4): 720–740. .
- Tokman M. (2006). "Efficient integration of large stiff systems of ODEs with exponential propagation iterative (EPI) methods". J. Comput. Physics. 213 (2): 748–776. .
- M. Hochbruck.; A. Ostermann. (2011). "Exponential multistep methods of Adams-type". BIT Numer. Math. 51 (4): 889–908. .
- Jimenez, J. C., & Carbonell, F. (2005). "Rate of convergence of local linearization schemes for initial-value problems". Appl. Math. Comput., 171(2), 1282-1295. .
- Carbonell F.; Jimenez J.C.; Pedroso L.M. (2008). "Computing multiple integrals involving matrix exponentials". J. Comput. Appl. Math. 213: 300–305. doi:10.1016/j.cam.2007.01.007.
- de la Cruz H.; Biscay R.J.; Carbonell F.; Ozaki T.; Jimenez J.C. (2007). "A higher order Local Linearization method for solving ordinary differential equations". Appl. Math. Comput. 185: 197–212. .
- Jimenez J.C.; Pedroso L.; Carbonell F.; Hernandez V. (2006). "Local linearization method for numerical integration of delay differential equations". SIAM J. Numer. Analysis. 44 (6): 2584–2609. .
- Jimenez J.C.; de la Cruz H. (2012). "Convergence rate of strong Local Linearization schemes for stochastic differential equations with additive noise". BIT Numer. Math. 52 (2): 357–382. .
- Jimenez J.C.; Biscay R.; Mora C.; Rodriguez L.M. (2002). "Dynamic properties of the Local Linearization method for initial-value problems". Appl. Math. Comput. 126: 63–68. .
- Jimenez J.C.; Sotolongo A.; Sanchez-Bornot J.M. (2014). "Locally Linearized Runge Kutta method of Dormand and Prince". Appl. Math. Comput. 247: 589–606. .
- Naranjo-Noda, Jimenez J.C. (2021) "Locally Linearized Runge_Kutta method of Dormand and Prince for large systems of initial value problems." J.Comput. Physics. 426: 109946. .
- Jimenez J.C.; Carbonell F. (2009). "Rate of convergence of local linearization schemes for random differential equations". BIT Numer. Math. 49 (2): 357–373. .
- Jimenez J.C, Shoji I., Ozaki T. (1999) "Simulación of stochastic differential equation through the local linearization method. A comparative study". J. Statist. Physics. 99: 587-602, .
- de la Cruz H.; Biscay R.J.; Jimenez J.C.; Carbonell F.; Ozaki T. (2010). "High Order Local Linearization methods: an approach for constructing A-stable high order explicit schemes for stochastic differential equations with additive noise". BIT Numer. Math. 50 (3): 509–539. .
- de la Cruz H.; Jimenez J.C.; Zubelli J.P. (2017). "Locally Linearized methods for the simulation of stochastic oscillators driven by random forces". BIT Numer. Math. 57: 123–151. .
- Jimenez J.C.; Carbonell F. (2015). "Convergence rate of weak Local Linearization schemes for stochastic differential equations with additive noise". J. Comput. Appl. Math. 279: 106–122. .
- Carbonell F.; Jimenez J.C.; Biscay R.J. (2006). "Weak local linear discretizations for stochastic differential equations: convergence and numerical schemes". J. Comput. Appl. Math. 197: 578–596. .
- Hansen N.R. (2003) "Geometric ergodicity of discre-time approximations to multivariate diffusion". Bernoulli. 9 : 725-743, .
- Pope, D. A. (1963). "An exponential method of numerical integration of ordinary differential equations". Comm. ACM, 6(8), 491-493. .
- Ozaki, T. (1985). "Non-linear time series models and dynamical systems". Handbook of statistics, 5, 25-83. .
- Biscay, R., Jimenez, J. C., Riera, J. J., & Valdes, P. A. (1996). "Local linearization method for the numerical solution of stochastic differential equations". Annals Inst. Statis. Math. 48(4), 631-644. .
- Shoji, I., & Ozaki, T. (1997). "Comparative study of estimation methods for continuous time stochastic processes". J. Time Series Anal. 18(5), 485-506. .
- Hochbruck, M., Lubich, C., & Selhofer, H. (1998). "Exponential integrators for large systems of differential equations". SIAM J. Scient. Comput. 19(5), 1552-1574. .
- Jimenez, J. C. (2002). "A simple algebraic expression to evaluate the local linearization schemes for stochastic differential equations". Appl. Math. Letters, 15(6), 775-780. .
- Carbonell, F., Jimenez, J. C., Biscay, R. J., & De La Cruz, H. (2005). "The local linearization method for numerical integration of random differential equations". BIT Num. Math. 45(1), 1-14. .