Numerical Solution of Convection-Diffusion Equation with the help of viscous Burger’s equation
- T M A K Azad
- 103-116
- Mar 4, 2025
- Education
Numerical Solution of Convection-Diffusion Equation with the Help of Viscous Burger’s Equation
T M A K Azad
Department of Computer Science & Engineering, University of Liberal Arts Bangladesh, Dhaka-1209
DOI: https://doi.org/10.51584/IJRIAS.2025.1002009
Received: 26 January 2025; Accepted: 31 January 2025; Published: 04 March 2025
ABSTRACT
Two finite difference schemes, FTBSCS (forward time backward space and centered space) and FTCS (forward time centered space) have been studied for solving convection-diffusion equation (CDE) with appropriate initial condition and boundary conditions. The convection velocity u(t, x) of CDE is computed by solving viscous Burger’s equation using the same schemes. Stability conditions of the schemes are determined and it is analytically shown that FTCS scheme is superior to FTBSCS scheme in terms of time step selection. The conditions of stability are also numerically verified. Some numerical simulation results are presented for various parameters. Error comparisons of both the schemes are presented to estimate accuracy of solutions.
Keywords: Convection-Diffusion Equation, Burger’s Equation, Finite Difference Schemes, Stability Conditions.
INTRODUCTION
Historically, Burger’s equation was first introduced by Bateman [2] who gave its steady solutions. It was later treated Burger’s [4] as a mathematical model for turbulence and after whom such an equation is widely referred to as Burger’s equation. Many problems can be modeled by Burger’s equation [8]. For example, the Burger’s equation can be considered as an approach to the Navier-Stokes equations [1] since both contain nonlinear terms of the type: unknown functions multiplied by a first derivative and both contain higher-order terms multiplied by a small parameter. It is a nonlinear equation for which exact solutions are known and is therefore important as a benchmark problem for numerical methods. The study of the general properties of the Burger’s equation has motivated considerable attention due to its applications in field as diverse as number theory, gas dynamics, heat conduction, elasticity, etc. The exact solutions of the one-dimensional Burger’s equation have been surveyed by Benton and Platzman [3]. Many other authors [5-8] have used a variety of numerical techniques based on finite-difference, finite-element and boundary element methods in attempting to solve the equation particularly for small values of the kinematic viscosity n which corresponds to steep fronts in the propagation of dynamic waveforms.
Convection-Diffusion Equation (CDE) is one of the most important partial differential equation and observed in a wide range of engineering and industrial applications. This equation reflects physical phenomena where in the diffusion process particles are moving with certain velocity from higher concentration to lower concentration. The analytical/numerical solutions along with an initial condition and two boundary conditions help to understand the contaminant or pollutant concentration distribution behavior through an open medium like air, rivers, lakes and porous medium like aquifer. CDE benefits from wide applications in such different disciplines as environmental engineering, mechanical engineering, heat transfer, soil science and as well in biology. It has wide applications in other disciplines too, like soil physics, petroleum engineering, chemical engineering and biosciences.
Analytical solutions are as useful tools in many areas-
Formerly, the analytical solutions of ADE were obtained by reducing the original ADE into a diffusion equation by omitting the advective term(s). It was done either by introducing moving co-ordinates (Ogata and Banks, 1961[26]; Harleman and Rumer 1963[30]; Bear 1972[14]; Guvanasen and Volker 1983[29]; Aral and Liao, 1996 [11]; Marshal et al. 1996[22]; or by introducing another dependent variable (Banks and Ali, 1964[13]; Ogata and Banks 1961[26]; Lai and Jurinak 1971[20] and Al-Niami and Rushton, 1977[9]). In more recent works, analytical solutions of ADE have been obtained using such integral transform techniques as either Laplace or Fourier transform ( Lai and Jurinak 1971[20]; Marino 1974 [21] and Kumar et al. 2009[12]). In [10; 15 – 19; 23 – 25; 27; 28; 34] analytical and numerical solutions have been obtained by applying different method.
In (Azad et al., [32]; Azad and Andallah [33]) finite difference schemes are presented for solving the advection diffusion equation (ADE). Numerical solution of the ADE is obtained by using FTBSCS and FTCS techniques for prescribed initial and boundary data. Numerical results for both the schemes are compared in terms of accuracy by error estimation with respect to exact solution of the ADE and also, the numerical features of the rate of convergence are presented graphically.
With the above discussion in view, one-dimensional convection-diffusion equation is solved by using two finite difference schemes FTBSCS and FTCS. The convection velocity u(t, x) is computed by solving viscous Burger’s equation using the same schemes. Stability conditions for the schemes studied and the condition of stability is also numerically verified.
GOVERNING EQUATION AND NUMERICAL SCHEMES
Governing Equation
In this paper, we consider variable advection velocity u(t, x), so that the PDE reads as convection-diffusion equation (CDE) ∂c/∂t+u ∂c/∂x=D (∂^2 c)/(∂x^2 ) where we have two unknowns c(t, x) and u(t, x). Therefore we have to solve another equation and we select the viscous Burger’s equation ∂u/∂t+u ∂u/∂x= (∂^2 u)/(∂x^2 ) to compute the variable velocity u(t, x). Our problem is thus to solve the following system of PDE’s simultaneously as an IBVP
∂u/∂t+u ∂u/∂x= (∂^2 u)/(∂x^2 ), a<x<b, t>0, (1)
∂c/∂t+u ∂c/∂x=D (∂^2 c)/(∂x^2 ), a<x<b, t>0, (2)
where c(t, x) represents the solute concentration [ML-3] at x, along longitudinal direction at time t, and is the coefficient of kinematic viscosity, D is the solute dispersion, if it is independent of position and time, is called dispersion coefficient [L2T-1], t = time[T]; x = distance[L] and, u(t, x) is the solutions of (1).
Appended with initial condition
u(x,0)=f(x); c(x,0)=f(x) a≤x<b
and Neumann boundary conditions
∂/∂x u(t,a)=u_a (t) ; ∂/∂x u(t,b)=u_b (t) t_0≤t≤T
∂/∂x c(t,a)=c_a (t) ; ∂/∂x c(t,b)=c_b (t) t_0≤t≤T
where ca, cb, ua, ub are constant concentration values.
Analytic solution
The exact solution of the advection-diffusion equation as IVP with initial condition
c(x, 0) = f(x) is given [31]
c(x,t)=M/(A√4πDt) exp(-(x – (x_0 + ut))^2/4Dt) (3)
where M = mass of tracer
A = uniformly cross section area at the point x = 0, at time t = 0.
Finite Difference Scheme
We consider the one–dimensional CDE as an initial and boundary value problem.
∂c/∂t+u ∂c/∂x=D (∂^2 c)/(∂x^2 ),
with initial condition c(t_0,x)=c_0 (x); a≤x≤b
and Neumann boundary conditions
∂/∂x c(t,a)=c_a (t) ; t_0≤t≤T
∂/∂x c(t,b)=c_b (t) ; t_0≤t≤T
FDMs are the efficient approach to numerical solutions of partial differential equations. A finite difference method proceeds by replacing the derivatives in the differential equation by the finite difference approximations. This gives a large algebraic system of equation to be developing a computer programming code.
Explicit Finite Difference Scheme
For the numerical solution of the one –dimensional linear convection- diffusion equation, we consider the IBVP
∂c/∂t+u ∂c/∂x=D (∂^2 c)/(∂x^2 ),
with initial condition c(x,0)=0.02×e^(-10x), 0≤x<l
and Neumann boundary conditions
∂/∂x c(t,x=0)=0, 0<t≤T
∂/∂x c(t,x=l)=0 0<t≤T
In order to develop the schemes, we discretize the x-t plane by choosing a spatial grid size h º Δx and temporal grid size k º Δt. Then we can define the discrete grid points
x_i=a+ih,i=0,1,2,3,………,M and t_n=nk,n=0,1,2,………,N where M = (b – a)/h and N =T/k. Now we present two finite difference schemes as follows-
FINITE DIFFERENCE FORMULAE
Derivatives in the convection- diffusion equation are approximated by truncated Taylor Series expansions, which are follows-
∂c/∂t=(c_i^(n+1)-c_i^n)/∆t (1st order forward difference in time) (4)
∂c/∂x=(c_i^n-c_(i-1)^n)/∆x (1st order backward space difference formula) (5)
∂c/∂x=(c_(i+1)^n-c_(i-1)^n)/2∆x (1st order centered space difference formula) (6)
and
(∂^2 c)/〖∂x〗^2 =(c_(i+1)^n-〖2c〗_i^n+c_(i-1)^n)/〖∆x〗^2 (2nd order centered space difference formula) (7)
Finite Difference (FTBSCS) Scheme
Substituting equations (4), (5), (7) into equation (1), (2) and rearranging according the time level,
- tends to
(u_i^(n+1)-u_i^n)/∆t+u_i^n (u_i^n-u_(i-1)^n)/∆x= (u_(i+1)^n-〖2u〗_i^n+u_(i-1)^n)/〖∆x〗^2 ,
〖”” u〗_i^(n+1)=u_i^n-t/x u_i^n (u_i^n-u_(i-1)^n )+∆t/〖∆x〗^2 (u_(i+1)^n-〖2u〗_i^n+u_(i-1)^n),
〖”” u〗_i^(n+1)=u_i^n-γ(u_i^n-u_(i-1)^n )+r(u_(i+1)^n-〖2u〗_i^n+u_(i-1)^n)
〖We get,u〗_i^(n+1)=(γ+r) u_(i-1)^n+(1-γ-2r) u_i^n+ru_(i+1)^n, (8)
where, γ=∆t/∆x u_i^n , r=∆t/〖∆x〗^2
2. tends to
(c_i^(n+1)-c_i^n)/∆t+u_i^n (c_i^n-c_(i-1)^n)/∆x=D (c_(i+1)^n-〖2c〗_i^n+c_(i-1)^n)/〖∆x〗^2 ,
〖”” c〗_i^(n+1)=c_i^n-t/x u_i^n (c_i^n-c_(i-1)^n )+D∆t/〖∆x〗^2 (c_(i+1)^n-〖2c〗_i^n+c_(i-1)^n),
c_i^(n+1)=c_i^n-γ(c_i^n-c_(i-1)^n )+D∆t/〖∆x〗^2 (c_(i+1)^n-〖2c〗_i^n+c_(i-1)^n)
We get,c_i^(n+1)=(γ+”” ) c_(i-1)^n+(1-γ-2″ ” ) c_i^n+c_(i+1)^n, (9)
where, γ=∆t/∆x u_i^n ,=D∆t/〖∆x〗^2
Finite Difference (FTCS) Scheme
Substituting equations (4), (6), (7) into equation (1), (2) and rearranging according the time level,
- tends to
(u_i^(n+1)-u_i^n)/∆t+u_i^n (u_(i+1)^n-u_(i-1)^n)/2∆x= (u_(i+1)^n-〖2u〗_i^n+u_(i-1)^n)/〖∆x〗^2 ,
〖”” u〗_i^(n+1)=u_i^n-∆t/2∆x u_i^n (u_(i+1)^n-u_(i-1)^n )+∆t/〖∆x〗^2 (u_(i+1)^n-〖2u〗_i^n+u_(i-1)^n),
〖”” u〗_i^(n+1)=u_i^n-γ/2 (u_(i+1)^n-u_(i-1)^n )+r(u_(i+1)^n-〖2u〗_i^n+u_(i-1)^n),
〖We get, u〗_i^(n+1)=(r+γ/2) u_(i-1)^n+(1-2r) u_i^n+(r-γ/2) u_(i+1)^n, (10)
where, γ=∆t/∆x u_i^n ,r=∆t/〖∆x〗^2
2. tends to
(c_i^(n+1)-c_i^n)/∆t+u_i^n (c_(i+1)^n-c_(i-1)^n)/2∆x=D (c_(i+1)^n-〖2c〗_i^n+c_(i-1)^n)/〖∆x〗^2 ,
c_i^(n+1)=c_i^n-t/2x u_i^n (c_(i+1)^n-c_(i-1)^n )+D∆t/〖∆x〗^2 (c_(i+1)^n-〖2c〗_i^n+c_(i-1)^n),
〖”” c〗_i^(n+1)=c_i^n-γ/2 (c_(i+1)^n-c_(i-1)^n )+(c_(i+1)^n-〖2c〗_i^n+c_(i-1)^n)
We get, c_i^(n+1)=(“” +γ/2) c_(i-1)^n+(1-2″ ” ) c_i^n+(“” -γ/2 u_i^n ) c_(i+1)^n, (11)
where, γ=∆t/∆x u_i^n ,=D∆t/〖∆x〗^2
It is seen that the truncation errors for the forward and backward differences are of first order; whereas the centered difference yields a second order truncation error (using by Taylor Series expansions). Therefore, both the schemes outlined above are consistent.
STABILITY ANALYSIS
After surveying the relevant literature on the subject, we discover that no practical stability criterion exists for the schemes. We have developed stability conditions for both the schemes in the following two propositions and maintaining the criteria we verify the results of the schemes numerically in the next sections.
proposition 1
Statement: The stability conditions for the FTBSCS scheme are
0≤ D∆t/〖∆x〗^2 ≤1 and -D∆t/〖∆x〗^2 ≤∆t/∆x u_i^n≤1-2D∆t/〖∆x〗^2
This is guaranteed by the simultaneous inequalities
0≤ D∆t/〖∆x〗^2 ≤1 and -D/∆x≤max(u_i^0)≤∆x/∆t-2 D/∆x
Proof:
The explicit centered difference scheme using by FTBSCS for CDE (2) is given by
c_i^(n+1)=(γ+”” ) c_(i-1)^n+(1-γ-2″ ” ) c_i^n+c_(i+1)^n, (12)
where γ=∆t/∆x u_i^n ,=D∆t/〖∆x〗^2
The equation (12) implies that if
0≤γ+≤1 (i)
0≤1-γ-2≤1 (ii)
0≤≤1 (iii)
then the new solution is a convex combination of the two previous solutions. That is the solution at new time-step (n+1) at a spatial node i is an average of the solutions at the previous time-step at the spatial-nodes i-1, i and i+1. This means that the extreme value of the new solution is the average of the extreme values of the previous two solutions at the three consecutive nodes. Therefore, the new solution continuously depends on the initial value
(ii) implies γ≤1-2≤1+γ (iv)
(i) implies -≤γ≤1-
∴-≤γ≤1-2 by (iv)
Therefore, the conditions are 0≤≤1 and -≤γ≤1-2
That is 0≤ D∆t/〖∆x〗^2 ≤1 and -D∆t/〖∆x〗^2 ≤∆t/∆x u_i^n≤1-2D∆t/〖∆x〗^2
This is guaranteed by the simultaneous inequality
0≤ D∆t/〖∆x〗^2 ≤1 and -D/∆x≤max(u_i^0)≤∆x/∆t-2 D/∆x
Proposition 2
Statement: The stability conditions for the FTCS scheme are
0≤ D∆t/〖∆x〗^2 ≤1/2 and -2 D∆t/〖∆x〗^2 ≤∆t/∆x u_i^n≤2(1-D∆t/〖∆x〗^2 ).
This is guaranteed by the conditions 0≤ D∆t/〖∆x〗^2 ≤1/2 and -2D/∆x≤max(u_i^0)≤2(∆x/∆t-D/∆x).
Proof:
The explicit centered difference scheme using by FTCS for CDE (2) is given by
c_i^(n+1)=(“” +γ/2) c_(i-1)^n+(1-2″ ” ) c_i^n+(“” -γ/2 u_i^n ) c_(i+1)^n, (13)
where γ=∆t/∆x u_i^n ,=D∆t/〖∆x〗^2
The equation (13) implies that if
0≤+γ/2≤1 (i)
0≤1-2≤1 (ii)
0≤-γ/2≤1 (iii)
then the new solution is a convex combination of the two previous solutions. That is, the solution at new time-step (n+1) at a spatial node i is an average of the solutions at the previous time-step at the spatial-nodes i-1, i and i+1. This means that the extreme value of the new solution is the average of the extreme values of the previous two solutions at the three consecutive nodes. Therefore, the new solution continuously depends on the initial value
(ii) implies 0≤≤1/2 (iv)
(iii) implies -1≤ γ/2 (v)
(i) implies -≤γ/2≤1- (vi)
From (v) & (vi), it follows that -≤γ/2≤1-
∴-2≤≤2(1-)
Therefore, (from (v), (vi)) the conditions are 0≤≤1/2 and -2≤≤2(1-)
That is 0≤ D∆t/〖∆x〗^2 ≤1/2 and -2 D∆t/〖∆x〗^2 ≤∆t/∆x u_i^n≤2(1-D∆t/〖∆x〗^2 ).
This is guaranteed by the conditions 0≤ D∆t/〖∆x〗^2 ≤1/2 and -2D/∆x≤max(u_i^0)≤2(∆x/∆t-D/∆x)
NUMERICAL SIMULATION AND RESULTS DISCUSSIONS
Various finite difference equations were used to represent the parabolic model equation (2). It is extremely important to experiment with the application of these numerical techniques. It is hoped that by writing computer codes and analyzing the results, additional insights into the solution procedures are gained. Therefore, this section proposes an example and presents solutions by the described schemes.
Numerical verification of Stability Conditions:
In this study, we assume that the length of spatial domain, l = 6 meters at all time, t = 1minute to t = 6 minutes with viscosity, n = 0.01m2/s=36 m2/h and diffusion coefficient, D = 0.01m2/s=36 m2/h.
The convection-diffusion equation for this problem is ∂C/∂t+u ∂C/∂x=D (∂^2 C)/(∂x^2 ) . Various values of spatial nodes size and time steps are to be used to investigate the numerical schemes and the effect of steps on stability.
An attempt is made to solve the stated problem subject to the imposed initial and Neumann boundary conditions by the following:
The FTBSCS and FTCS schemes with
- Spatial step size, Dx = 0.05 m Temporal step size, Dt = 0.033s, Time, T = 60´2 sec
- Spatial step size, Dx = 0.05 m Temporal step size, Dt = 0.067s, Time, T = 60´4 sec
- Spatial step size, Dx = 0.05 m Temporal step size, Dt = 0.01s, Time, T = 60´6 sec
- Spatial step size, Dx = 0.05 m Temporal step size, Dt = 0.1192s, Time,T =60´152 sec
Solutions:
Case I. When the step sizes are Δx = 0.05, Dt = 0.033.
In this case, both the schemes are to be used as stated previously.
The stability conditions of FTBSCS is determined by equation (12) as
0≤λ≤1 and -λ≤γ≤1-2λ
This is guaranteed by the simultaneous inequalities
0≤ D∆t/〖∆x〗^2 ≤1 and-D/∆x≤max(u_i^0)≤∆x/∆t-2 D/∆x
The stability conditions of FTCS is determined by equation (13) as
0≤λ≤1/2 and-2λ≤λ≤2(1-λ)
This is guaranteed by the conditions 0≤ D∆t/〖∆x〗^2 ≤1/2 and-2D/∆x≤max(u_i^0)≤2(∆x/∆t-D/∆x)
where, γ= ∆t/∆x max(u_i^0) ,=D∆t/〖∆x〗^2
For this particular application,
The value of which satisfies the guaranteed inequality in both the schemes.
γ=∆t/∆x max(u_i^0 )=0.033/0.05 Χ0.02=0.0132 and λ=D∆t/〖∆x〗^2 =(0.01×0.033)/(0.05)^2 =0.132
FTBSCS ⇒ 0≤0.132 ≤1 and-0.132 ≤0.0132≤1-20.132 =0.736
FTCS ⇒ 0≤0.132≤ 1/2 and-0.264≤0.0132≤1.736
Therefore, the stability conditions for both the schemes are satisfied and a stable solution is expected. The concentration profiles are to be obtained up to t = 2 minutes are shown in figure 5.1.
Figure 5.1: Concentration profiles with Dx = 0.05, Dt = 0.033
Case II. When the step sizes are Dx = 0.05, Dt = 0.067.
In this case, both the schemes are to be used as stated previously.
The stability conditions of FTBSCS is determined by equation (12) as
0≤λ≤1 and -λ≤γ≤1-2λ
This is guaranteed by the simultaneous inequalities
0≤ D∆t/〖∆x〗^2 ≤1 and -D/∆x≤max(u_i^0)≤∆x/∆t-2 D/∆x
The stability conditions of FTCS is determined by equation (13) as
0≤≤1/2 and -2≤≤2(1-)
This is guaranteed by the conditions 0≤ D∆t/〖∆x〗^2 ≤1/2 and -2D/∆x≤max(u_i^0)≤2(∆x/∆t-D/∆x)
where γ=∆t/∆x max(u_i^0) ,=D∆t/〖∆x〗^2
For this particular application,
The value of max(u_i^0 )=0.02 which satisfies the guaranteed inequality in both the schemes.
γ=∆t/∆x max(u_i^0) =0.067/0.05 0.02=0.0268 and λ=D∆t/〖∆x〗^2 =(0.01×0.067)/(0.05)^2 =0.268
FTBSCS 0≤0.268 ≤1 and -0.268 ≤0.0268≤1-20.268 =0.464
and
FTCS 0≤0.268≤ 1/2 and -0.536≤0.0268≤1.464
Therefore, the stability conditions for both the schemes are satisfied and a stable solution is expected. The concentration profiles are to be obtained up to t = 4 minutes are shown in figure 5.2.
Figure 5.2: Concentration profiles with Dx = 0.05, Dt = 0.067
Case III. When the step sizes are Dx = 0.05, Dt = 0.1.
In this case, both the schemes are to be used as stated previously.
The stability conditions of FTBSCS is determined by equation (12) as
0≤≤1 and -≤γ≤1-2
This is guaranteed by the simultaneous inequalities
0≤≤1/2 and -2≤≤2(1-)
This is guaranteed by the conditions 0≤ D∆t/〖∆x〗^2 ≤1/2 and -2D/∆x≤max(u_i^0)≤2(∆x/∆t-D/∆x)
where γ=∆t/∆x max(u_i^0) ,=D∆t/〖∆x〗^2
0≤ D∆t/〖∆x〗^2 ≤1 and -D/∆x≤max(u_i^0)≤∆x/∆t-2 D/∆x
The stability conditions of FTCS is determined by equation (13) as
For this particular application,
The value of max(u_i^0 )=0.02 which satisfies the guaranteed inequality in both the schemes.
γ=∆t/∆x max(u_i^0) =0.1/0.05 0.02=0.04 and λ=D∆t/〖∆x〗^2 =(0.01×0.1)/(0.05)^2 =0.4
FTBSCS 0≤0.4 ≤1 and -0.4 ≤0.04≤1-20.4 =0.2
and
FTCS 0≤0.4≤ 1/2 and -0.8≤0.04≤1.2
Therefore, the stability conditions for both the schemes are satisfied and a stable solution is expected. The concentration profiles are to be obtained up to t = 6 minutes are shown in figure 5.3.
Figure 5.3: Concentration profiles with Dx = 0.05, Dt = 0.1
Case IV. When the step sizes are increased to Δx = 0.05, Dt = 0.1192,
The stability conditions of FTBSCS is determined by equation (12) as
0≤≤1 and -≤γ≤1-2
This is guaranteed by the simultaneous inequalities
0≤ D∆t/〖∆x〗^2 ≤1 and -D/∆x≤max(u_i^0)≤∆x/∆t-2 D/∆x
The stability conditions of FTCS is determined by equation (13) as
0≤≤1/2 and -2≤≤2(1-)
This is guaranteed by the conditions 0≤ D∆t/〖∆x〗^2 ≤1/2 and -2D/∆x≤max(u_i^0)≤2(∆x/∆t-D/∆x)
where γ=∆t/∆x max(u_i^0) ,=D∆t/〖∆x〗^2
For this particular application,
The value of max(u_i^0 )=0.02 which satisfies the guaranteed inequality in both the schemes.
γ=∆t/∆x max(u_i^0) =0.1192/0.05 0.02=0.04768 and λ=D∆t/〖∆x〗^2 =(0.01×0.1192)/(0.05)^2 =0.4768
FTBSCS 0≤0.4768≤1 and -0.4768≤0.04768≤ 0.0464 which does not satisfy the stability condition of FTBSCS scheme, and
FTCS 0≤0.4768≤ 1/2 and -0.9536≤0.04768≤1.0464
In this case, FTBSCS of the CDE shows an instability which is shown in the following figure 5.4.
Figure 5.4: Concentration profiles with Dx = 0.05, Dt = 0.1192
Error Estimation and Convergence
We compute the relative error in L1-norm which is defined as
err = 〖∥c_e-c_n∥〗_1/〖∥c_e∥〗_1 (14)
where, ce is the exact solution, and cn is the numerical solution computed by the finite difference schemes for time . The following figure 6.1 shows the convergence of relative error by the scheme FTBSCS.
Figure 6.1 Rate of Numerical feature of Convergence
The following figure 6.2 shows the convergence of relative error by the scheme FTCS.
Figure 6.2 Rate of Numerical feature of Convergence
The following figure 6.3 shows the comparison of relative errors for the both schemes.
Figure 6.3 Comparison of relative errors for the both schemes
CONCLUSION
We have developed stability conditions and numerical solutions by using FTBSCS and FTCS schemes for convection diffusion equation with an initial condition and Neumann boundary conditions. The solution of Burger’s equation is used as convection term in the CDE. Some numerical experiment is presented graphically.
In the Figure 5.1, 5.2, 5.3, it has been found that FTCS scheme gives better pointwise solution than FTBSCS scheme. In figure 5.4, an unstable solution is appeared by using FTBSCS scheme however, the solutions by using FTCS scheme is stable at the increased time step size Dt = 0.1192 and it is numerically shown that FTCS scheme is superior to FTBSCS scheme interms of time step selection.
The analytical result is used for code validation and for error comparison of both schemes. In addition, it is used to study the effect of step size on the accuracy of solutions. The results shown in Figure 6.1 – 6.3 are the error terms as defined above at time level [1, 6]. Two points to emphasize with regard to Figure 6.1-6.3 are: (1) for this application, the FTCS scheme has minimum error in comparison with FTBSCS scheme, and the amount of error is decreased for the both schemes as the solution is marched in time. This error reduction is due to a decrease in the influence of the initial data.
REFERENCES
- W.F. Ames, Nonlinear Partial Differential Equation in Engineering, Academic Press, New York, 1965.
- H. Bateman, Some recent researches on the motion of the fluids, Monthly Weather Rev. 43(1915): 163-170.
- E. Benton, G.W. Platzman, A table of solutions of the one-dimensional Burger’s equation, Quart. Appl. Math. 30 (1972): 195-212.
- J. M. Burger, A Mathematical Model Illustrating the Theory of Turbulence, Adv. in Appl. Mech. I, Academic Press, New York, 1948, pp 171-199.
- J. Caldwell, P. Wanless, A.E. Cook, A finite element approach to Burger’s equation, Appl. Math. Modelling 5(1981): 189-193.
- D. J. Evans, A.R. Abdullah, The group explicit method for the solution of Burger’s equation, Computing 32 (1984) :239-253.
- Y. C. Hon, X.Z. Mao, An efficient numerical scheme for Burger’s equation, Appl. Math. Comput. 95(1998): 37-50.
- C.A. Fletcher, Burger’s equation: a model for all reasons, in: J. Noye (Ed.), Numerical Solutions of partial Differential Equations, North-Holland, Amsterdam, 1982.
- Al-Niami A N S and Ruston K R 1977, “Analysis of flow against dispersion in porous media”, Hydrol. 33:87-97.
- Anderson, Mary P., and William W. Woessner, Applied Groundwater Modeling, Simulation of Flow and Advective Transport, Academic Press Inc., San Diego, 1992. Pages 6-68.
- Aral M M and Liao B 1996, Analytical solutions for two-dimensional transport equation with time-dependent dispersion coefficients, J. Hydrol. Engg. 1(1): 20-32.
- Atul Kumar, Dilip Kumar Jaiswal and Naveen Kumar, Analytical solution of one dimensional Advection diffusion equation with variable coefficients in a finite domain, J. Earth Syst. Sci. 118, 5, pp. 539-549, October 2009.
- Banks R B and Ali J 1964, Dispersion and adsorption in porous media flow, J. Hydraul. Div. 90: 13- 31.
- Bear J 1972, Dynamics of fluids in porous media (New York: Amr. Elsev. Co.)
- Bender, Edward A, An Introduction to Mathematical Modeling, John Wiley & Sons Inc. New York, 1978. Pages 1-140.
- Changiun Zhu, Liping Wa and Sha Li,A numerical Simulation of Hybrid Finite Analytic Methods For Ground Water Pollution, Advanced Materials Research Vol. 121-122(2010), pp 48-51.
- Changjun Zhu and Shuwen Li, A numerical Simulation of River Water Pollution using Grey Differential Model, Journal of Computer, No.9, September 2010.
- Donea J, Giulinai S, Laval H. Quartapelle, Time accurate solution of advection-diffusion problems by finite elements, Comput Methods Appl Mech Eng 1984; 45: 123-45.
- F. B. Agusto and O. M. Bamingbola, Numerical Treatment of the Mathematical Models for Water Pollution, Research Journal of Applied Sciences 2(5): 548-556, 2007.
- Lai S H and Jurinak J J 1971, Numerical approximationof cation exchange in miscible displacement through soil columns; Soil Sci.Soc. Am. Proc. 35:894-899.
- Marino M A 1974, Distribution of contaminants in porous media flow; Water resour. Res. 10: 1013-1018.
- Marshal T J, Holmes J W and Rose C W 1996, Soil Physics (Cambridge University Press, 3rd)
- L F. Leon, P.M. Austria, Stability Criterion for Explicit Scheme on the solution of Advection-Diffusion Equation, Maxican Institute of Water Technology.
- M. Thongmoon and R. Mckibbin, A comparison of some numerical methods for the advection-diffusion equation, Int. Math. Sci. 2006, Vol. 10, pp. 49-52.
- Nicholas J.Higham, Accuracy and stability of Numerical Algorithms, Society of Industrial and Applied Mathematics, Philadelphia, 1996.
- Ogata A, Banks RB, A Solution of the differential equation of longitudinal dispersion in porous media, US Geological Survey, Paper 1961; 411-A; 1961.
- Randall J. Leveque, Numerical methods for conservation laws, second edition, 1992, Springer.
- Romao, Silva and Moura, Error analysis in the numerical solution of 3D convection diffusion equation by finite difference methods, Thermal technology, vol-08, pp12-17, 2009.
- Guvanasen V and Volker R E 1983, Experimental investigations of unconfined aquifer pollution from recharge basins; Water resour, Res. 19(3): 707-717.
- Harleman D R F and Rumer R R 1963, Longitudinal and lateral dispersion in an isotropic porous medium; J. Fluid Mech. 385-394.
- Scott A. Socolofsky & Gerhard H. Jirka, Environmental Fluid Mechanics, part 1, 2nd Edition, 2002.
- T M A K Azad, M Begum and L S Andallah, An explicit finite difference scheme for advection diffusion equation, jahangirnagar journal of mathematics and mathematical sciences, Vol.-24, 2015, ISSN 2219-5823.
- T M A K Azad and L S Andallah, An Explicit Finite Difference Method, Ulab Journal of Science and Engr. Vol. 6, 2015 ISSN 2079-4398 (PRINT), ISSN 2414-102X (ONLINE)
- Young-San Park, Jong-Jin Baik, Analytical solution of the advection diffusion equation for a ground level finite area source, Atmospheric Environment 42: 9063-9069, 2008.