Next Article in Journal
In Search of the Densest Subgraph
Previous Article in Journal
A Rigid Motion Artifact Reduction Method for CT Based on Blind Deconvolution
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

A Collocation Method for the Numerical Solution of Nonlinear Fractional Dynamical Systems

by
Francesca Pitolli
Department SBAI, University of Roma “La Sapienza”, 00161 Roma, Italy
Current address: Via Antonio Scarpa 16, 00161 Roma, Italy.
Algorithms 2019, 12(8), 156; https://doi.org/10.3390/a12080156
Submission received: 5 July 2019 / Revised: 26 July 2019 / Accepted: 30 July 2019 / Published: 31 July 2019

Abstract

:
Fractional differential problems are widely used in applied sciences. For this reason, there is a great interest in the construction of efficient numerical methods to approximate their solution. The aim of this paper is to describe in detail a collocation method suitable to approximate the solution of dynamical systems with time derivative of fractional order. We will highlight all the steps necessary to implement the corresponding algorithm and we will use it to solve some test problems. Two Mathematica Notebooks that can be used to solve these test problems are provided.

1. Introduction

Presently, fractional differential problems are well established models to describe a great variety of real-world phenomena [1,2,3,4]. Since their analytical solution can be obtained in just a few cases, numerical methods are required for its approximation. A key point to construct efficient numerical methods is the ability to reproduce the nonlocal behavior of the fractional derivative. This is a challenging goal especially in cases of nonlinear problems.
In the literature several methods, such as finite difference methods, spectral methods, finite element methods, collocation methods, were proposed to solve fractional differential problems [5,6,7]. In this context, collocation methods are revealed particularly attractive since their global nature is suitable to catch the non-locality of the fractional derivative.
The aim of this paper is to describe in detail how to apply the fractional collocation method introduced in [8] for the numerical solution of nonlinear dynamical systems with time derivative of fractional order. The method was already used to numerically solve some linear and nonlinear problems with fractional time derivative [9,10,11]. Here, we will describe how to use the method to solve differential problems of a more general form and discuss its implementation issues. To allow the reader to easily follow the description of the algorithm, we limit ourselves to the case when the approximate solution belongs to the spline space. In particular, we will show some numerical tests when using both linear and cubic splines and provide two Mathematica Notebooks [12] that can be used to solve such test problems.
The paper is organized as follows. In Section 2 the fractional differential problem we are interested in and the collocation method we use are briefly recalled. In particular, the spline space we use to construct the approximate solution is described in Section 2.2 and Section 2.3; the analytical expression of both the basis functions and their fractional derivative is given in Section 2.3 and Section 2.4; the algorithm of the collocation method is described in Section 2.5. The results of the numerical tests are shown in Section 3 and briefly discussed in Section 4. Finally, in Section 5 some conclusions are given.

2. Materials and Methods

In this section, after describing the differential problem we are interested in, we recall the main features of the numerical method we use to approximate its solution.

2.1. Nonlinear Fractional Dynamical Systems

Let Y ( t ) : R R m and F : R m + 1 R m be real-valued vector functions, and Y 0 R m be a real vector. A nonlinear dynamical system with derivative of fractional, i.e., noninteger, order in time can be written as
C D t β Y ( t ) = F ( t , Y ( t ) ) , t > 0 , 0 < β < 1 , Y ( 0 ) = Y 0 .
where C D t β Y ( t ) denotes the Caputo fractional derivative with respect to the time t. For a sufficiently smooth vector function Y ( t ) = [ y 1 ( t ) , y 2 ( t ) , , y m ( t ) ] T , its Caputo derivative is defined as
D t β Y ( t ) : = D t β y 1 ( t ) , D t β y 2 ( t ) , , D t β y m ( t ) T ,
where
D t β y ( t ) : = 1 Γ ( k β ) 0 x y ( k ) ( τ ) ( x τ ) β + 1 k d τ , k 1 < β < k , k N , t > 0 ,
and Γ denotes the Euler’s gamma function. For details on fractional calculus and fractional derivatives see, for instance, [13,14,15,16].
The existence, unicity and smoothness of the solution to (1) can be analyzed by transforming the problem into an integral equation [17,18].

