Skip to main content

ORIGINAL RESEARCH article

Front. Phys., 08 October 2020
Sec. Statistical and Computational Physics
Volume 8 - 2020 | https://doi.org/10.3389/fphy.2020.00293

An Efficient Numerical Technique for Solving Time-Fractional Generalized Fisher's Equation

  • 1Division of Science and Technology, Department of Mathematics, University of Education Lahore, Lahore, Pakistan
  • 2Department of Mathematics, University of Sargodha, Sargodha, Pakistan
  • 3Department of Mathematics, Jaipur Engineering College & Research Centre (JECRC) University, Jaipur, India

This paper extends the existing Fisher's equation by adding the source term and generalizing the degree β of the non-linear part. A numerical solution of a modified Fisher's equation for different values of β using the cubic B-spline collocation scheme is also investigated. The fractional derivative in a time dimension is discretized in Caputo's form based on the L1 formula, while cubic B-spline basis functions are used to interpolate the spatial derivative. The non-linear part in the model is linearized by the modified formula. The efficiency of the proposed scheme is examined by simulating four test examples with different initial and boundary conditions. The effect of different parameters is discussed and presented in tables and graphics form. Moreover, by using the Von Neumann stability formula, the proposed scheme is shown to be unconditionally stable. The results of error norms reflect that the present scheme is suitable for non-linear time fractional differential equations.

1. Introduction

Fractional calculus-based models have been used in different fields of engineering and science. In the last few years, fractional differential equations have been widely used. The main advantage of using fractional order differential equation is its non-local property in mathematical modeling. During the twentieth century, the authors [13] added a significant amount of research in the area of fractional calculus. The applications can be seen in different branches of science and engineering, such as finance [4], nano-technology [5], electrodynamics [6], and visco-elasticity. Fisher's equation is commonly used in epidemics and bacteria, branching Brownian motion, neolithic transitions and chemical kinetics [79]. The spatial and temporal propagation of a virile gene in an infinite medium has been explained by Fisher [10]. Several numerical methods for differential equations with Riemann-Liouville and Caputo sense fractional order derivatives have been applied and analyzed [1113].

The time-fractional Fisher's equation used in Baranwal et al. [14] has been modified in this paper in two different ways: (1) by introducing the source term or (2) by generalizing the non-linear power.

The modified form of time fractional Fisher's equation is:

αZ(r,t)tα-ν2Z(r,t)r2-Z(r,t)(1-Zβ(r,t))                   =f(r,t),  arb,  0<α1,  t0,    (1.1)

with the initial condition

Z(r,0)=ψ(r),        arb,    (1.2)

and the boundary conditions

Z(a,t)=ψ1(t),    Z(b,t)=ψ2(t),      t0,    (1.3)

where ν is a parameter of viscosity.

The Caputo and Riemann-Liouville fractional derivatives have a wide range of applications [1517]. The Caputo derivative is used in this work:

