Numerical Solution of the Coupled Viscous Burgers’ Equation Using Differential Quadrature Method Based on Fourier Expansion Basis

Abstract

The differential quadrature method based on Fourier expansion basis is applied in this work to solve coupled viscous Burgers’ equation with appropriate initial and boundary conditions. In the first step for the given problem we have discretized the interval and replaced the differential equation by the Differential quadrature method based on Fourier expansion basis to obtain a system of ordinary differential equation (ODE) then we implement the numerical scheme by computer programing and perform numerical solution. Finally the validation of the present scheme is demonstrated by numerical example and compared with some existing numerical methods in literature. The method is analyzed for stability and convergence. It is found that the proposed numerical scheme produces a good result as compared to other researcher’s result and even generates a value at the nodes or mesh points that the results have not seen yet.

Share and Cite:

Jima, M. , Shiferaw, A. and Tsegaye, A. (2018) Numerical Solution of the Coupled Viscous Burgers’ Equation Using Differential Quadrature Method Based on Fourier Expansion Basis. Applied Mathematics, 9, 821-835. doi: 10.4236/am.2018.97057.

1. Introduction

1.1. Background of the Study

In the field of computational mathematics, numerical methods are most widely utilized to solve equations arising in the field of physics, engineering and other sciences. Numerical analysis plays a significant role and helps us to find an approximate solution for problems which are difficult to solve analytically. The design and computation of the numerical algorithm is one of the mathematical challenges faced nowadays, but scientists in the field of computational mathematics are trying to develop numerical methods by using of computers for further application. One of those numerical methods is quadrature method.

A differential quadrature method is a numerical method for evaluating derivatives of sufficiently smooth function as proposed by [1] . The basic idea of differential quadrature came from Gauss Quadrature [2] , which is a useful numerical integration method. Gauss Quadrature is characterized by approximating a definite integral with weighting sum of integrand value of a group at Gauss point. Extending it to find the derivatives of various orders of sufficiently smooth function gives rise to DQ [1] . In other words the derivatives of smooth function are approximated with weighted sum of the function values at a group of so called nodes. Differential quadrature can be formulated through either approximation theory or solving a system of linear equations. However, the rapid development over the recent years on problems involving nonlinear, discontinuity, multiple scales, singularity and irregularity are challenges in the field of computational science and engineering of the various numerical solutions. DQ method has distinguished themselves because of their high accuracy, straight forward implementation and generality in variety of problems [3] .

Coupled Viscous Burgers’ Equation

Coupled Viscous Burgers’ equation is the nonlinear partial differential equation, wildly applicable in the theory of shock waves, mathematical modeling of turbulent fluid and in continuous stochastic processes.

And this equation has a wide application in the various areas of applied mathematics, such as fluid mechanics, nonlinear acoustic gas dynamics and traffic flow. The coupled viscous Burgers’ equation was studied for the first time by [4] to model polydisperse sedimentation or evaluate scaled volume concentration of two kinds of particles in fluid suspensions or colloid under the effect of gravity.

The viscous Burgers’ equation was presented in 1940 and in 1950 Hopf and in 1951 Cole independently introduced the method that has come to be known as the Cole-Hopf transformation to solve the Viscous Burgers’ Equation [3] .

The Coupled Viscous Burgers’ Equation which is a nonlinear partial differential equation of the form

u t u x x + η u u x + α ( u v ) x = 0 , x [ a , b ] , t [ 0 , T ]

v t v x x + ε v v x + β ( u v ) x = 0 , x [ a , b ] , t [ 0 , T ] (1.1)

with initial condition

u ( x , 0 ) = ϕ 1 ( x ) , v ( x , 0 ) = ϕ 2 ( x ) , 0 x 1 (1.2)

The boundary condition

u ( a , t ) = f 1 ( a , t ) , v ( a , t ) = g 1 ( a , t ) (1.3)

u ( b , t ) = f 2 ( b , t ) , v ( b , t ) = g 2 ( b , t ) , 0 t T