2.2. The Cardinal B-Splines

The cardinal B-splines are piecewise polynomials with breakpoints on integer knots. Given the sequence of simple integer knots I = { 0 , 1 , , n + 1 } , the Cardinal B-spline of integer degree n 0 can be defined by applying the divided difference operator to the truncated power function t + n : = max ( t , 0 ) n on the knots I :
B n ( t ) : = ( n + 1 ) [ 0 , 1 , , n + 1 ] ( x t ) + n = = ( n + 1 ) M 1 , x , x 2 , , x n , ( x t ) + n 0 , 1 , 2 , , n , n + 1 M 1 , x , x 2 , , x n , x n + 1 0 , 1 , 2 , , n , n + 1 = 1 n ! Δ n + 1 t + n ,
where
M f 1 ( x ) , f 2 ( x ) , , f n ( x ) x 1 , x 2 , , x n = f 1 ( x 1 ) f n ( x 1 ) f n ( x 1 ) f 1 ( x 2 ) f n ( x 2 ) f n ( x 2 ) f 1 ( x n ) f n ( x n ) f n ( x n )
is the collocation matrix of the function system { f 1 ( x ) , f 2 ( x ) , , f n ( x ) } on the nodes { x 1 , x 2 , , x n }  and
Δ n f ( t ) = k = 0 n ( 1 ) k n k f ( t k )
is the backward finite difference operator.
We recall that B n ( t ) is compactly supported on [ 0 , n + 1 ] , is positive in ( 0 , n + 1 ) and belongs to C n 1 ( R ) . For details and further properties on polynomial B-splines, see, for instance, [19].

2.3. B-Spline Bases on the Semi-Infinite Interval

The system of the integer translates B n = B n ( t k ) , k Z forms a function basis for the space of piecewise polynomials of degree n on the real line and enjoys many useful properties that make it especially suitable in approximation problems. In particular, B n is a partition of unity, reproduces polynomials up to degree n, satisfies the Strang-Fix theory and has approximation order n + 1  (cf. [19]).
To construct a function basis in the semi-infinite interval [ 0 , ) we restrict B n to this interval. The interior functions, i.e., the functions B n ( t k ) with k 0 , which have support [ k , k + n + 1 ] all contained in [ 0 , ) , remain unchanged. The left-edge boundary functions, i.e., the functions B n ( t k ) with n k 1 , whose support is not all contained in [ 0 , ) , are modified introducing a knot of multiplicity n + 1 at the left-edge of the interval. Thus, the B-spline basis on the semi-infinite interval [ 0 , ) is
N n = { N k n ( t ) , 0 k n 1 } { B n ( t k ) , k 0 } , t [ 0 , ) ,
where N k n ( t ) , 0 k n 1 , are the left-edge boundary functions. In [20] their analytical expressions is given in terms of suitable collocation matrices:
N k n ( t ) = ( k + 1 ) | T n k | | P k n | , 0 k n 1 ,
where T k n is the ( k + 1 ) order collocation matrix
T k n = M x n k + 1 , x n k + 2 , x n , ( x t ) + n 1 , 2 , k , k + 1 ,
and P k n is the ( k + 1 ) order collocation matrix
P k n = M x n k + 1 , x n k + 2 , x n , x n + 1 1 , 2 , k , k + 1 .
The B-spline bases can be generalized to any sequence of equidistant knots on the interval [ 0 , ) by mapping t t / h , where h > 0 is the refinement step:
N n h = { N k n h ( t ) , k 0 } , t [ 0 , ) ,
where N k n h ( t ) = N k n t h , 0 k n 1 , are the left-edge functions and N k n h ( t ) = B n t h ( k n ) , k n , are the interior functions. We observe that at the left-edge of the interval the basis functions satisfy the initial conditions
N k n h ( 0 ) = δ k 0 ,
where δ k j denotes the Kronecker delta. Consequently, just the first basis function N 0 n h does not vanish in the origin with N 0 n h ( 0 ) = 1 .