αZ(r,t)tα={1Γ(q-a)0tqZ(r,s)tq(t-s)q-α-1ds,q-1<α<q,qZ(r,t)tq,q=α.

The Caputo derivative is discretized by the L1 formula [18]:

αhtα|tn=1(Δt)αΓ(2-α)k=0n-1λkα[h(tn-k)-h(tn-k-1)]+O(Δt),    (1.4)

where λk=(k+1)1-α-k1-α.

In this paper, we generalized the linearization formula used in [19]:

(Zβ)jn+1=βZjn+1(Zβ-1)jn-(β-1)(Zβ)jn,    (1.5)

where β is a positive integer.

The numerical and analytical solution of fractional order PDEs play an important role in explaining the characteristics of non-linear problems that arise in everyday life. In the literature, researchers applied various techniques for the numerical solutions of Fisher's equation. Baranwal et al. [14] introduced an analytic algorithm for solving non-linear time-fractional reaction diffusion equations based on the variational iteration method (VIM) and Adomian decomposition method (ADM). Wazwaz and Gorguis [20] implemented ADM for the analytic study of Fisher's equation. Homotopy perturbation sumudu transform method has been applied for solving fractional non-linear dispersive equations by Abedle-Rady et al. [21]. Gupta and Saha Ray [22] implemented two methods. Haar wavelet method and the optimal homotopy asymptotic method (OHAM) for the numerical solutions of arbitrary order PDE, such as Burger-Fisher's and generalized Fisher's equations. Cherif et al. [23] solved space-fractional Fisher's equation using classical HPM. Khader and Saad [24] proposed a numerical solution for solving the space-fractional Fisher's equation using Chebyshev spectral collocation technique. Rawashdeh [25] introduced the fractional natural decomposition method (FNDM) to find the analytical and approximate solutions of the non-linear time-fractional Harry Dym equation and the non-linear time-fractional Fisher's equation. Singh [26] introduced an efficient computational method for the approximate solution of a non-linear Lane-Emden-type equation. The numerical solution of fractional vibration equation of large membrane has been investigated in Singh [27] by Jacobi polynomial. The authors in [28] employed the cubic B-spline method for the numerical simulations of time fractional Burgers' and Fisher's equation. Singh et al. [29] constructed a q-homotopy analysis transform method for solving time and space-fractional coupled Burgers' equation. Najeeb et al. [30] used HPM for the analytical solution of time-fractional reaction-diffusion equation. Majeed et al. [28] used B-spline at non-uniform for the construction of craniofacial fractures.

In this paper, we have presented a cubic B-spline (CBS) algorithm for numerical simulation of the time-fractional generalized Fisher's equation. Caputo's time fractional derivative based on the L1 scheme has been discretized by finite difference formula, whereas spatial derivatives are discretized by CBS functions. The present approach is novel for the numerical results of fractional order PDEs and, to the best of our knowledge, any spline solution of the time-fractional generalized Fisher's equation has never yet been studied. Moreover, this scheme is equally effective for homogeneous and non-homogeneous boundary conditions.

This article has been presented in the following manner. Section 2 evolves a brief description of temporal discretization, cubic B-spline functions and spatial discretization. In section 4, the stability of the proposed algorithm has been discussed. The discussion on numerical results of four test problems has been reported in section 5. Concluding remarks of this work are given in section 6.

2. Description of the Method

Let us consider the interval [a, b] is sub divided into N finite elements of equal spacing h determined by the knots rj, j = 0, 1, 2, 3.……, N such that a = r0 < r1 < r2… < rN−1 < rN = b. The cubic B-spline basis function at the grid points is defined as

ϕj(r)=16h3{(r-rj)3,                                                    if   r[rj,rj+1),h3+3h2(r-rj+1)+3h(r-rj+1)2-3(r-rj+1)3,  if   r[rj+1,rj+2],h3+3h2(rj+3-r)+3h(rj+3-r)2-3(rj+3-r)3,  if   r[rj+2,rj+3],(rj+4-r)3,                                              if   r[rj+3,rj+4).    (2.1)

From the above basis, the approximation solution ZN(r, t) can be written in terms of linear combination of cubic B-spline base function as follows

ZN(r,t)=j=-1N+1Υj(t)ϕj(r),    (2.2)

where Υj(t)s are the unknowns to be determined. Four consecutive cubic B-splines are used to construct each element [rj, rj+1]. The values of cubic B-splines and its derivatives at the nodal points are given in Table 1. The variation of ZN(r, t) over the typical component [rj, rj+1] is given by

ZN(rj,tn)=m=j-1j+1Υm(t)ϕm(rm).    (2.3)
TABLE 1
www.frontiersin.org

Table 1. Coefficients of CBS and its derivative at the nodes rj.

By plugging the approximation values given in Table 1 into Equation (2.3) at (rj, tn), The Equation (1.1) yields the following set of fractional order ordinary differential equations.

[(Υj-1(t)+4Υj(t)+Υj+1(t))/6]-νh2[Υj-1-2Υj+Υj+1]-[(Υj-1+4Υj+Υj+1)/6][1-((Υj-1+4Υj+Υj+1)/6)β]=f(rj,tn).    (2.4)

Here, • represents αth order fractional derivative with respect to time. After some simplification, a recurrence relation for Equation (1.1) with β = 3 can be written as

Υj1n+1[γ612h2112+21296(Tm)3]+Υjn+1[4γ6+1h213+81296(Tm)3]+Υj+1n+1[γ612h2112+21296(Tm)3]=Υj1n[γ6+12h2+112]+Υjn[4γ61h2+13]+Υj+1n[γ6+12h2+112]11296(Tm)4+f(rj,tn)(γk=0n1λk[((Υj1nk1Υj1nk)+4(Υjnk1Υjnk)+(Υj+1nk1Υj+1nk))/6]+ρΔtn+1),    (2.5)

where λk=[(k+1)1-α-k1-α], Tm=Υj-1n+4Υjn+Υj+1n, γ=(Δt)-αΓ(2-α). Moreover, the truncation error ρΔtn+1 is bounded as

|ρΔtn+1|ϖ(Δt)2-α,    (2.6)

where ϖ is a real constant.

Lemma 2.1. The coefficients λk in (2.5) possess the following characteristics [31]:

• λk > 0 and λ0 = 1, k = 1:1:n,

• λ0 > λ1 > λ2 > … > λk, λk → 0 as k → ∞,

k=0n(λk-λk+1)+λn+1=(1-λ1)+k=1n-1(λk-λk+1)+λn=1.

Equation (2.5) is modified as

Υj1n+1α0+Υjn+1α1+Υj+1n+1α0=Υj1n(n1)+Υjn(n2)                      +Υj+1n(n1)11296(Tm)4+f(rj,tn)                      (γk=1n1λk[((Υj1nk1Υj1nk)+4(Υjnk1Υjnk)                      +(Υj+1nk1Υj+1nk))/6]+ρΔtn+1),    (2.7)

where α0=γ6-12h2-112+21296(Tm)3,    α1=4γ6+1h2-13+81296(Tm)3, n1=γ6+12h2+112 and n2=4γ6-1h2+13

From (2.7), the system of N + 1 linear equation with N + 3 unknown parameters (Υ-1,Υ0,Υ1,,ΥN+1)T can be obtained. To acquire unique solution of the system, two extra equations are needed. For this purpose, given boundary conditions are used. Thus, the system of linear equations for expression (2.7) becomes

PYn+1=QYn.    (2.8)
Yn=(Υ-1n,Υ0n,Υ1n,,ΥN+1n)T.

where

P=[1646160000α0α1α000000000α0α1α00000164616].    (2.9)

3. Initial Vector

For the initial vector, the initial and boundary conditions of the problem under consideration will help to compute the initial vector Y0=(Υ-10,Υ00,Υ10,,ΥN+10)T. The approximation (2.2) therefore becomes

ZN(r,0)=j=-1N+1Υj(0)ϕj(r).

To determine Υ0, the approximation for the derivatives of the initial and boundary conditions is as follows [32]:

(Zr)jk=g(rj) for j = 0, N

(Z)j0=g(rj) for j = 0, 1, 2, …, N

This gives the following (N + 3) × (N + 3) matrix system:

[-12h012h0000164616000000001646160000-12h012h]  [Υ-10Υ00ΥN+10]=[g(r0)g(r0)g(rN)g(rN)]

4. Stability Analysis

The von Neumann analysis is frequently used to determine the requirements of stability, as it is usually simple to apply in a simple way. The solution in single Fourier mode is defined as

Υjn=Υkeiηjh,    (4.1)

where i=-1. The approximation solution of generalized Fisher's equation (2.7) can be written as

Υj1n+1(α0)+Υjn+1(α1)+Υj+1n+1(α0)=Υj1n(n1)+Υjn(n2)                         +Υj+1n(n3)11296(Tm)4                         +f(rj,tn)γk=1n1λkα[((Υj1nk+1Υj1nk)                         +4(Υjnk+1Υjnk)+(Υj+1nk+1Υj+1nk))/6].    (4.2)

where n1=γ6+12h2+112,   n2=4γ6-1h2+13,   n3=γ6 +12h2+112, Tm=Υi-1n+4Υin+Υi+1n.

Substituting (4.1) into (4.2), we get

Υk+1eiη(j1)h(α0)+Υk+1eiη(j)h(α1)+Υk+1eiη(j+1)h(α0)=Υkeiη(j1)h(n1)+Υkeiη(j)h(n2)+Υkeiη(j+1)h(n3)11296(Tm)4+f(r,t)k=1n1λkα[((Υnk+1eiη(j1)hΥnkeiη(j1)h)+4(Υnk+1eiη(j)hΥnkeiη(j)h)+(Υnk+1eiη(j+1)hΥnkeiη(j+1)h))/6].
Υk+1[eiη(j1)h(α0)+eiη(j)h(α1)+eiη(j+1)h(α0)]=Υk[eiη(j1)h(n1)+eiη(j)h(n2)+eiη(j+1)h(n3)]11296(Tm)4+f(r,t)k=1n1λkα[(Υnk+1eiη(j1)hΥnkeiη(j1)h+4Υnk+1eiη(j)h4Υnkeiη(j)h+Υnk+1eiη(j+1)hΥnkeiη(j+1)h)/6].
Υk+1=Υkeiη(j)h[eiηh(n1)+n2+eiηh(n3)]11296(Tm)4eiηjh+f(r,t)eiηjheiη(j)h[eiηh(α0)+α1+eiηh(α0)]k=1n1λkα[Υnk+1eiηjh(eiηh+4+eiηh)Υnkeiηjh(eiηh+4+eiηh)]eiη(j)h[eiηh(α0)+α1+eiηh(α0)].

By inserting values of α0, α1 and n1, n2, n3 in above expression, we have

Υk+1=Υk[γ3(cosηh+3)+16h2(cosηh-6)+16(cosηh+2)]-11296(Tm)4e-iηjhγ3(cosηh+3)-16h2(cosηh-6)-16(cosηh+2)+3216(Tm)2(cosηh+3)            +f(r,t)e-iηjh-k=1n-1λkα[2cosηh+4(Υn-k+1-Υn-k)]γ3(cosηh+3)-16h2(cosηh-6)-16(cosηh+2)+3216(Tm)2(cosηh+3).

The applied scheme is stable if augment factor |Υk+1| ≤ 1, and, from the above expression, we can observe that value of numerator is lesser than denominator for the values of γ, η, h. The scheme become unstable as the approximations grows in magnitude.

Υk+1Υk,
Υk+11.

The above result thus reflects that scheme is unconditionally stable.

5. Applications and Discussion

This section presents some examples with different initial and boundary conditions. The numerical results are presented graphically and numerically in figures and tables. The error norms L2 and L are computed to analyze the precision of the suggested technique as

L2=Zexact-Zapprox2hj=0n|(Zj)exact-(Zj)approx|2,
L=Zexact-Zapproxmaxj(Zj)exact-(Zj)approx.

In this manuscript we used, MATLAB 2015b on IntelRCORETMi5 CPU with 8GB RAM and 64-bit operating system (window 7) for numerical simulations.

Example 5.1. Consider the fractional order Fisher's equation (1.1) for β = 3 subject to

αZ(r,t)tα-ν2Z(r,t)r2-Z(r,t)(1-Z3(r,t))=f(r,t).    (5.1)
IC:  Z(r,0)=0,    0r1.
BCs:  Z(0,t)=t2α,     Z(1,t)=0,     t0.

and the source term

f(r,t)=exp(2r)(1-r2)tαΓ(2α+1)Γ(1+α)-2νt2α(1-4r-2r2)exp(2r)-[t2α(1-r2)exp(2r)][1-(t2α(1-r2)exp(2r))3].

The approximate solution (2.3) can be written in piecewise form:

Z(r,tn)=Υj-3ϕ3,j-3(r)+Υj-2ϕ3,j-2(r)               +Υj-1ϕ3,j-1(r)+Υjϕ3,j(r),       r[rj,rj+1).    (5.2)
ZN(r,1)={r3-0.64r2-0.805r+0.99997,                        r[0,0.1),0.56667r3-0.51r2-0.818r+1.0004,                     r[0.1,0.2),16.75r3-10.22r2+1.124r+0.87093,                             r[0.2,0.3),0.11667r3-0.195r2-0.8945r+1.0068,                    r[0.3,0.4),-0.033333r3-0.015r2-0.9665r+1.0165,            r[0.4,0.5),-0.066667r3+0.035r2-0.9915r+1.0206,                  r[0.5,0.6),-0.05r3+0.005r2-0.9735r+1.017,                          r[0.6,0.7),-0.033333r3-0.03r2-0.949r+1.0113,                    r[0.7,0.8),-3546.6r3+8511.7r2-6810.3r+1816.8,                r[0.8,0.9),10640.0r3-29793.0r2+27664.0r-8525.4,                 r[0.9,1).    (5.3)

The exact solution of (5.1) is Z(r, t) = t(1 − r2)exp(2r).

Figures 1, 2 explores the comparison of CBS solution with exact solution for Example 5.1 for different parameters. Figure 1A shows the 2-dimensional preview of approximate and exact results for t = 0.25 with α = 0.95, h = 0.01, Δt = 0.0003 and ν = 1. The graph illustrates that exact and approximate outcomes are indiscriminately similar to each other. Figure 1B cites the action of solution obtained for Equation (5.1) with α = 0.95, h = 0.01, ν = 1 and for various time steps t = 0.5, 0.75, and 1 with Δt = 0.0003. It is clear from the graph that both solutions are overlapping. Three dimensional preview has been given in Figure 2. While the influence of α has been discussed for distinct Brownian motion, i.e, α = 0.25, 0.5, and 0.98 in Figure 3. It can be observed that as the value of α increases, the solution profile decreases and as α → 1, the numerical solution tends to overlap the exact solution. The comparison of numerical and exact outcomes is expressed in Table 2, which shows that both results are consistent with each other and are accurate up to 5 decimal places. The numerical results for α variation is presented in Table 3. It is clear from tabular data that both results strongly agree with each other, and the accuracy of the scheme is examined by the error norms as shown in Table 4.

FIGURE 1
www.frontiersin.org

Figure 1. Approximate results of Example 5.1 at different time levels for α = 0.95, ν = 1, Δt = 0.0003, and h = 0.01. (A) For t = 0.25. (B) For t = 0.5, 0.75, and 1.

FIGURE 2
www.frontiersin.org

Figure 2. 3D image of numerical solution of Example 5.1 for t ϵ [0, 1], α = 0.25, ν = 1, Δt = 0.0003, and h = 0.01.

FIGURE 3
www.frontiersin.org

Figure 3. Numerical solution of Example 5.1 for various values of α = 0.25, 0.5, and 0.98, ν = 1, Δt = 0.0003, and h = 0.01.

TABLE 2
www.frontiersin.org

Table 2. The comparison of results for Example 5.1 at different time level.

TABLE 3
www.frontiersin.org

Table 3. The comparison of results for Example 5.1 at different values of α and t = 0.5.

TABLE 4
www.frontiersin.org

Table 4. Computation of error norms for Example 5.1.

Example 5.2. The fractional order Fisher's equation (1.1) for β = 3 can be written as:

αZ(r,t)tα-ν2Z(r,t)r2-Z(r,t)(1-Z3(r,t))=f(r,t).    (5.4)

with

IC:  Z(r,0)=r2exp(2r),    0r1.
BCs:  Z(0,t)=0,     Z(1,t)=exp(2)(1+t2),     t0.

source term is

f(r,t)=2r2t2-αexp(2r)Γ(3-α)-2ν(1+t2)(1+4r+2r2)exp(2r)                     -[(1+t2)r2exp(2r)][1-((1+t2)r2exp(2r))3].

The Exact solution of Example 5.2 is Z(r, t) = (1 + t2)r2exp(2r). Figures 4, 5 plot the 2D and 3D preview of exact and approximate solutions of Example 5.2. The graph shown in Figure 4A demonstrates that the approximate solution at t = 0.25, α = 0.95, h = 0.01, Δt = 0.0003, and ν = 1 is compatible with exact solution. Figure 4B shows the effect of various time steps t = 0.5, 0.75, and 1 on the solution profile. It is clear from the graphics that exact and numerical solutions have identical behavior for fixed value of α = 0.95. The comparison of exact and approximate results is presented in Table 5, which clearly shows that both solutions are very close to each other and have negligible errors. Figure 5 give 3D preview of approximate solution. To examine the accuracy of the present technique, error norms are computed and shown in Table 6.

FIGURE 4
www.frontiersin.org

Figure 4. Approximate results of Example 5.2 at different time levels for α = 0.95, ν = 1, Δt = 0.0003, and h = 0.01. (A) For t = 0.25. (B) For t = 0.5, 0.75, and 1.

FIGURE 5
www.frontiersin.org

Figure 5. 3D preview of numerical solution of Example 5.2 for t ϵ [0, 1], α = 0.95, ν = 1, Δt = 0.0003, and h = 0.01.

TABLE 5
www.frontiersin.org

Table 5. Numerical results for Example 5.2.

TABLE 6
www.frontiersin.org

Table 6. Error norms for Example 5.2.

The approximate solution (2.3) can be written in piecewise form:

Z(r,tn)=Υj-3ϕ3,j-3(r)+Υj-2ϕ3,j-2(r)+Υj-1ϕ3,j-1(r)                                          +Υjϕ3,j(r),       r[rj,rj+1).    (5.5)
ZN(r,1)={-5.4667r3+0.9700r2+14.08r+0.000033333,           r[0,0.1),-4.2667r3+0.61r2+14.116r-0.0011667,             r[0.1,0.2),-221.05r3+130.68r2-11.898r+1.7331,              r[0.2,0.3),-1.4667r3-1.395r2+14.614r-0.04415,                 r[0.3,0.4),5.35r3-9.575r2+17.887r-0.48042,                    r[0.4,0.5),-1.6333r3+0.9r2+12.649r+0.3925,                    r[0.5,0.6),56.233r3-103.26r2+75.145r-12.107,                    r[0.6,0.7),-104.25r3+233.76r2-160.77r+42.939,           r[0.7,0.8),587.43r3-1426.3r2+1167.3r-311.2,                   r[0.8,0.9),-1846.6r3+5145.5r2-4747.4r+1463.2,                r[0.9,1).    (5.6)

Example 5.3. For β = 2, the time fractional Fisher's equation becomes

αZ(r,t)tα-ν2Z(r,t)r2-Z(r,t)(1-Z2(r,t))=f(r,t).    (5.7)
IC:  Z(r,0)=0,   0<r<1,
BCs:  Z(0,t)=0,     Z(1,t)=0,     t0.

The source term

f(r,t)=24t4-αΓ(5-α)sin(2πr)+4π2t4sin(2πr)-(t4sin(2πr))(1-t4sin(2πr)).

Exact solution for above conditions is

Z(r,t)=t4sin(2πr).

Thus, the approximate solution (2.3) can be written in piecewise form:

Z(r,tn)=Υj-3ϕ3,j-3(r)+Υj-2ϕ3,j-2(r)+Υj-1ϕ3,j-1(r)+Υjϕ3,j(r),       r[rj,rj+1).    (5.8)
ZN(r,1)={-17815.0r3+3562.9r2+0.008r-23.753,               r[0,0.1),5938.2r3-3562.9r2+712.59r-47.506,                 r[0.1,0.2),0.033333r3-0.045r2+0.0195r-0.00085,              r[0.2,0.3),-0.025r2+0.0155r-0.00058333,                  r[0.3,0.4),1490.3r3-1788.4r2+715.36r-95.38,                    r[0.4,0.5),-4470.7r3+7153.2r2-3755.4r+649.75,             r[0.5,0.6),4470.8r3-8941.7r2+5901.5r-1281.6,                  r[0.6,0.7),-1490.1r3+3576.4r2-2861.1r+762.98,               r[0.7,0.8),0.016667r3+0.005r2-0.0425r+0.020917,          r[0.8,0.9),-0.033333r3+0.14r2-0.164r+0.057367,           r[0.9,1).    (5.9)

Figure 6A, displays the numerical and exact solution of Example 5.3 for t = 0.4, α = 0.96, h = 0.01 and Δt = 0.0001. The graphics illustrate that numerical and exact solutions are obviously shown to be indiscriminately comparable to one another. The effect of time concentrations t = 0.6, 0.8, and 1 is studied and presented in Figure 6B keeping other parameters constant. It can be seen from graphics that both solutions have symmetrical conduct and their corresponding numerical data are presented in Table 7, which demonstrates that both results are accurate and have negligible error. Figure 7 plots three-dimensional solution and results of error norms is given in Table 8.

FIGURE 6
www.frontiersin.org

Figure 6. Numerical solution of Example 5.3 for variation in time at α = 0.96, ν = 1, h = 0.01, Δt = 0.0001, and β = 1. (A) For t = 0.25. (B) For t = 0, 0.5, 0.75, and 1.

TABLE 7
www.frontiersin.org

Table 7. Comparison of exact and numerical findings of Example 5.3 at various time stages.

FIGURE 7
www.frontiersin.org

Figure 7. 3D image of approximate results of Example 5.3 for t ϵ [0, 1], α = 0.96, step size h = 0.01, Δt = 0.0001, and ν = 1.

TABLE 8
www.frontiersin.org

Table 8. Comparison of error norms of Example 5.3.

The influence of Brownian motion, i.e, α = 0.25, 0.75, on solution curve is displayed in Figure 8. The identical behavior of solution curves demonstrates that for smaller values of α, the solution profile is away from the exact result and as α → 1, the approximate and exact solution tends to overlap.

FIGURE 8
www.frontiersin.org

Figure 8. Approximate results of Example 5.3 for α = 0.5, 0.75 and 0.95, h = 0.01, Δt = 0.0001, and ν = 1.

Example 5.4. Fisher's equation with fractional order for β = 1 with f(r, t) = 0, is

αZ(r,t)tα-ν2Z(r,t)r2-Z(r,t)(1-Z(r,t))=f(r,t).    (5.10)
with  IC:  Z(r,0)=σ*,    0r1.

The exact solution of the model for α = 1 is,

Z(r,t)=exp(t)σ*1-σ*+σ*exp(t).

The graphical illustration of exact and numerical solutions for Example 5.4 are shown in Figure 9. Figure 9A shows compatibility of exact and numerical results for h = 0.01, Δt = 0.02, α = 1, and σ* = 0.25. The multiple curves for exact and numerical solutions for various values of σ* = 0.5, 0.7, and 0.9 are shown in Figure 9B. The comparison of exact and approximate solutions acquired by the proposed scheme is expressed in Table 9. The tabular data demonstrate that both solutions are compatible with each other for various values of σ*. Table 10 demonstrates the error norms.

FIGURE 9
www.frontiersin.org

Figure 9. Numerical results of Example 5.4 for various values of σ* and α = 1, Δt = 0.02, and h = 0.01. (A) For σ* = 0.25. (B) For σ* = 0.5, 0.7, and 0.9.

TABLE 9
www.frontiersin.org

Table 9. Exact and numerical results of Example 5.4 at different values of σ*.

TABLE 10
www.frontiersin.org

Table 10. Comparison of error norms.

6. Concluding Remarks

In this study, cubic B-spline (CBS) scheme has been successfully implemented to acquire numerical solution of a time-fractional modified Fisher's equation for β = 2 and 3. The temporal derivative is discretized in the Caputo's sense by means of L1 formula, whereas CBS functions have been used for spatial derivative. The results acquired by the proposed scheme are presented in the form of tables and graphics. Following are the main outcomes of this study.

1. The existing Fisher's model has been modified by adding source term and by increasing integer power of non-linear term.

2. The influence of α parameter has been studied for different values and observed that, as the value of α increases gradually, the solution profile Z(r, t) tends toward exact solution. The numerical solution overlaps the exact solution as α approaches 1 as shown in figures.

3. The numerical behavior of the proposed model with different initial and boundary conditions has been observed at different time levels.

4. The comparison of exact and numerical results displayed in graphics reveals that both results show symmetrical behavior and their corresponding numerical data presented in tables clearly elaborate consistency of the results.

5. The results of the study regarding stability of the presented scheme show that proposed scheme is unconditionally stable.

Moreover, the accuracy and efficiency of the proposed scheme is quantified by computing error norms and the numerical results reflect that the proposed scheme is applicable for non-linear time fractional generalized Fisher's equation.

Author Contributions

All authors listed have made a substantial, direct and intellectual contribution to the work, and approved it for publication.

Conflict of Interest

The authors declare that the research was conducted in the absence of any commercial or financial relationships that could be construed as a potential conflict of interest.

The reviewer HS declared a past co-authorship with one of the authors JS to the handling editor.

References

1. Caputo M. Elasticita e Dissipazione. Bologna: Zanichelli (1969).

2. Miller KS, Ross B. An Introduction to Fractional Calculus and Fractional Differential Equations. New York, NY: Wiley (1993).

3. Liao SJ. Homotopy analysis method: a new analytic method for nonlinear problems. Appl Math Mech. (1998) 19:957–62. doi: 10.1007/BF02457955

CrossRef Full Text | Google Scholar

4. Scalar E, Gorenflo R, Mainardi F. Fractional calculus and continuous time finance. Phys A. (2000) 284:376–84. doi: 10.1016/S0378-4371(00)00255-7

CrossRef Full Text | Google Scholar

5. West BJ, Turalskal M, Grigolini P. Fractional calculus ties the microscopic and macroscopic scales of complex network dynamics. New J Phys. (2015) 17:045009. doi: 10.1088/1367-2630/17/4/045009

CrossRef Full Text | Google Scholar

6. Tarasov VE. Fractional vector calculus and fractional Maxwell's equations. Ann Phys. (2008) 323:2756–78. doi: 10.1016/j.aop.2008.04.005

CrossRef Full Text | Google Scholar

7. Rossa J, Villaverdeb AF, Bangab JR, Vazquezc S, Moranc F. A generalized Fisher equation and its utility in chemical kinetics. Proc Natl Acad Sci USA. (2010) 107:12777–81. doi: 10.1073/pnas.1008257107

PubMed Abstract | CrossRef Full Text | Google Scholar

8. Ammerman AJ, Cavalli-Sforza LL. The Neolithic Transition and the Genetics of Population in Europe. Princeton, NJ: Princeton University Press (1984).

PubMed Abstract | Google Scholar

9. Kerke VM. Results from variants of the Fisher equation in the study of epidemics and bacteria. Phys A. (2004) 342:242–8. doi: 10.1016/j.physa.2004.04.084

CrossRef Full Text | Google Scholar

10. Fisher RA. The wave of advance of advantageous genes. Ann Eugen. (1937) 7:355–69. doi: 10.1111/j.1469-1809.1937.tb02153.x

CrossRef Full Text | Google Scholar

11. Podlubny I. Fractional Differential Equations, Vol. 198 of Mathematics in Science and Engineering. San Diego, CA: Academic Press (1999).

12. Odibat Z. Approximation of fractional integrals and caputo fractional derivatives. Appl Math Comput. (2006) 178:527–33. doi: 10.1016/j.amc.2005.11.072

CrossRef Full Text | Google Scholar

13. Baleanu D, Diethelm K, Scalas E, Trujillo JJ. Fractional Calculus Models and Numerical Methods, Vol. 3 of Series on Complexity, Nonlinearity and Chaos. Singapore: World Scientific (2012).

Google Scholar

14. Baranwal VK, Pandey RK, Tripathi MP, Singh OP. An analytic algorithm for time fractional nonlinear reaction diffusion equation based on a new iterative method. Commun Nonlin Sci Numer Simul. (2012) 17:3906–21. doi: 10.1016/j.cnsns.2012.02.015

CrossRef Full Text | Google Scholar

15. Yang XJ, Machado JAT, Baleanu D. Anomalous diffusion models with general fractional derivatives within the kernels of the extended Mittag Leffler type functions. Rom Rep Phys. (2017) 69:120. Available online at:http://hdl.handle.net/20.500.12416/1850

Google Scholar

16. Yang XJ. Fractional derivatives of constant and variable orders applied to anomalous relaxation models in heat-transfer problems. Therm Sci. (2017) 21:116–71. doi: 10.2298/TSCI161216326Y

CrossRef Full Text

17. Yang XJ, Machado JAT, Cattani C, Gao F. On a fractal LC-electric circuit modeled by local fractional calculus. Commun Nonlinear Sci Numer Simul. (2017) 47:200–6. doi: 10.1016/j.cnsns.2016.11.017

CrossRef Full Text | Google Scholar

18. Alaattin E, Ucar Y, Yagmurlu N, Tasbozan O. A Galerkin finite element method to solve fractional diffusion and fractional diffusionwave equations. Math Model Anal. (2013) 18:260–73. doi: 10.3846/13926292.2013.783884

CrossRef Full Text | Google Scholar

19. Rubin SG, Graves RA. Cubic Spline Approximation for Problems in Fluid Mechanics. Washington, DC: NASA TR R-436 (1975).

Google Scholar

20. Wazwaz AM, Gorguis A. An analytic study of Fishers equation by using Adomian decomposition method. Appl Math Comput. (2004) 154:609–20. doi: 10.1016/S0096-3003(03)00738-0

CrossRef Full Text | Google Scholar

21. Abedle-Rady AS, Rida SZ, Arafa AAM, Adedl-Rahim HR. Approximate analytical solutions of the fractional nonlinear dispersive equations using homotopy perturbation Sumudu transform method. Int J Innov Sci Eng Technol. (2014) 19:257–67.

Google Scholar

22. Gupta AK, Ray SS. On the solutions of fractional Burgers Fisher and generalized Fishers equations using two reliable methods. Int J Math Math Sci. (2014) 2014:682910. doi: 10.1155/2014/682910

CrossRef Full Text | Google Scholar

23. Cherif MH, Belghaba K, Zaine D. Homotopy perturbation method for solving the fractional Fishers equation. Int J Anal Appl. (2016) 101:916.

Google Scholar

24. Khader MM, Saad KM. A numerical approach for solving the fractional Fisher equation using Chebyshev spectral collocation method. Chaos Solit Fract. (2018) 110:169177. doi: 10.1016/j.chaos.2018.03.018

CrossRef Full Text | Google Scholar

25. Rawashdeh MS. The fractional natural decomposition method: theories and applications. Math Methods Appl Sci. (2016) 40:2362–76. doi: 10.1002/mma.4144

CrossRef Full Text | Google Scholar

26. Singh H. An efficient computational method for the approximate solution of nonlinear Lane-Emden type equations arising in astrophysics. Astrophys Space Sci. (2018) 363:71. doi: 10.1007/s10509-018-3286-1

CrossRef Full Text | Google Scholar

27. Singh H. Approximate solution of fractional vibration equation using Jacobi polynomials. Appl Math Comput. (2018) 317:85–100. doi: 10.1016/j.amc.2017.08.057

CrossRef Full Text | Google Scholar

28. Majeed A, Piah ARM, Rafique M, Abdullah JY, Rajion ZA. NURBS curves with the application of multiple bones fracture reconstruction. Appl Math Comput. (2017) 315:70–84. doi: 10.1016/j.amc.2017.05.061

CrossRef Full Text | Google Scholar

29. Singh J, Kumar D, Swroop R. Numerical solution of timeand space-fractional coupled Burgers equations via homotopy algorithm. Alex Eng J. (2016) 552:1753–63. doi: 10.1016/j.aej.2016.03.028

CrossRef Full Text | Google Scholar

30. Najeeb AK, Ayaz F, Jin L, Ahmet Y. On approximate solutions for the time-fractional reaction-diffusion equation of Fisher type. Int J Phys Sci. (2011) 6:2483–96.

Google Scholar

31. Sayevand K, Yazdani A, Arjang F. Cubic B-spline collocation method and its application for anomalous fractional diffusion equations in transport dynamic systems. J Vib Control. (2016) 22:2173–86. doi: 10.1177/1077546316636282

CrossRef Full Text | Google Scholar

32. Dag I, Irk D, Saka B. A numerical solution of Burgers equation using cubic B-splines. Appl Math Comput. (2005) 163:199–211. doi: 10.1016/j.amc.2004.01.028

CrossRef Full Text | Google Scholar

Keywords: cubic B-spline (CBS) collocation scheme, time fractional modified Fisher equation, Caputo derivative, stability analysis, error norms

Citation: Majeed A, Kamran M, Abbas M and Singh J (2020) An Efficient Numerical Technique for Solving Time-Fractional Generalized Fisher's Equation. Front. Phys. 8:293. doi: 10.3389/fphy.2020.00293

Received: 17 March 2020; Accepted: 29 June 2020;
Published: 08 October 2020.

Edited by:

Xiao-Jun Yang, China University of Mining and Technology, China

Reviewed by:

Haci Mehmet Baskonus, Harran University, Turkey
Harendra Singh, Indian Institute of Technology (BHU), India

Copyright © 2020 Majeed, Kamran, Abbas and Singh. This is an open-access article distributed under the terms of the Creative Commons Attribution License (CC BY). The use, distribution or reproduction in other forums is permitted, provided the original author(s) and the copyright owner(s) are credited and that the original publication in this journal is cited, in accordance with accepted academic practice. No use, distribution or reproduction is permitted which does not comply with these terms.

*Correspondence: Muhammad Abbas, muhammad.abbas@uos.edu.pk

Download