where η, ε, α and β are constants depending on the system parameters.

Differential Quadrature Method (DQM)

Differential quadrature method first introduced by [1] is one of the most efficient numerical method to solve partial differential equations. The key procedure in differential quadrature approximation is to determine the weighting coefficient.

[5] and [6] obtain explicit formulations to compute the weighting coefficient of the first and second order derivative. [3] presented a simple algebraic formulation to compute the weighting coefficient of the first order derivative without any restriction on the choice of the grid points and a recurrence relationship to compute the weighting coefficient of the DQ method and its applications were rapidly developed after the late 1980s, thanks to the innovative work in the computation of the weighting coefficients by other researchers and the author. As a result, the DQ method has emerged as a powerful numerical discretization tool in the past decade. As compared to the conventional low order finite difference and finite element methods, the DQ method can obtain very accurate numerical results using a considerably smaller number of grid points and hence requiring relatively little computational effort. So far, the DQ method has been efficiently employed in a variety of problems in engineering and physical sciences.

Based on the analysis of function approximation and the analysis of linear vector space, the DQ method can be classified as polynomial-based DQ (PDQ) and Fourier series expansion-based DQ (FDQ) methods. PDQ is usually applied to non-periodic problems while FDQ can be applied to both periodic and non-periodic problems. But its performance for periodic problems is much better. The details of PDQ and FDQ methods and their application in engineering can be referred to the book of [3] which is the first book in the area to systematically describe the DQ method and its application in engineering.

Fourier Expansion Basis

The polynomial approximation is suitable for most of the engineering problems, but for some problems, especially for those with periodic behaviors, Fourier series expansion could be a better choice for the true solution instead of polynomial approximate the interval [0, 2π] [7] and [4] , the Fourier series expansion can be given by

f ( x ) = a 0 + k = 1 ( c k cos k x + d k sin k x ) (1.4)

where the coefficient a 0 , c k and d k are expressed as

a 0 = 1 0 f ( x ) d x , (1.5)

c k = 1 π 0 f ( x ) cos k x d x (1.6)

d k = 1 π 0 f ( x ) sin k x d x , (1.7)

For practical application, the truncated Fourier series expansion is usually used. Thus Equation (1.4) can be described as

f ( x ) = F N + 1 = a 0 + k = 1 N ( c k cos k x ) + k = 1 N ( d k sin k x ) (1.8)

Moreover, the convergence of the above Equation (1.8) of f ( x ) as N is guaranteed by Weirstrass’s second theorem. i.e.

The function f ( x ) be continuous on the interval [ 0 , 2 π ] . Then for any ε > 0 there exists an integer n and a trigonometric Sn such that the inequality

max x [ 0 , 2 π ] | f ( x ) s N ( x ) | < ε is satisfied for all values of x. (1.9)

where

s n ( x ) = a o + k = 1 N a k cos k x + k = 1 N b k sin k x (1.10)

1.2. Statement of the Problem

Consider the Coupled Viscous burgers’ Equation in Equations (1.1)-(1.3) is a nonlinear partial differential equation, by using Fourier basis based on weighted average differential quadrature method one can expect to find its’ solution numerically by using some approximation method.

In this regard [4] presented numerical simulations for the Coupled Viscous Burgers’ Equation and compared the results with experimental data recently; [9] proposed a Fourier Pseudospectral method for solving Coupled Viscous Burgers’ Equation; [10] and [11] applied differential quadrature method to solve the viscous Burgers’ Equation; [7] use finite difference and cubic spline finite element methods to solve Burgers’ equation; [10] and [11] used polynomial Differential quadrature method for numerical solution of coupled viscous Burger’ equations; [12] transform the Burgers’ equation to linear heat equation using Hopf-Cole transformation and then use explicit finite difference and exact explicit finite difference method to solve the transformed linear heat equation with Neumann boundary condition; [13] solve one dimensional Burgers’ Equation by using differential quadrature method based on Fourier Expansion basis; [10] used cubic B-spline collocation scheme based on Crank-Nicolson formulation for time integration and cubic B-spline functions for space integration by linearizing the nonlinear terms to solve coupled viscous Burgers’ Equation.