2.4. The Fractional Derivative of the Cardinal B-Splines

The Caputo fractional derivative of the interior functions can be easily evaluated by the differentiation rule (cf. [8,21])
C D t β B n ( t ) = Δ n + 1 t + n β Γ ( n β + 1 ) , t 0 , 0 < β < n 1 .
The Caputo fractional derivative of the left-edge boundary functions can be obtained by applying the fractional differentiation operator to their analytical expression [20]:
C D t β N k n ( t ) = ( k + 1 ) | P k n | r = 1 k + 1 ( 1 ) r + k + 1 C D t β ( r t ) + n | T k n r | , 0 k n 1 ,
where
T k n r = 1 1 1 2 n k + 1 2 n k + 2 2 n ( r 1 ) n k + 1 ( r 1 ) n k + 2 ( r 1 ) n ( r + 1 ) n k + 1 ( r + 1 ) n k + 2 ( r + 1 ) n ( k + 1 ) n k + 1 ( k + 1 ) n k + 2 ( k + 1 ) n .
Equation (8) shows that C D t β N k n is a linear combination of the fractional derivative of the translates of the truncated power function whose expression is given by
C D t β ( r t ) + n = 1 Γ ( k + 1 β ) ( 1 ) k n ! ( n k ) ! r n k t β k = 0 n k ( 1 ) n k ( 1 ) ( k + 1 β ) t r + ( 1 ) n + k n ! Γ ( n + 1 β ) ( t r ) + n β , k 1 < β < k ,
where ( p ) denotes the rising Pochhammer symbol [20].

2.5. The Collocation Method

We approximate the solution to the dynamical system (1) by a linear combination of the functions belonging to the basis N n h :
Y n h ( t ) = k 0 Λ k N k n h ( t ) , t 0 ,
where Λ k R m , k 0 , are unknown vectors that can be determined requiring that Y n h ( t ) satisfies the differential problem (1) on a set of collocation points.
Let I = [ 0 , T ] be the discretization interval and let T = { 0 < t 1 < < t n p 1 < t n p = T } be a set of n p collocation points. The restriction of Y n h ( t ) to the interval I is
Y n h ( t ) = k = 0 n k Λ k N k n h ( t ) , t I ,
where n k = T / h + n 1 . Thus, the discretized version of (1) reads
C D t β Y n h ( t p ) = F ( t p , Y n h ( t p ) ) , 1 p n p , Y n h ( 0 ) = Y 0 .
First of all, we observe that due to (6) and the partition of unity property, the initial condition is easily satisfied by setting
Y n h ( t ) = Y 0 + k = 1 n k Λ k N k n h ( t ) .
Now, using (13) in the first Equation of (12), we get
k = 1 n k Λ k C D t β N k n h ( t p ) = F t p , Y 0 + k = 1 n k Λ k N k n h ( t p ) , 1 p n p .
This is a nonlinear system with m × n p equations and m × n k unknowns. The existence of a unique solution to (14) depends on the existence of a unique solution to (1) [17,18,22].
The convergence and the stability of the method can be proved following the same line of reasoning in [8,11] (cf. also [22]). For sufficiently smooth Y ( t ) the method is stable and the convergence is guaranteed with convergence order at least β , i.e., Y ( t ) Y n h ( t ) κ h β , where Y ( t ) = max 1 i m ( max t [ 0 , T ] | y i ( t ) | ) and κ is a constant independent of h. Moreover, polynomial reproduction implies that the spline approximation Y n h ( t ) is exact whenever the solution Y ( t ) is a polynomial of degree at most n.
The solution to the nonlinear system (14) can be approximated by the Gauss-Newton method. Let
L = [ Λ 1 , Λ 2 , , Λ n k ] T R m n k
be the unknown vector and let
M 0 = N k n h ( t p ) , 1 p n p , 1 k n k R n p × n k ,
M β = C D t β N k n h ( t p ) , 1 p n p , 1 k n k R n p × n k
be the collocation matrices of the basis functions and of their fractional derivative, respectively. Let  G : R m n k R m n p be the vector-valued function whose entries are the equations of the nonlinear system (14). Then, the nonlinear system can be written as
G ( L ) = I m M β L Q ( L ) = 0 ,
where I m is the identity matrix of order m and the vector Q ( L ) = F ( T , Y n h ( T ) ) R m n p stands for the know term F evaluated in all the collocation points. Here, the symbol ⊗ denotes the Kronecker product on two matrices. The Gauss-Newton method starts by an initial guess L ( 0 ) and approximates the solution to the nonlinear system by the iterative procedure
L ( + 1 ) = L ( ) V ( ) , 0 ,
where the vector V ( ) is the solution to the linear system
J G ( L ( ) ) V ( ) = G ( L ( ) ) ,
and J G ( L ) is the Jacobian matrix of G ( L ) . For a general nonlinear fractional differential problem of type (1) the Jacobian matrix can be written as
J G ( L ) = I m M β J F ( T , Y n h ( T ) ) ( I m M 0 ) .
where J F ( T , Y n h ( T ) ) denotes the Jacobian matrix of the known term F evaluated in the collocation points. Here, the symbol ∘ denotes the entrywise product of arrays. To have a unique solution to the linear system (17), the number of the collocation points and the number of basis functions must be chosen so that n p n k . In case of equality the linear system is squared otherwise we get an overdetermined linear system that can be solved by the least squares method (cf. [11]).
In practical computation, the iterative procedure is stopped when V ( ) / L ( + 1 ) τ , where τ is a given tolerance. It is known that the local convergence of the Gauss-Newton method is not guaranteed, and particular attention should be paid in implementing the method.
The flow chart showing all the steps needed to implement the method is displayed in Figure 1.

3. Results

In this section, we give some algorithmic details on the collocation method described in the previous section when using linear or cubic splines to approximate its solution. Two Mathematica Notebooks (Supplementary Materials) [12] describing all the necessary steps to implement the algorithm for solving some numerical tests are provided as Supplementary Materials.

3.1. The Linear B-Spline Basis

Given a finite interval [ 0 , T ] , the linear B-spline basis
N 1 h = { N k 1 h ( t ) , 0 k n k } , t [ 0 , T ] ,
has just one left-edge boundary function, i.e., N 01 h ( t ) , and n k interior functions, i.e., N k 1 h ( t ) , 1 k n k , where n k = T / h . Obviously, T and h must be chosen in order n k N . The explicit expression of the basis functions is well known and is given by
N 01 ( t ) = ( 1 t ) , 0 t 1 , 0 , otherwise ,
N k 1 ( t ) = B 1 ( t k + 1 ) , 1 k n k ,
where
B 1 ( t ) = t , 0 t 1 , 2 t , 1 t 2 , 0 , otherwise .
The Caputo derivative of fractional order 0 < β < 1 of the basis functions has the following expression
C D t β N 01 ( t ) = 1 Γ ( 2 β ) t 1 β + ( t 1 ) + 1 β ,
C D t β N k 1 ( t ) = C D t β B 1 ( t k + 1 ) , 1 k n k ,
where
C D t β B 1 ( t ) = 1 Γ ( 2 β ) Δ 2 t + 1 β
is the Caputo derivative of the linear B-spline.
The edge function N 01 and the linear cardinal B-spline B 1 are shown in Figure 2 while their fractional derivative of order β = 0.5 is shown in Figure 3.