In this study, we look for the solution of coupled viscous Burger’ equation by applying the differential quadrature method based on Fourier Expansion basis. As a result, this study attempted to answer the following basic research questions.

1) How do we describe the differential quadrature method based on Fourier Expansion basis for coupled viscous Burgers’ equation?

2) How the present method is applied to solve coupled viscous Burgers’ equation?

3) To what extent the proposed method is approximate the exact solution?

1.3. Objectives of the Study

1.3.1. General Objective

The general objective of this study is to find the numerical solution of coupled viscous burger equation using differential quadrature method based on Fourier expansion basis.

1.3.2. Specific Objectives

The specific objectives of the present study are:

1) To describe the differential quadrature method based on fourier expansion basis in solving coupled viscous Burgers’ equation numerically.

2) To solve the coupled viscous Burgers’ equation using differential quadrature method based on a Fourier expansion.

3) To determine the accuracy that the proposed method approximate the exist solutions.

1.4. Significance of the Study

The outcomes of this study have the following importance to:

1) Find an alternative numerical solution of coupled viscous Burgers’ Equation.

2) Apply differential quadrature method based on Fourier expansion basis to find the solution for some practical problems like coupled viscous Burgers’ equation.

1.5. Delimitation of the Study

This study was delimited to the numerical solution of the coupled viscous Burgers’ equation.

The study also delimited to the practically most important (linear) differential quadrature based on Fourier expansion that are of the same type as differential quadrature and Fourier expansion formulas, i.e., linear combinations of weighted differential function evaluations and their error analysis for quadrature.

2. Methodology

2.1. Study Area and Period

The study was conducted in Jimma University under the department of mathematics from September 2016 G.C. to September 2017 G.C. Conceptually the study focus on the solution of coupled viscous Burgers’ equation using differential quadrature method based on Fourier expansion basis.

2.2. Study Design

This study was employed mixed-design (documentary review design and experimental design) on the coupled viscous Burgers’ equation type.

2.3. Source of Information

The relevant sources of information for this study is books, published articles and related studies from internet and the experimental results were obtained by writing MATLAB code for the present methods.

2.4. Mathematical Procedures

The study is an experimental as it evolves entirely laboratory work with the help of computer and MATLAB software. Farther, important materials for the study were collected by the researcher using the documentary analysis. The required numerical data was collected by coding and running using MATLAB software to get the numerical results and table of some examples that have exact solution, to show the validity and efficiency of the method. Hence, in order to achieve the stated objectives, the study was followed the procedures

1) Problem preparation or formulation.

2) Discretizing the space variable.

3) Replacing the partial differential equation (or the Coupled Viscous Burgers’ Equation) by using differential quadrature method based on Fourier expansion basis to obtain a system of first order ordinary differential equations.

4) The obtained systems of ordinary differential equations was solved by classical fourth order Runge-Kutta method.

5) Validating the schemes using numerical examples.

6) Writing MATLAB code for the method to solve the systems obtained.

3. Result and Discussion

3.1. Preliminaries

3.1.1. Differential Quadrature Method

In seeking an efficient discretization technique to obtain accurate numerical solution using a considerably small number of grid points, [1] and [14] introduced the method of differential quadrature (DQ).where a partial derivative of a function with respect to a coordinate direction is expressed as a linear weighted sum of all the functional values at all mesh points along that direction. The key to DQ is to determine the weighting coefficient for the discretization of a derivative of any order. [1] suggested two methods to determine the weighting coefficients of first order derivative. The first method is based on an ill-conditioned algebraic equation system and the second method uses a simple algebraic formulation, but the coordinates of the grid points are fixed by the roots of the shifted Legendre polynomial. In earlier applications of the DQ method, Bellman’s first method was usually used because it allows the use of arbitrary grid points distribution. However, since the algebraic equation system of this method is ill-conditioned, the number of the grid points usually used is less than 13 [15] . After that, [5] obtain explicit formulations to compute the weighting coefficient for the first and second order derivative. [16] presented a simple algebraic formulation to compute the weighting coefficient of the first order derivative without any restriction on the choice of the grid points and a recurrence relationship to compute the weighting coefficient of the DQ method and [3] and [17] have further developed some simple algebraic formulation to compute the weighting coefficient. Recently, the most frequently used DQ procedures to solve one and two dimensional differential equations are Lagrange interpolation polynomials based differential quadrature method (PDQM). The DQ method approximates the derivative of a smooth function at a grid point by a linear weighted summation of all the functional value in the whole computational domain.

The coupled viscous Burgers’ equation is a nonlinear partial differential equation of the form

u t u x x + η u u x + α ( u v ) x = 0 , x [ a , b ] , t [ 0 , T ]

v t v x x + ε v v x + β ( u v ) x = 0 , x [ a , b ] , t [ 0 , T ]

With initial condition

u ( x , 0 ) = ϕ 1 ( x ) , v ( x , 0 ) = ϕ 2 ( x ) , 0 x 1

The boundary condition

u ( a , t ) = f 1 ( a , t ) , v ( a , t ) = g 1 ( a , t )

u ( b , t ) = f 2 ( b , t ) , v ( b , t ) = g ( b , t ) , 0 t T

where η, α, ε and β are arbitrary constants depending on the system parameters.

3.1.2. Differential Quadrature Method Based on the Fourier Expansion basis

Let the first and second order derivative of u ( x ) at a point x i be approximated by the following equations

u x ( x i , t ) = j = 1 N a i j u ( x j , t ) for i = 1 , 2 , , N (4.1)

u x x ( x i , t ) = j = 1 N b i j u ( x j , t ) for i = 1 , 2 , , N (4.2)

where a i j and b i j represents the weighting coefficients of first and second derivative respectively, N is the number of grid points. And the key procedure in DQ is to determine the weighting coefficient.

For, the solution of any partial differential equation has to be convergent and bounded, so the solution u ( x ) of the viscous Burger equation be approximated by a Fourier expansion of the form

u ( x ) = a 0 + k = 1 N ( c k cos k π x + d k sin k π x ) (4.3)

u ( x ) in this equation constitutes an ( N + 1 ) dimensional linear vector space since

1 , sin π x , cos π x , sin 2 π x , cos 2 π x , , sin N π x and cos N π x (4.4a)

are linearly independent vectors.

Thus, we can consider (4.4a) as a set of base vectors.

Actually FDQ uses two sets of base functions, one is the base functions (4.4a) and the other is the terms of the Lagrange interpolating trigonometric polynomial given by

r k ( x ) = sin π ( x x 0 ) sin π ( x x 1 ) sin π ( x x k 1 ) sin π ( x x k + 1 ) sin π ( x x N ) sin π ( x k x 0 ) sin π ( x k x 1 ) sin π ( x k x k 1 ) sin π ( x k x k + 1 ) sin π ( x k x N ) (4.4b)

for k = 1 , 2 , 3 , , N .

Let

p ( x ) = k = 0 N r k ( x ) (4.5)

where

M ( x ) = k = 0 N sin π ( x x k ) (4.6)

p ( x i ) = k = 0 , k i N sin π ( x i x k ) (4.7)

By using the above two sets of base vectors to drive explicit formulations to compute the weighting coefficients of the first and second order derivatives, for the non-diagonal weighting coefficient we need to use the second set of base vectors. For simplicity, we set

M ( x ) = k = 0 N sin π ( x x k ) = N ( x , x k ) sin π ( x x k ) (4.8)

where

N ( x i , x k ) = k = 0 , k i N sin π 2 ( x i x k ) = p ( x i ) (4.9)

N ( x i , x j ) = N ( x i , x j ) δ i j where δ i j = { 1 if i = j 0 if i j is the Kronecker delta operator.

Then Equation (4.4b) can be reduced to

r k ( x ) = N ( x , x k ) p ( x k ) (4.10)

Using the same approach as in a polynomial differential quadrature method [18] we let all the base vectors given by Equation (4.10) satisfy Equations ((4.1) and (4.2)) and obtain

a i j = N ( x i , x j ) p ( x j ) (4.11)

b i j = N ( x i , x j ) p ( x j ) (4.12)

It is observed from Equations ((4.11) and (4.12)), the computation of a i j and b i j is equivalent to the evaluations of N ( x i , x j ) and N ( x i , x j ) since p ( x j ) can be calculated by Equation (4.9). We successively differentiate Equation (4.8) to get

M ( x ) = N ( x , x k ) sin π ( x x k ) + π N ( x , x k ) cos π ( x x k ) (4.13)

M ( x ) = N ( x , x k ) sin π ( x x k ) + 2 π N ( x , x k ) cos π ( x x k ) π 2 N ( x , x k ) sin π ( x x k ) (4.14)

M ( x ) = N ( x , x k ) sin π ( x x k ) + 3 π N ( x , x k ) cos π ( x x k ) 3 π 2 N ( x , x k ) sin π ( x x k ) π 3 N ( x , x k ) cos π ( x x k ) (4.15)

From the above equation, we can obtain the following result

M ( x i ) = π N ( x i , x i ) = π p ( x i ) (4.16)

N ( x i , x j ) = π p ( x i ) sin π ( x i x j ) where i j (4.17)

N ( x i , x j ) = M ( x i ) π (4.18)

N ( x i , x j ) = M ( x i ) π N ( x i , x j ) cos π ( x i x j ) sin π ( x i x j ) where i j (4.19)

N ( x i , x j ) = 2 [ M ( x i ) + π 3 8 N ( x i , x i ) ] (4.20)

Substituting Equations ((4.16) and (4.17)) in to Equation (4.11) we obtain

a i j = π p ( x i ) sin π ( x i x j ) p ( x j ) where i j (4.21)

a i i = M ( x i ) π p ( x j ) (4.22)

Similarly substituting Equations ((4.19) and (4.20)) in to (4.12) and using Equations ((4.17), (4.18)), we obtain

b i j = a i j [ 2 a i i π cot π ( x i x j ) ] where j i (4.23)

b i i = 2 [ M ( x i ) p ( x i ) + π 3 8 ] (4.24)

From Equations ((4.21) and (4.23)), a i j and b i j ( i j ) can be obtained.

However, the calculation of a i i from Equation (4.22) and b i i from Equation (4.24) involve the computation of M ( x i ) and M ( x i ) which are not easy to compute by applying the second set of base vectors 1 , sin ( π x ) , cos ( π x ) , sin ( 2 π x ) , cos ( 2 π x ) , , sin ( N π x ) , cos ( N π x ) let the vector 1 satisfy Equation (4.1) and (4.2) and then obtain

j = 1 N a i j = 0 (4.25)

j = 1 N b i j = 0 (4.26)

Using Equations ((4.21), (4.23), (4.25) and (4.26)), the weighting coefficients of the first and second order derivatives can be calculated with FDQ. It should be indicated that these equations can be applied to the periodic problems and the non-periodic problems. For the non-periodic problems, the range in the computational domain is 0 x π , while for the periodic problems, the range in the computational domain is 0 x 2 π .

3.2. Main Results and Discussion

The coupled viscous Burgers’ Equations (1.1)-(1.3) can be discretized in the Cartesian coordinate system as

d u ( x i , t ) d t = j = 1 N b i j u ( x j , t ) η u ( x i , t ) j = 1 N a i j u ( x j , t ) α ( u ( x i , t ) j = 1 N a i j v ( x j , t ) + v ( x i , t ) j = 1 N a i j u ( x j , t ) ) , x i [ a , b ] d v ( x i , t ) d t = j = 1 N b i j v ( x j , t ) ε v ( x i , t ) j = 1 N a i j v ( x j , t ) β ( u ( x i , t ) j = 1 N a i j v ( x j , t ) + v ( x i , t ) j = 1 N a i j u ( x j , t ) ) , x i [ a , b ] (4.27)

With initial condition

u ( x i , 0 ) = ϕ 1 ( x i ) , v ( x i , 0 ) = ϕ 2 ( x i ) , x i D

The boundary condition

u ( a , t ) = f 1 ( a , t ) , v ( a , t ) = g 1 ( a , t )

u ( b , t ) = f 2 ( b , t ) , v ( b , t ) = g 2 ( b , t ) , 0 t T

where η, α, ε and β are arbitrary constants depending on the system parameters.

Where N is the number of grid points, a i j and b i j are the weighting coefficients in the x direction, and when FDQ method is used a i j and b i j are computed by Equations ((4.21), (4.23)). The resulting system of ODEs (4.27) can now be solved by using the classical fourth order Runge-Kutta method.

3.2.1. Numerical Experiments

In this section, we consider two examples to test the efficiency of the proposed method. For describing the error, we consider maximum error norm for u defined as follows

E ( u ) = max 1 j N | u ( x j , t ) u N ( x j , t ) | (4.28)

where u ( x j , t ) is exact solution of the problem and u N ( x j , t ) is the numerical solution at the same mesh points obtained by DQM based on Fourier Expansion basis.

To illustrate the efficiency of the proposed numerical scheme, we solve two test examples and throughout the numerical experiment, we consider step length in time space Δ t .

Example 1

Consider the coupled viscous Burgers’ equation with the initial and boundary condition taken as follows. u ( x , 0 ) = sin (x)

v ( x , 0 ) = sin ( x ) , π x π , t > 0 (4.29a)

u ( π , t ) = u ( π , t ) = 0 , v ( π , t ) = v ( π , t ) = 0 (4.29b)

The exact solution taken from [8]

u ( x , t ) = e t sin ( x ) , v ( x , t ) = e t sin ( x ) , π x π , t > 0

The numerical results are computed with different time step length Δ t and various values of parameters, α, ε and β. The maximum absolute error obtain with Δ t = 0.01 up to T = 3 are reported in Table 1. It is also shown in Table 2 that absolute errors become reduced when the time step is reduced.

Example 2

In this problem, we consider the coupled viscous Burger equation with initial conditions

u ( x , 0 ) = a 0 2 A ( 2 α 1 4 α β 1 ) tanh ( A x ) ; 10 x 10 (4.30a)

v ( x , 0 ) = a 0 ( 2 β 1 2 α 1 ) 2 A ( 2 α 1 4 α β 1 ) tanh ( A x ) (4.30b)

Table 1. Maximum errors norm of Example 1 for η = 2 , ε = 2 , α = 1 , β = 1 at step length Δ t = 0.01 .

Table 2. Maximum absolute norm of u and v of Example 1 for different values of Δ t the proposed method, at t = 1.

The exact solution are given by [19]

u ( x , t ) = a 0 2 A ( 2 α 1 4 α β 1 ) tanh ( A ( x 2 A t ) ) , 10 x 10 , t 0 v ( x , t ) = a 0 ( 2 β 1 2 α 1 ) 2 A ( 2 α 1 4 α β 1 ) tanh ( A ( x 2 A t ) ) , 10 x 10 , t > 0

where A = a 0 4 α β 1 4 α 2 and a 0 , α , β are arbitrary constants. In Table 3 and

Table 4, we present comparison between the numerical solutions obtained by the present method and the method proposed in literature. Table 3 and Table 4 shows the maximum absolute errors for η = 1 , ε = 2 and various values of α and β .

From Table 1 and Table 2 it can be seen that the solution of Maximum absolute norm u and v decrease to zero at a time t as the value of η , ε increase it can also observed that the Differential quadrature method based on Fourier Expansion basis method is capable of finding numerical solution for larger value of η , ε .

Here the parameters α and β determine the size of the boundary layer near the edges of the domain. We use the value of η = 1 , ε = 2 in our numerical experiment.

Table 3. Comparison of numerical results of Example 2 with the results obtained by [9] and [11] for the variable u with a 0 = 0.05 , N = 21 with Δ t = 0.01 .

Table 4. Comparison of numerical results of Example 2 with the results obtained by [9] and [11] for the variable v with a 0 = 0.05 , N = 21 with Δ t = 0.01

In this case we solve the PDE on the random point distribution. The optimal shape parameter α and β is also taken the same as we achieved in the linear PDE case. The error norm in Table 2 shows as differential quadrature method based on Fourier expansion basis. Also works well for this nonlinear problem. However, it is shown that the method can be fluctuated as applied to a wide class of higher-dimension, nonlinear partial differential equations with a little modification depending on the system parameters. In Table 3 and Table 4 we compare the differential quadrature method results with those available ones in the literature. As seen from Table 3 and Table 4 the differential quadrature method based on Fourier expansion is quite comparable with those methods in the literature.

4. Conclusions and Future Scope

4.1. Conclusions

This study demonstrates the application of FDQ method to solve one-dimensional coupled viscous Burgers’ equation. This method produces a system of first order ordinary differential equations, which can be solved numerically by the classical fourth order Runge-Kutta method. To verify the method two test problems have been considered and the results obtained are compared with some other methods which are available in the literature. The numerical solutions obtained show that the present method produces reasonably accurate numerical solution of coupled viscous Burgers’ equation.

Therefore differential quadrature method based on Fourier expansion basis is a reliable method to obtain the numerical solution of some physically important nonlinear problems governed by partial differential equation; this is because it brings the problem into a smooth and periodic one.

If the viscous term is dropped from the Burgers' equation the nonlinearity allows discontinuous solutions to develop. A wave is convicting from left to right and solutions for successive times are indicated. Points on the wave with larger values of u convict faster and consequently overtake parts of the wave convicting with smaller values of u . Coupled viscous Burgers’ equation is the nonlinear partial differential equation, that encounters in the theory of shock waves, mathematical modeling of turbulent fluid and in continuous stochastic processes. It is necessary to postulate a shock across which u changes discontinuously to have a unique solution and so a physically result.

It is shown that the present numerical scheme gives better solutions on most of the grid points. However, it is shown that the method can be fluctuated as applied to a wide class of higher-dimension, nonlinear partial differential equations with a little modification depending on the system parameters.

4.2. Future Scope

In the future by applying different differential quadrature method, I will try to solve different partial differential equations numerically.

Acknowledgements

We all authors need to pass our heartfelt thanks to Jimma University for funding and supporting this important applicable paper.

Conflicts of Interest

The authors declare no conflicts of interest regarding the publication of this paper.

Conflicts of Interest

The authors declare no conflicts of interest.

References

[1] Bellman, R. and Casti, J. (1971) Differential Quadrature and Long-Term Integration. Journal of Mathematical Analysis and Applications, 34, 235-238.
https://doi.org/10.1016/0022-247X(71)90110-7
[2] Stroud, A.H. and Secrest, D. (1992) Gaussian Quadrature Formulas. Prentice-Hall, Englewood Cliffs, New Jersey.
[3] Shu, C. and Chew, Y.T. (1999) Application of Multi-Domain GDQ Method to Analysis of Waveguides with Rectangular Boundaries. In: Kong, J.A., Ed., Progress in Electromagnetics Research, PIER 21, Electromagnetic Waves, Series 21, EMW, Cambridge, Massachusetts, Chapter 1, 1-18.
https://doi.org/10.2528/PIER98052601
[4] Esipov, S.E. (1995) Coupled Burgers’ Equations: A Model of Polydispersive Sedimentation. Physical Review E, 52, 3711-3718.
https://doi.org/10.1103/PhysRevE.52.3711
[5] Quan, J.R. and Chang, C.T. (1989) New Insights in Solving Distributed System Equations by the Quadsrature Methods-II. Computers & Chemical Engineering, 13, 1017-1024.
https://doi.org/10.1016/0098-1354(89)87043-7
[6] Quan, J.R. and Chang, C.T. (1989) New Insights in Solving Distributed System Equations by the Quadrature Methods-I. Computers & Chemical Engineering, 13, 779-788.
https://doi.org/10.1016/0098-1354(89)85051-3
[7] Lejeune-Dirichlet, P. (1829) Sur la convergence des séries trigonométriques qui servent à représenter une fonction arbitraire entre des limites données. [On the Convergence of Trigonometric Series Which Serve to Represent an Arbitrary Function between Two Given Limits.] Journal für die reine und angewandte Mathematik, 4, 157-169. (In French)
https://doi.org/10.1515/crll.1829.4.157
[8] Kaya, D. (2001) An Explicit Solution of Coupled Burgers’ Equations by Decomposition Method. IJMMS, 27, 3711-3718.
[9] Rashid, A. and Ismail, A.I.B.M. (2009) A Fourier Pseudospectral Method for Solving Coupled Viscous Burgers’ Equations. Computational Methods in Applied Mathematics, 9, 412-420.
https://doi.org/10.2478/cmam-2009-0026
[10] Mittal, R.C. and Arora, G. (2011) Numerical Solution of the Coupled Viscous Burgers’ Equation. Communications in Nonlinear Science and Numerical Simulation, 16, 1304-1313.
https://doi.org/10.1016/j.cnsns.2010.06.028
[11] Jiwari, R., Pandit, S. and Mittal, R.C. (2012) Numerical Simulation of Two-Dimensional Sine-Gordon Solitons by Differential Quadrature Method. Computer Physics Communications, 183, 600-616.
https://doi.org/10.1016/j.cpc.2011.12.004
[12] Séroul, R. (2000) Lagrange Interpolation. In: Programming for Mathematicians, Springer-Verlag, Berlin, 269-273, §10.9.
[13] Mamo, T., Shiferaw, A. and Jima, M. (2017) Numerical Solution of Burgers’ Equation Using Fourier Expansion Based on Differential Quadrature Method. Asian Journal of science and Technology, 8, 4760-4768.
[14] Jiwari, R., Mittal, R.C. and Sharma, K.K. (2013) A Numerical Scheme Based on Weighted Average Differential Quadrature Method for the Numerical Solution of Burgers’ Equation. Applied Mathematics and Computation, 219, 6680-6691.
https://doi.org/10.1016/j.amc.2012.12.035
[15] Weierstrass, K. (1886) Sur la possibilité d’une représentation analytique des fonctions dites arbitraires d’une variable réelle. Journal de Mathématiques Pures et Appliquées, 2, 105-113, 115-138.
[16] Shu, C. (2000) Differential Quadrature and Its Application in Engineering. Athenaeum Press Ltd., Great Britain.
https://doi.org/10.1007/978-1-4471-0407-0
[17] Shu, C. and Xue, H. (1997) Explicit Computation of Weighting Coefficients in the Harmonic Differential Quadrature. Journal of Sound and Vibration, 204, 549-555.
https://doi.org/10.1006/jsvi.1996.0894
[18] Pike, J. and Roe, P.L. (1985) Accelerated Convergence of Jameson’s Finite Volume Euler Scheme Using Van Der Houwen Integrators. Computers & Fluids, 13, 223-236.
https://doi.org/10.1016/0045-7930(85)90027-1
[19] Soliman, A.A. (2006) The Modified Extended Tanh-Function Method for Solving Burgers-Type Equations. Physica A, 361, 394-404.
https://doi.org/10.1016/j.physa.2005.07.008

Copyright © 2024 by authors and Scientific Research Publishing Inc.

Creative Commons License

This work and the related PDF file are licensed under a Creative Commons Attribution 4.0 International License.