3.2. The Cubic B-Spline Basis

Given a finite interval [ 0 , T ] , the cubic B-spline basis
N 3 h = { N k 3 h ( t ) , 0 k n k } , t [ 0 , T ] ,
consists of 3 left-edge boundary functions, i.e., N k 3 h ( t ) , 0 k 2 , and n k 2 interior functions, i.e., N k 3 h ( t ) , 3 k n k , where n k = T / h + 2 N . Their explicit expression can be evaluated by Equations (4) and (5). For the convenience of the reader we give the resulting expression taken from [20]:
N 03 ( t ) = ( 1 t ) 3 , 0 t 1 , 0 , otherwise ,
N 13 ( t ) = 1 4 ( 2 t ) 3 2 ( 1 t ) 3 , 0 t 1 , 1 4 ( 2 t ) 3 , 1 < t 2 , 0 , otherwise ,
N 23 ( t ) = 1 6 ( 3 t ) 3 3 4 ( 2 t ) 3 + 3 2 ( 1 t ) 3 , 0 t 1 , 1 6 ( 3 t ) 3 3 4 ( 2 t ) 3 , 1 < t 2 , 1 6 ( 3 t ) 3 , 2 < t 3 , 0 , otherwise .
N k 3 ( t ) = B 3 ( t k + 3 ) , 3 k n k ,
where
B 3 ( t ) = 1 6 t 3 , 0 t 1 , 1 6 3 t 3 + 12 t 2 12 t + 4 , 1 t 2 , 1 6 3 ( 4 t ) 3 + 12 ( 4 t ) 2 12 ( 4 t ) + 4 , 2 t 3 , 1 6 ( 4 t ) 3 , 3 t 4 , 0 , otherwise .
The Caputo derivative of fractional order 0 < β < 1 of the basis functions has analytical expression
C D t β N 03 ( t ) = 3 Γ ( 4 β ) 2 t 2 2 ( 3 β ) t + ( 2 β ) 2 t 1 β + 2 ( t 1 ) + 3 β ,
C D t β N 13 ( t ) = 3 Γ ( 4 β ) ( 7 2 t 2 3 ( 3 β ) t + ( 2 β ) 2 t 1 β 4 ( t 1 ) + 3 β + 1 2 ( t 2 ) + 3 β ,
C D t β N 23 ( t ) = 3 Γ ( 4 β ) 11 6 t 2 + ( 3 β ) t t 1 β + 3 ( t 1 ) + 3 β 3 2 ( t 2 ) + 3 β + 1 3 ( t 3 ) + 3 β ,
C D t β N k 3 ( t ) = C D t β B 3 ( t k + 3 ) , 3 k n k ,
where
C D t β ( r t ) + 3 = 3 Γ ( 4 β ) ( 2 t 2 2 ( 3 β ) r t + ( 2 β ) 2 r 2 ) t 1 β 2 ( t r ) + 3 β
and
C D t β B 3 ( t ) = 1 Γ ( 4 β ) Δ 4 t + 3 β
are the Caputo derivatives of the truncated power function of degree 3 and of the cubic B-spline, respectively.
The edge functions N 03 , N 13 , N 23 and the cubic cardinal B-spline B 3 are shown in Figure 4 while their fractional derivative of order β = 0.5 is shown in Figure 5.

3.3. Numerical Solution of Linear Dynamical Systems

The collocation method described in Section 2.5 can be also used to solve linear problems of type
C D t β Y ( t ) = A Y ( t ) , t > 0 , 0 < β < 1 , Y ( 0 ) = Y 0 ,
where A R m × m is a real matrix. In this case, the Jacobian matrix is independent of and reduces to
J G = I m M β A ( I m M 0 ) ,
so that the numerical solution is computed by solving a linear system (cf. [11]). As a test problem we consider the linear dynamical system
C D 1 2 y 1 ( t ) = y 1 ( t ) + y 2 ( t ) + y 3 ( t ) , C D 1 2 y 2 ( t ) = y 1 ( t ) + y 2 ( t ) y 3 ( t ) , t > 0 , C D 1 2 y 3 ( t ) = π 2 y 3 ( t ) , y 1 ( 0 ) = 0.05 , y 2 ( 0 ) = 0.05 , y 3 ( 0 ) = 0.05 .
taken from [23]. We solved the problem on the discretization interval [ 0 , 8 ] using a set of equidistant collocation nodes with time step Δ t = 1 32 for a total of 254 collocation points. We used as function basis the cubic B-spline basis and the linear B-splines basis with h = 1 16 so that the basis has 131 functions and 129 functions, respectively. Thus, the final linear system to be solved has 765 equations and 390 unknowns in the first case and 765 equations and 384 unknowns in the second case. The numerical solutions obtained by the algorithm implemented in the Mathematica Notebooks (Supplementary Materials) are displayed in Figure 6.

3.4. Numerical Solution of Nonlinear Dynamical Systems

We solved the nonlinear dynamical system (cf. [23])
C D 1 2 y 1 ( t ) = y 1 ( t ) + y 2 ( t ) + 100 π y 1 2 ( t ) + y 3 ( t ) , C D 1 2 y 2 ( t ) = y 1 ( t ) + y 2 ( t ) + 100 π y 1 2 ( t ) y 3 ( t ) , t > 0 , C D 1 2 y 3 ( t ) = y 3 2 ( t ) π 200 y 3 ( t ) , y 1 ( 0 ) = 0.05 , y 2 ( 0 ) = 0.05 , y 3 ( 0 ) = 0.05 .
using the same collocation points and the same function basis as in the linear case.
The numerical solutions obtained by the algorithm implemented in the Mathematica Notebooks (Supplementary Materials) are displayed Figure 7.

4. Discussion

The examples above show that the collocation method described in Section 2 is easy to implement and give accurate results both in the linear and cubic case. We notice that the Mathematica Notebooks (Supplementary Materials) we provided are just intended for explaining in detail the algorithm shown in Figure 1. To solve high dimensional problems the algorithm should be implemented in a more efficient way. For instance, the slight instabilities appearing near the initial point in Figure 7 can be avoided by solving the overdetermined linear system (17) by Krylov methods [24]. Moreover, the Jacobian matrix J G can be compressed by usual techniques [25]. Taking these remarks into account, the method can be used not only to solve several kinds of initial problems but also to solve boundary value problems.

5. Conclusions

We presented a collocation method suitable to solve nonlinear differential problems with time fractional derivative. The strength of the method is its ability to approximate exactly the fractional derivative of the approximating function by using the explicit formulas (7) and (8). Moreover, the method is easy to implement since required just the construction of the nonlinear system (14). With respect to the collocation method considered in [17], where the number of equations is equal to the number of unknowns, in our examples the number of equations is almost twice the number of unknowns. To apply the method in case of high dimensional problems, the number of equations should be reduced. This can be done, for instance, using non-equidistant collocation points as done in [17]. In particular, using Gaussian nodes instead of equidistant nodes not only could reduce the dimension of the nonlinear system but could also improve the accuracy of the method. Finally, a detailed analysis of the stability and the convergence of the method should be conducted. This will be the subject of a forthcoming paper.

Supplementary Materials

The following are available online at https://www.mdpi.com/1999-4893/12/8/156/s1, Mathematica Notebooks: CollMethod_FractTimeNonLinDynSistem_LinearBspline.nb (linear spline approximation), CollMethod_FractTimeNonLinDynSistem_CubicBspline.nb (cubic spline approximation).

Funding

This research received no external funding.

Conflicts of Interest

The authors declare no conflict of interest.

References

  1. Mainardi, F. Fractional Calculus and Waves in Linear Viscoelasticity: An Introduction to Mathematical Models; World Scientific: Singapore, 2010. [Google Scholar]
  2. Hilfer, R. Applications of Fractional Calculus in Physics; World Scientific: Singapore, 2000. [Google Scholar]
  3. Kilbas, A.A.; Srivastava, H.M.; Trujillo, J.J. Theory and Applications of Fractional Differential Equations; Elsevier Science: Amsterdam, The Netherlands, 2006. [Google Scholar]
  4. Tarasov, V.E. Fractional Dynamics. Applications of Fractional Calculus to Dynamics of Particles, Fields and Media; Nonlinear Physical Science; Springer: Berlin, Germany, 2010. [Google Scholar]
  5. Baleanu, D.; Diethelm, K.; Scalas, E.; Trujillo, J.J. Fractional Calculus: Models and Numerical Methods; World Scientific: Singapore, 2016. [Google Scholar]
  6. Li, C.; Zeng, F. Numerical Methods for Fractional Calculus; A Chapman & Hall Book/CRC Press: Boca Raton, FL, USA, 2015. [Google Scholar]
  7. Li, C.; Chen, A. Numerical methods for fractional partial differential equations. Int. J. Comput. Math. 2018, 95, 1048–1099. [Google Scholar] [CrossRef]
  8. Pezza, L.; Pitolli, F. A multiscale collocation method for fractional differential problems. Math. Comput. Simul. 2018, 147, 210–219. [Google Scholar] [CrossRef]
  9. Pezza, L.; Pitolli, F. A fractional spline collocation-Galerkin method for the time-fractional diffusion equation. Commun. Appl. Ind. Math. 2018, 9, 104–120. [Google Scholar] [CrossRef] [Green Version]
  10. Pitolli, F. A fractional B-spline collocation method for the numerical solution of fractional predator-prey models. Fractal Fract. 2018, 2, 13. [Google Scholar] [CrossRef]
  11. Pellegrino, E.; Pezza, L.; Pitolli, F. A collocation method in spline spaces for the solution of linear fractional dynamical systems. arXiv 2019, arXiv:1907.10927. [Google Scholar]
  12. Wolfram Research, Inc. Mathematica, Version 12.0.0.0; Wolfram Research: Champaign, IL, USA, 2019. [Google Scholar]
  13. Diethelm, K. The Analysis of Fractional Differential Equations: An Application-Oriented Exposition Using Differential Operators of Caputo Type; Springer: Berlin, Germany, 2010. [Google Scholar]
  14. Sabatier, J.; Agrawal, O.; Tenreiro Machado, J.A. Advances in Fractional Calculus; Springer: Berlin, Germany, 2007. [Google Scholar]
  15. Samko, S.G.; Kilbas, A.A.; Marichev, O.I. Fractional Integrals and Derivatives; Gordon & Breach Science Publishers: London, UK, 1993. [Google Scholar]
  16. Podlubny, I. Fractional Differential Equations; Academic Press: Cambridge, MA, USA, 1998. [Google Scholar]
  17. Pedas, A.; Tamme, E.; Vikerpuur, M. Smoothing transformation and spline collocation for nonlinear fractional initial and boundary value problems. J. Comput. Appl. Math. 2017, 317, 1–16. [Google Scholar] [CrossRef]
  18. Vainikko, G. Multidimensional Weakly Singular Integral Equations; Lecture Notes in Mathematics; Springer: Berlin, Germany, 1993. [Google Scholar]
  19. Schumaker, L.L. Spline Functions: Basic Theory; Cambridge University Press: Vambridge, UK, 2007. [Google Scholar]
  20. Pitolli, F. Optimal B-spline bases for the numerical solution of fractional differential problems. Axioms 2018, 7, 46. [Google Scholar] [CrossRef]
  21. Unser, M.; Blu, T. Fractional splines and wavelets. SIAM Rev. 2000, 42, 43–67. [Google Scholar] [CrossRef]
  22. Ascher, U. Discrete least squares approximations for ordinary differential equations. SIAM J. Num. Anal. 1978, 15, 478–496. [Google Scholar] [CrossRef]
  23. Li, C.; Ma, Y. Fractional dynamical system and its linearization theorem. Nonlinear Dyn. 2013, 71, 621–633. [Google Scholar] [CrossRef]
  24. Calvetti, D.; Pitolli, F.; Somersalo, E.; Vantaggi, B. Bayes meets Krylov: Statistically inspired preconditioners for CGLS. SIAM Rev. 2018, 60, 429–461. [Google Scholar] [CrossRef]
  25. Mallat, S. A Wavelet tour of Signal Processing. The Sparse Way; Elsevier: Amsterdam, The Netherlands, 2009. [Google Scholar]
Figure 1. The flow chart of the collocation method described in Section 2.
Figure 1. The flow chart of the collocation method described in Section 2.
Algorithms 12 00156 g001
Figure 2. The left-edge function N 01 (blue) and the linear cardinal B-spline B 1 (orange).
Figure 2. The left-edge function N 01 (blue) and the linear cardinal B-spline B 1 (orange).
Algorithms 12 00156 g002
Figure 3. The fractional derivatives C D t N 01 (blue) and C D t B 1 (orange).
Figure 3. The fractional derivatives C D t N 01 (blue) and C D t B 1 (orange).
Algorithms 12 00156 g003
Figure 4. The left-edge functions N 03 (blue), N 13 (orange), N 23 (green), and the cubic cardinal B-spline B 3 (red).
Figure 4. The left-edge functions N 03 (blue), N 13 (orange), N 23 (green), and the cubic cardinal B-spline B 3 (red).
Algorithms 12 00156 g004
Figure 5. The fractional derivatives C D t N 03 (blue), C D t N 13 (orange), C D t N 23 (green), C D t B 3 (red).
Figure 5. The fractional derivatives C D t N 03 (blue), C D t N 13 (orange), C D t N 23 (green), C D t B 3 (red).
Algorithms 12 00156 g005
Figure 6. The numerical solution Y n h ( t ) for n = 3 (solid lines) and n = 1 (dashed line) of the linear dynamical system (37). In both cases h = 1 16 . The first, second and third entries of the vector Y n h ( t ) are displayed in blue, yellow and green, respectively.
Figure 6. The numerical solution Y n h ( t ) for n = 3 (solid lines) and n = 1 (dashed line) of the linear dynamical system (37). In both cases h = 1 16 . The first, second and third entries of the vector Y n h ( t ) are displayed in blue, yellow and green, respectively.
Algorithms 12 00156 g006
Figure 7. The numerical solution Y n h ( t ) for n = 3 (solid lines) and n = 1 (dashed line) of the nonlinear dynamical system (38). In both cases h = 1 16 . The first, second and third entries of the vector Y n h ( t ) are displayed in blue, yellow and green, respectively.
Figure 7. The numerical solution Y n h ( t ) for n = 3 (solid lines) and n = 1 (dashed line) of the nonlinear dynamical system (38). In both cases h = 1 16 . The first, second and third entries of the vector Y n h ( t ) are displayed in blue, yellow and green, respectively.
Algorithms 12 00156 g007

Share and Cite

MDPI and ACS Style

Pitolli, F. A Collocation Method for the Numerical Solution of Nonlinear Fractional Dynamical Systems. Algorithms 2019, 12, 156. https://doi.org/10.3390/a12080156

AMA Style

Pitolli F. A Collocation Method for the Numerical Solution of Nonlinear Fractional Dynamical Systems. Algorithms. 2019; 12(8):156. https://doi.org/10.3390/a12080156

Chicago/Turabian Style

Pitolli, Francesca. 2019. "A Collocation Method for the Numerical Solution of Nonlinear Fractional Dynamical Systems" Algorithms 12, no. 8: 156. https://doi.org/10.3390/a12080156

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop