Skip to main content

Theory and Modern Applications

An extrapolation full multigrid algorithm combined with fourth-order compact scheme for convection–diffusion equations

Abstract

In this paper, we propose an extrapolation full multigrid (EXFMG) algorithm to solve the large linear system arising from a fourth-order compact difference discretization of two-dimensional (2D) convection diffusion equations. A bi-quartic Lagrange interpolation for the solution on previous coarser grid is used to construct a good initial guess on the next finer grid for V- or W-cycles multigrid solver, which greatly reduces the number of relaxation sweeps. Instead of performing a fixed number of multigrid cycles as used in classical full multigrid methods, a series of grid level dependent relative residual tolerances is introduced to control the number of the multigrid cycles. Once the fourth-order accurate numerical solutions are obtained, a simple method based on the midpoint extrapolation is employed for the fourth-order difference solutions on two-level grids to construct a sixth-order accurate solution on the entire fine grid cheaply and directly. Numerical experiments are conducted to verify that the proposed method has much better efficiency compared to classical multigrid methods. The proposed EXFMG method can also be extended to solve other kinds of partial differential equations.

1 Introduction

Richardson extrapolation [1, 2] is an acceleration method, used to improve the rate of convergence for a sequence. In 1983, Marchuk and Shaidurov extended Richardson extrapolation technique in the framework of the finite difference (FD) method [3]. Later on, Blum et al. discussed Richardson extrapolation strategy in conjunction with the finite element (FE) method [47].

Multigrid methods (MGs) [8, 9] have been shown to be one of the most efficient modern numerical strategies to solve the large linear systems arising from FE or FD discretizations of partial differential equations (PDEs), such as the Poisson equation [1014], Helmholtz equation [1517], convection–diffusion equation [1820]. The main advantage of the multigrid method is that its convergence rate is independent of the number of unknowns [8, 21]. The full multigrid (FMG) method, which combines nested iteration with a V- or W-cycles multigrid method, is well known to be optimal with respect to the energy norm and the \(L^{2}\)-norm [8, 2123]. It starts on the coarsest grid with a direct solver, then the solution is interpolated to form the initial guess on the next finer grid, where a few V- or W-cycles are used to produce an approximate solution whose algebraic error matches with the discretization error. The procedure goes on recursively until the finest grid.

Recently, the Richardson extrapolation technique has been applied in multigrid methods. One group of researchers used Richardson extrapolation to construct a good initial guess for the iterative solver. An extrapolation cascadic multigrid (EXCMG) method [24, 25] was proposed by Chen et al. to solve second-order elliptic problems. This method uses a new extrapolation formula to construct a quite good initial guess for the iterative solution on the next finer grid, which greatly improves the convergence rate of the original CMG algorithm (see [2426] for details). Then the EXCMG method has been successfully applied to non-smooth elliptic problems [27, 28], parabolic problems [29], and some other related problems [3032]. Moreover, Pan [33] and Li [34, 35] developed some EXCMG methods combined with high-order compact difference schemes to solve Poisson equations. In 2017, Hu et al. [36] obtained the super-optimality of the EXCMG method under the energy norm for \(H^{2+\alpha }\)-regular \((0<\alpha \leq 1)\) elliptic problems.

Another group of researchers made efforts to design an iterative procedure with Richardson extrapolation strategy to enhance the solution accuracy on the finest grid. Sun, Zhang and Dai developed a sixth-order FD scheme for solving the 2D convection–diffusion equation [37, 38]. In their approach, the ADI method is applied to compute the fourth-order accurate solution on the fine and coarse grids, respectively, then the Richardson extrapolation technique and an operator-based interpolation scheme are employed in each ADI iteration to calculate the sixth-order accurate solution on the fine grid. In 2009, Wang and Zhang designed an explicit sixth-order compact discretization strategy (MG-Six) for the 2D Poisson equation [39]. They used a V-cycle multigrid method to get the fourth-order accurate solutions on both the fine and the coarse grids first, and then chose the iterative operator with Richardson extrapolation technique to compute the sixth-order accurate solution on the fine grid.

We extend the idea described in the literature [32, 33, 39] to the original full multigrid method, and develop an extrapolation full multigrid (EXFMG) method to solve the 2D convection–diffusion equation with a fourth-order compact difference discretization. To be more precise, a bi-quartic Lagrange interpolation operator on a coarser grid is applied to get a good initial guess on the next finer grid for the multigrid V- or W-cycles solver. Besides, a stopping criterion related to relative residual is used to conveniently obtain the numerical solution with the desired accuracy. Moreover, a mid-point extrapolation strategy is used to obtain cheaply and directly a sixth-order accurate solution on the entire fine grid from two fourth-order solutions on two different grids (current fine and previous coarse grids). Finally, through two examples chosen from the literature, the computational efficiency of the EXFMG method is discussed in detail.

The rest of the paper is organized as follows. Section 2 introduces the model problem and a fourth-order compact difference scheme. Section 3 depicts the classical multigrid method. And the extrapolation full multigrid method is described in Sect. 4. Numerical results are given in Sect. 5 to show the efficiency and high-order accuracy of the new algorithm. Finally, concluding remarks are provided in Sect. 6.

2 Model problem and discretization

Consider the following two-dimensional (2D) convection–diffusion equation:

$$ -u_{xx} (x,y) - u_{yy} (x,y) + p(x,y)u_{x}(x,y)+q(x,y)u_{y}(x,y) = f(x,y), \quad (x,y) \in \Omega , $$
(1)

with suitable Dirichlet boundary conditions. Here Ω is a rectangular domain, \(p(x, y)\) and \(q(x, y)\) are the given convection velocities, \(f(x,y)\) is the given source term, and \(u(x,y)\) is the unknown function. All these functions are assumed to be sufficiently smooth and have the necessary continuous partial derivatives up to certain orders. This equation is used to describe many processes in fields of fluid dynamics.

Let \(\Omega =[0,M_{x}]\times [0,M_{y}] \) and divide Ω into \(N_{x} \times N_{y}\) uniform grids with the mesh size \(\Delta x = \frac{ {M_{x} }}{{N_{x} }}\) and \(\Delta y = \frac{{M_{y} }}{{N_{y} }}\) in the x and y coordinate directions, respectively. \(N_{x}\) and \(N_{y}\) are the numbers of uniform intervals in the x and y directions, respectively. The mesh points are \((x_{i},y _{j})\) with \(x_{i}=i\Delta x\) and \(y_{i}=i\Delta y\), \(0 \le i \le N _{x}\), \(0 \le j \le N_{y}\). For simplicity, we use \(U_{i,j}\) to represent the approximation of \(u(x_{i},y_{j})\) at the mesh point \((x_{i},y_{j}) \), set \(f_{i,j}=f(x_{i},y_{j})\), \(p_{i,j}=p(x_{i},y_{j})\), and so on.

The fourth-order compact difference scheme for Eq. (1) with nine-point computational stencil is given by [40]

$$\begin{aligned} & \biggl( \frac{4A_{i,j}}{\Delta x ^{2} \Delta y^{2} }-\frac{2D_{i,j}}{ \Delta x^{2}}-\frac{2E_{i,j}}{\Delta y^{2}} \biggr)U_{ij} + \biggl( \frac{-2A_{i,j}}{ \Delta x ^{2} \Delta y^{2} }-\frac{C_{i,j}}{\Delta x \Delta y^{2}}+ \frac{D _{i,j}}{\Delta x^{2}}+ \frac{G_{i,j}}{2 \Delta x} \biggr)U_{i + 1,j} \\ & \quad{} + \biggl( \frac{-2A_{i,j}}{\Delta x ^{2} \Delta y^{2} }+\frac{C_{i,j}}{ \Delta x \Delta y^{2}}+ \frac{D_{i,j}}{\Delta x^{2}}- \frac{G_{i,j}}{2 \Delta x} \biggr)U_{i - 1,j} \\ & \quad{} + \biggl( \frac{-2A_{i,j}}{\Delta x ^{2} \Delta y^{2} }- \frac{B_{i,j}}{2\Delta x^{2} \Delta y}+ \frac{E_{i,j}}{\Delta y ^{2}}+ \frac{H_{i,j}}{2\Delta y} \biggr)U_{i,j + 1} \\ & \quad{} + \biggl( \frac{-2A_{i,j}}{\Delta x ^{2} \Delta y^{2} } + \frac{B_{i,j}}{ \Delta x^{2} \Delta y }+ \frac{E_{i,j}}{\Delta y^{2}}- \frac{H_{i,j}}{2 \Delta y} \biggr)U_{i,j - 1} \\ & \quad{} + \biggl( \frac{A_{i,j}}{\Delta x ^{2} \Delta y^{2} }+ \frac{B _{i,j}}{2\Delta x^{2} \Delta y}- \frac{C_{i,j}}{2 \Delta x \Delta y ^{2}}- \frac{K_{i,j}}{4 \Delta x \Delta y} \biggr)U_{i - 1,j+1} \\ & \quad{} + \biggl( \frac{A_{i,j}}{\Delta x ^{2} \Delta y^{2} }-\frac{B_{i,j}}{2 \Delta x^{2} \Delta y}+ \frac{C_{i,j}}{2 \Delta x \Delta y^{2}}- \frac{K _{i,j}}{4 \Delta x \Delta y} \biggr)U_{i + 1,j-1} \\ & \quad{} + \biggl( \frac{A_{i,j}}{\Delta x ^{2} \Delta y^{2} }+ \frac{B_{i,j}}{2\Delta x^{2} \Delta y}+ \frac{C _{i,j}}{2 \Delta x \Delta y^{2}}+ \frac{K_{i,j}}{4 \Delta x \Delta y} \biggr)U _{i + 1,j+1} \\ & \quad{} + \biggl( \frac{A_{i,j}}{\Delta x ^{2} \Delta y^{2} }- \frac{B_{i,j}}{2 \Delta x^{2} \Delta y}- \frac{C_{i,j}}{2 \Delta x \Delta y^{2}}+ \frac{K _{i,j}}{4 \Delta x \Delta y} \biggr)U_{i -1,j-1} =F_{i,j} , \end{aligned}$$
(2)

with the coefficients

$$\begin{aligned} &A_{i,j}=-\frac{\Delta x^{2}+\Delta y^{2}}{12}, \qquad B_{i,j}= \frac{ \Delta x^{2}+\Delta y^{2}}{12}q_{i,j}, \qquad C_{i,j}=\frac{\Delta x ^{2}+\Delta y^{2}}{12}p_{i,j}, \\ &D_{i,j}=-1+\frac{\Delta x^{2}}{12} \bigl[2(p_{x})_{i,j})-p_{i,j}^{2} \bigr], \qquad E_{i,j}=-1+\frac{\Delta y^{2}}{12} \bigl(2(q_{y})_{i,j}-q_{i,j}^{2} \bigr), \\ &K_{i,j}=\frac{\Delta x^{2}}{12} \bigl[2(q_{x})_{i,j} -(pq)_{i,j} \bigr]+\frac{ \Delta y^{2}}{12} \bigl[2(p_{y})_{i,j}-(pq)_{i,j} \bigr], \\ &G_{i,j}=p_{i,j}+\frac{\Delta x^{2}}{12} \bigl[ (p_{xx})_{i,j} -(pp_{x})_{i,j} \bigr]+ \frac{ \Delta y^{2}}{12} \bigl[(p_{yy})_{i,j}-(p_{y}q)_{i,j} \bigr], \\ &H_{i,j}=q_{i,j}+\frac{\Delta x^{2}}{12} \bigl[ (q_{xx})_{i,j} -(pq_{x})_{i,j} \bigr]+ \frac{ \Delta y^{2}}{12} \bigl[(q_{yy})_{i,j}-(qq_{y})_{i,j} \bigr], \\ &F_{i,j}=f_{i,j}+\frac{\Delta x^{2}}{12} \bigl[ (f_{xx})_{i,j} -(pf_{x})_{i,j} \bigr]+ \frac{ \Delta y^{2}}{12} \bigl[(f_{yy})_{i,j}-(qf_{y})_{i,j} \bigr]. \end{aligned}$$
(3)

Now set \(h_{1}=\Delta x=\Delta y\) and assume that the domain Ω is divided into a sequence of grids \(\Omega_{k}, k=1,2, \ldots , L\) with mesh size \(h_{k}={h_{1}}/{2^{k-1}}\). By applying the fourth-order compact scheme (2), we obtain the corresponding sparse linear system,

$$ A_{k} u_{k} = F_{k}, \quad k=1,2, \ldots ,L, $$
(4)

where \(A_{k}\) is a nine-diagonal matrix, \(F_{k}\) and \(u_{k}\) are the right-hand side vector and the solution vector, respectively.

3 Classical multigrid method

The multigrid (MG) method is a very efficient approach to solving large sparse linear systems arising from FE or FD discretizations of various PDEs [8]. The main feature behind the MG method is to divide the errors into high frequency components and low frequency components and eliminate them in different grids. To be more specific, the high frequency component errors are eliminated on the fine grid, while the remaining low frequency errors are eliminated by a recursive procedure on the coarse grid. We depict this method in Algorithm 1, in which a direct solver “DSOLVER” is used on the coarsest grid, since the size of the linear system is small. A restriction operator \(R^{j}_{j+1} \) (such as a full-weighting scheme) is employed to project residual from the fine grid to the coarse grid, and an interpolation operator \(I_{j}^{j+1}\) (such as bilinear interpolator) is used to transfer corrections from the coarse grid to the fine grid. The recursion parameter \(N_{\textrm{cycles}}\) is greater than or equal to one. If Ncycles = 1, the so-called V-cycle is generated, while Ncycles = 2 leads to the W-cycle. A cycle of Algorithm 1, means that it starts from the finest grid to the coarsest grid and back to the finest grid again. When Algorithm 1 is applied to the finest grid system (2) in the solution of which we are interested, it can be repeated until the accuracy of approximation on the finest grid is considered to be high enough.

Algorithm 1
figure a

Classical multigrid method: \(u_{L} \Leftarrow \textrm{MGM} (A_{L}, u_{L}^{0}, F_{L},L)\)

In fact, Algorithm 1 can be incorporated with the classical FMG method naturally. The FMG method starts with the coarsest grid, and uses an interpolation operator \(P_{j-1}^{j}\) to produce an initial guess for Algorithm 1 on the next finer grid; see Algorithm 2 for details. The interpolation operator \(P_{j-1}^{j}\) usually is of higher accuracy than the interpolation operator \(I_{j-1}^{j}\) used within the multigrid iteration. It is well known that FMG delivers an approximation up to discretization accuracy if the multigrid cycle converges satisfactorily and if the order of FMG interpolation is larger than the discretization order of the PDE [8].

Algorithm 2
figure b

Full multigrid method (FMG)

4 Extrapolation full multigrid method

4.1 Description of the EXFMG algorithm

In this section, we shall establish an extrapolation full multigrid (EXFMG) method to solve the 2D convection–diffusion equation (1) with the fourth-order compact discretization (2). Similar to FMG method, the EXFMG method starts with the coarsest grid to compute the solution by a direct solver, and applies an interpolation operator on the current grid to provide an initial guess for Algorithm 1 on the next finer grid. Besides, EXFMG method employs a fine mesh Richardson extrapolation technique [33] to get an extrapolation solution on each grid, when the two solutions with fourth-order accuracy on current and previous grids has been obtained by the Algorithm 1. The detailed algorithm is stated in Algorithm 3, where \(FMRE\) denotes a fine mesh Richardson extrapolation operator which will be defined and discussed in Sect. 4.2, \(\bar{u}_{i}^{*} \) and \(u_{j}^{*}\) denote the numerical solution and extrapolated solution on the grid \(\Omega_{i}\), respectively.

Algorithm 3
figure c

Extrapolation full multigrid method (EXFMG)

The key ingredients of this new method which are the main differences between the existing FMG methods include:

  1. (1)

    A bi-quartic Lagrange interpolation operator on coarse grid is taken as a full interpolation to provide a good initial guess on the next finer grid for multigrid iteration.

  2. (2)

    Instead of performing a fixed number of multigrid iterations at each level of grid as used in the usual FMG method, a tolerance \(\epsilon _{j}\) related to the relative residual is used on jth grid level (see line 4 in Algorithm 3), which enables us to conveniently calculate the approximate solution with the desired accuracy and keep suitable computational cost.

  3. (3)

    The FMG method only computes the fourth-order accuracy solution of each discretization system. But the extrapolation method based on the midpoint formula (see line 5 in Algorithm 3 and Sect. 4.2) enhances the solution accuracy on each grid (see numerical results section for details).

4.2 Fine mesh extrapolation operator

In the classical Richardson extrapolation formula, two solutions on fine and coarse grids are used to obtain an extrapolation solution on the coarse grid. Based on the Richardson extrapolation technique and interpolation theory, in 2017, Pan proposed a mid-point extrapolation technique to enhance the accuracy of approximations on fine grid directly and cheaply (see [33] for details). Now, we will introduce this strategy for 2D case in the following.

Assume that the notations \(u^{h}\) and \(u^{h/2}\) represent the fourth-order accurate solutions on coarse grid \(\Omega_{h}\) and fine grid \(\Omega_{h/2}\) with mesh size h and \(h/2\), respectively. For simplicity of description, we take a coarse cell \(I_{i,j}=[x_{i},x_{i+1}]\times [y_{j},y_{j+1}]\) of grid \(\Omega_{h}\) (see Fig. 1), use \(u_{i,j}^{h}\) and \(u_{i,j}^{h/2}\) to represent the fourth-order accurate solutions on the point \((x_{i},y _{j})\) of the coarse grid \(\Omega_{h}\) and the fine grid \(\Omega_{h/2}\), respectively. Here \((x_{i},y_{j+1/2}) \in \Omega_{h/2} \) denotes the mid-point of \((x_{i},y_{j}) \in \Omega_{h} \) and \((x_{i},y_{j+1}) \in \Omega_{h}\).

Figure 1
figure 1

Cells of coarse grid \(\Omega_{h}\) (a) and refined grid\(\Omega_{h/2}\) (b)

To obtain an extrapolation solution on the fine grid \(\Omega_{h/2}\), we first use the classical Richardson extrapolation formula,

$$ Eu_{s, t} = \frac{16}{15}u^{h/2}_{s, t} - \frac{1}{15}u^{h}_{s, t}, \quad s=i, i+1, t=j, j+1, $$
(5)

to get an extrapolation solution on the nodes \((x_{s},y_{t})\). Then we apply the mid-point extrapolation formula [33] for those nodes \((x_{s},y_{j+1/2}) \), \((x_{i+1/2},y_{t}) \) and \((x_{i+1/2},y _{j+1/2}) \), to obtain some formulas as follows:

$$\begin{aligned}& Eu_{s,j+1/2}= u^{ h/2}_{s,j+1/2} + \frac{1}{{30}} \bigl[ \bigl(u^{h/2} - u^{h} \bigr)_{s,j} + \bigl( u^{h/2} - u^{h} \bigr)_{s,j+1} \bigr], \quad s=i, i+1, \end{aligned}$$
(6)
$$\begin{aligned}& Eu_{i+1/2,t}= u^{h/2}_{i+1/2,t} + \frac{1}{30} \bigl[ \bigl(u^{h/2} - u^{h} \bigr)_{i ,t} + \bigl( u^{h/2} - u^{h} \bigr)_{i+1,t} \bigr], \quad t=j, j+1, \end{aligned}$$
(7)
$$\begin{aligned}& Eu_{i+1/2,j+1/2}= u^{h/2}_{i+1/2,j+1/2} + \frac{1}{{60}} \bigl[ \bigl(u^{h/2} - u ^{h} \bigr)_{i,j} + \bigl( u^{h/2} - u^{h} \bigr)_{i+1,j} + \bigl(u^{h/2} - u^{h} \bigr)_{i,j+1} \\& \hphantom{Eu_{i+1/2,j+1/2}= }{}+ \bigl( u^{h/2} - u^{h} \bigr)_{i+1,j+1} \bigr], \end{aligned}$$
(8)

in order to construct the corresponding extrapolation solution, respectively.

Taking the above four extrapolation formulas (5), (6), (7) and (8), we can obtain an extrapolation solution Eu, which is more accurate than the fourth-order accurate numerical solution \(u^{h/2}\) on the fine grid \(\Omega_{h/2}\). For simplicity, we denote this procedure from \(u^{h}\), \(u^{h/2}\) to Eu as an operator, we call it as fine mesh Richardson extrapolation (\(FMRE\)) interpolator

$$ \textstyle\begin{array}{l} Eu \Leftarrow FMRE(u^{h},u^{h/2}). \end{array} $$
(9)

Remark 4.1

It should be noted that the extrapolation interpolator \(FMRE\) is a local operation, which can be done very effectively.

4.3 Computational work

Throughout this paper, when using Algorithm 1 as a solver on each grid of the EXFMG method, we always set \(N_{\textrm{cycles}} =1\). Now we turn to estimate the computational cost of the EXFMG method in terms of \(work\) \(units\) (WUs). Roughly speaking, “1 WU” is the computational cost of performing one relaxation sweep on the finest grid. For simplicity, we neglect the amount of work needed to solve the equations on the coarsest grid and the transfer operators (include interpolation and restriction) between different levels of grids since it normally counts 10–20% of the total cost of the algorithm.

Assume that the \(m_{j}\) is the number of the MG cycles required on the grid \(\Omega _{j}\) when the MG solution satisfies the stopping criterion (see line 4 in Algorithm 3). Based on the above conditions, we can estimate the computational work of EXFMG with L levels of grids for d-dimensional problems as follows:

$$\begin{aligned} WU_{\textrm{EXFMG}} & \approx (v_{1} + v_{2}) \bigl[m_{L} +(m_{L}+m _{L-1}) 2^{ - d} + \cdots + (m_{L}+m_{L-1}+\cdots +m_{2}) 2^{ -( L-2)d} \bigr] \\ & = (v_{1} + v_{2})\sum_{j = 2}^{L} {\sum_{i = j}^{L} {m_{i}2^{ - d(L - j)} } } WU. \end{aligned}$$
(10)

5 Numerical experiments

In this section, we conduct numerical experiments with two examples both on the unit square domain \(\Omega =(0,1)\times (0,1)\). In the two test problems, the right-hand side function \(f(x,y)\) and the Dirichlet boundary conditions on Ω are prescribed to satisfy the given analytic solutions \(u(x,y)\). Our codes are written in Matlab and the programs are carried out on a desktop with Inter (R) Core(TM) i5-6200 U CPU (2.30 GHZ, 2.40 GHZ) and 4 GB RAM.

For comparison purposes, we denote the Algorithm 1 with \(N_{\textrm{cycles}} =1\) as MG. The iterative procedure of MG method starts with zero initial guesses and terminates when the approximation solution \(u_{L}^{*}\) on the finest grid satisfies the same stopping criterion \({{\Vert F_{L} - A_{L} u_{L}^{*} \Vert }} \le \epsilon _{L} {{\Vert F_{L} \Vert }}\) as the EXFMG algorithm.

In MG and EXFMG methods with L embedded grids, the standard bilinear interpolation is used to transfer corrections from the coarse grid to the fine grid, the full-weighting scheme is employed to project residual from the fine grid to the coarse grid, the Conjugate Gradient (CG) method is chosen as a smoother to eliminate the high frequency error, and the number of pre-smoothing and post-smoothing steps are set to be \(v_{1}=v_{2}=2\). \(\epsilon_{L}=10^{-10}\) is taken as the stopping tolerance on the finest grid.

In all numerical experiments, we use the notations u, \(\bar{u}_{j} ^{*}\) and \(u_{j}^{*}\) to denote the exact solution, numerical solution and extrapolation solution on the grid \(\Omega_{j}\), respectively. For convenience of comparison, we choose the \(L^{\infty }\)-norm and the \(L^{2}\)-norm to measure the error between \(u_{j}^{*}\) (or \(\bar{u}_{j}^{*}\)) and u, which are defined as

$$\begin{aligned}& \bigl\Vert u-u_{j}^{*} \bigr\Vert _{\infty }= \Vert e_{j} \Vert _{\infty }= \mathop{\max } _{(x, y) \in \Omega_{j}} \bigl\vert e_{j}(x,y) \bigr\vert , \\& \bigl\Vert u-u_{j}^{*} \bigr\Vert _{2} = \Vert e_{j} \Vert _{2} = h_{j} \sqrt{\sum _{(x, y) \in \Omega_{j} } { \bigl\vert e_{j}(x, y) \bigr\vert ^{2} } }. \end{aligned}$$

We also apply the definition

$$ \textrm{Order} = \frac{{\log (\Vert e_{j-1} \Vert /\Vert e_{j} \Vert )}}{{\log (h_{j-1} /h_{j})}},\quad j=2,\cdots ,L, $$

to represent the convergence order of the approximate solution. Here, \(\Vert \cdot \Vert \) is a given norm (such as \(L^{\infty }\), \(L^{2}\)). Besides, we use “CPU” , “WU” and “Tflops” to record the algorithm’s computational time in seconds, work units [8] and number of flops measured in \(TeraFlops\), respectively. “Iter” denotes the number of multigrid cycles required.

Example 5.1

([41, 42])

Consider the following differential equation:

$$ - u_{xx}(x,y)-u_{yy}(x,y)+ \frac{1}{\varepsilon (1+y)} u_{y}(x,y)=f(x,y), $$
(11)

with suitable Dirichlet boundary condition and right-hand side term \(f(x,y)\), such that the exact solution is

$$ u(x,y) = \exp (y-x)+2^{-1/\varepsilon }(1+y)^{1+1/\varepsilon }. $$
(12)

Here, \(\varepsilon =0.01\).

Example 5.2

([40])

Consider the convection–diffusion equation:

$$ - u_{xx}(x,y)-u_{yy}(x,y)+x(x-1) (1-2y) u_{x}(x,y)+ y(y-1) (1-2x) u _{y}(x,y)=f(x,y), $$
(13)

with the analytic solution

$$ u(x,y) = \exp \bigl(-2000 (x-0.5)^{2}-y^{2} \bigr). $$
(14)

The numerical results for Example 5.1 and 5.2 obtained by MG and EXFMG methods with five embedded grids are listed in Tables 1 and 2. When fixing \(32 \times 32\) as the coarsest grid \(\Omega _{1}\), Tables 38 list the numerical results of EXFMG method with the stopping criteria

$$ \epsilon_{j}=10^{j-L-10}, \quad j=2,3,\ldots ,L, $$
(15)

on each grid \(\Omega_{j}\), \(j=2,3,\ldots ,L\). We also present the numerical errors and computational costs (time and WU) in Figs. 2, 3, 4 and 5, respectively. Now we discuss those results in the following paragraphs.

Figure 2
figure 2

Comparison of the \(L^{\infty }\)-norm error \(\Vert u-u_{L}^{*} \Vert _{{\infty }}\) with different mesh size \(h_{L}\) (\(L=6\))

Figure 3
figure 3

Comparison of the \(L^{2}\)-norm error \(\Vert u-u_{L}^{*} \Vert _{{2}}\) with different mesh size \(h_{L}\) (\(L=6\))

Figure 4
figure 4

Comparison of the computational time with different mesh size \(h_{L}\) (\(L=6\))

Figure 5
figure 5

Comparison of the WU of MG and EXFMG methods with \(L=6\)

Table 1 Errors and costs of algorithms with \(L=5\) for different discretization system arising from Example 5.1
Table 2 Errors and costs of algorithms with \(L=5\) for different discretization system arising from Example 5.2
Table 3 Comparison of the \(L^{\infty }\) errors and convergence order on different grid level of MG and EXFMG methods for Example 5.1

For the accuracy, we find that the numerical solutions from the EXFMG method are much more accurate than those from the MG method (see Tables 1 and 2, Figs. 2 and 3). This means that, to achieve the same accuracy, fewer grid points are needed for the EXFMG method than for the MG method. For instance, the numerical solution by the EXFMG method on the \(256\times 256\) grid is comparable to the numerical solution obtained by the MG method on the \(512\times 512\) grid in Tables 1 and 2.

From Tables 3, 4, 5 and 6, we can see that the numerical solution \(\bar{u}^{*}_{j}\) of the EXFMG method as well as MG method, converges with fourth-order in both \(L^{\infty }\)-norm and \(L^{2}\)-norm while the extrapolated solution \(u^{*}_{j}\) achieves sixth-order accuracy on most levels of grids and starts to lose convergent order on fine grids since the requirement to achieve sixth-order accuracy on fine grids is much higher.

Table 4 Comparison of the \(L^{\infty }\) errors and convergence order on different grid level of MG and EXFMG methods for Example 5.2
Table 5 Comparison of the \(L^{2}\) errors and convergence order on different grid level of MG and EXFMG methods for Example 5.1
Table 6 Comparison of the \(L^{2}\) errors and convergence order on different grid level of MG and EXFMG methods for Example 5.2

Tables 7 and 8 list computational costs on each level of grids for the EXFMG method and MG methods, we find that WU as well as the total work cost of EXFMG method depends greatly on the number of multigrid iterations on the finest grid \(\Omega_{L}\). From Tables 1 and 2, we noticed that the EXFMG method takes fewer iterations on the finest grid, which is more efficient than the MG method. Therefore, the total computational cost (WU, Tflop and CPU time) of EXFMG method are much lower than that of the MG method, which is particularly true when mesh size is less or equal to \(\frac{1}{512}\) (see Tables 1, 2 , 7, 8 and Figs. 4, 5 for details).

Table 7 Comparison of the iteration number and computational cost (WU) on different grid level of MG and EXFMG methods for Example 5.1
Table 8 Comparison of the iteration number and computational cost (WU) on different grid level of MG and EXFMG methods for Example 5.2

From the above discussion, we can see that the EXFMG method not only achieves high-order accuracy but also keeps a low computational cost. Hence, it is a cost-effective numerical solver.

6 Conclusion

We present an EXFMG method combined with a fourth-order compact difference scheme, a bi-quartic Lagrange interpolation and a simple extrapolation technique, to solve the 2D convection–diffusion equation. Numerical experiments were conducted for two test problems to demonstrate that the proposed EXFMG method improves the solution accuracy and keeps less computational costs, compared to the classical MG method.

We need point out that the fourth-order compact difference method, which is employed to discretize the differential equation, can be replaced by other numerical methods, such as the FE method and the finite volume method. Furthermore, we also plan to extend this study and apply EXFMG algorithm with sixth-order combined compact difference scheme [4345] to solve unsteady three-dimensional convection–diffusion equations.

References

  1. Richardson, L.F.: The approximate solution of physical problems involving differential equations using finite differences, with an application to the stress in a masonry dam. Philos. Trans. R. Soc. Lond. Ser. A 210, 307–357 (1910)

    Article  Google Scholar 

  2. Richardson, L.F.: The deferred approach to the limit. I: the single lattice. Philos. Trans. R. Soc. Lond. Ser. A 226, 299–349 (1927)

    Article  MATH  Google Scholar 

  3. Marchuk, G.I., Shaidurov, V.V.: Difference Methods and Their Extrapolations. Springer, New York (1983)

    Book  MATH  Google Scholar 

  4. Blum, H., Lin, Q., Rannacher, R.: Asymptotic error expansion and Richardson extrapolation for linear finite elements. Numer. Math. 49(1), 11–37 (1986)

    Article  MathSciNet  MATH  Google Scholar 

  5. Chen, C.M., Lin, Q.: Extrapolation of finite element approximation in a rectangular domain. J. Comput. Math. 7(3), 227–233 (1989)

    MathSciNet  MATH  Google Scholar 

  6. Fairweather, G., Lin, Q., Lin, Y.P., et al.: Asymptotic expansions and Richardson extrapolation of approximate solutions for second order elliptic problems on rectangular domains by mixed finite element methods. SIAM J. Numer. Anal. 44(3), 1122–1149 (2006)

    Article  MathSciNet  MATH  Google Scholar 

  7. Lin, Q., Lu, T., Shen, S.M.: Maximum norm estimate, extrapolation and optimal point of stresses for finite element methods on strogle regular triangulation. J. Comput. Math. 1(4), 376–383 (1983)

    MATH  Google Scholar 

  8. Trottenberg, U., Oosterlee, C.W., Schller, A.: Multigrid. Academic Press, London (2001)

    Google Scholar 

  9. Hackbusch, W.: Multi-Grid Methods and Applications. Springer, Berlin (1985)

    Book  MATH  Google Scholar 

  10. Othman, M., Abdullah, A.R.: An efficient multigrid Poisson solver. Int. J. Comput. Math. 71(4), 541–553 (1999)

    Article  MathSciNet  MATH  Google Scholar 

  11. Ge, Y.B.: Multigrid method and fourth-order compact difference discretization scheme with unequal meshsizes for 3D poissson equation. J. Comput. Phys. 229(18), 6381–6391 (2010)

    Article  MathSciNet  MATH  Google Scholar 

  12. Gupta, M.M., Kouatchou, J., Zhang, J.: Comparison of second and fourth order discretization for multigrid Poisson solver. J. Comput. Phys. 132, 663–674 (1997)

    MathSciNet  Google Scholar 

  13. Shi, Z.C., Xu, X.J., Huang, Y.Q.: Economical cascadic multigrid methods (ECMG). Sci. China Ser. A, Math. 50, 1765–1780 (2007)

    Article  MathSciNet  MATH  Google Scholar 

  14. Li, C.L.: A new parallel cascadic multigrid method. Appl. Math. Comput. 219, 10150–10157 (2013)

    MathSciNet  MATH  Google Scholar 

  15. Elman, H.C., Ernst, O.G., O’leary, D.P.: A multigrid method enhanced by Krylov subspace iteration for discrete Helmholtz equations. SIAM J. Sci. Comput. 23(4), 1291–1315 (2001)

    Article  MathSciNet  MATH  Google Scholar 

  16. Erlangga, Y.A., Oosterlee, C.W., Vuik, C.: A novel multigrid based precondtioner for heterogeneous Helmholtz problems. SIAM J. Sci. Comput. 27(4), 1471–1492 (2006)

    Article  MathSciNet  MATH  Google Scholar 

  17. Stolk, C.C., Ahmed, M., Bhowmik, S.K.: A multigrid method for the Helmholtz equation with optimized coarse grid corrections. SIAM J. Sci. Comput. 36(6), A2819–A2841 (2013)

    Article  MathSciNet  MATH  Google Scholar 

  18. Ge, Y.B.: Multigrid method based on the transformation-free HOC scheme on nonuniform grids for 2D convection diffusion problems. J. Comput. Phys. 230(10), 4051–4070 (2011)

    Article  MathSciNet  MATH  Google Scholar 

  19. Gupta, M.M., Zhang, J.: High accuracy multigrid solution of the 3D convection-diffusion euqaiton. Appl. Math. Comput. 113(2), 249–274 (2000)

    MathSciNet  MATH  Google Scholar 

  20. Bhowmik, S.K., Stolk, C.C.: Preconditioners based on windowed Fourier frames applied to elliptic partial differential equations. J. Pseudo-Differ. Oper. Appl. 2(3), 317–342 (2011)

    Article  MathSciNet  MATH  Google Scholar 

  21. Brandt, A.: Multi-level adaptive solutions to boundary-value problems. Math. Comput. 31(138), 333–390 (1977)

    Article  MathSciNet  MATH  Google Scholar 

  22. Mandel, J., Parter, S.V.: On the multigrid F-cycle. Appl. Math. Comput. 37(1), 19–36 (1990)

    MathSciNet  MATH  Google Scholar 

  23. Thekale, A., Gradl, T., et al.: Optimizing the number of multigrid cycle in the full multigrid algorithm. Numer. Linear Algebra Appl. 17(2–3), 199–210 (2010)

    MathSciNet  MATH  Google Scholar 

  24. Chen, C.M., Hu, H.L., et al.: Analysis of extrapolation cascadic multigrid method (EXCMG). Sci. China Ser. A 51, 1349–1360 (2008)

    Article  MathSciNet  MATH  Google Scholar 

  25. Chen, C.M., Shi, Z.C., Hu, H.L.: On extrapolation cascadic multigrid method. J. Comput. Math. 29(6), 684–697 (2011)

    Article  MathSciNet  MATH  Google Scholar 

  26. Chen, C.M., Hu, H.L.: Extrapolation cascadic multigrid method on piecewise uniform grid. Sci. China Math. 56(12), 2711–2722 (2013)

    Article  MathSciNet  MATH  Google Scholar 

  27. Hu, H.L., Chen, C.M., Pan, K.J.: Asymptotic expansions of finite element solutions to Robin problems in \(H^{3}\) and their application in extrapolation cascadic multigrid method. Sci. China Math. 57, 687–698 (2014)

    Article  MathSciNet  MATH  Google Scholar 

  28. Pan, K.J., He, D.D., Chen, C.M.: An extrapolation cascadic multigrid method for elliptic problems on reentrant domains. Adv. Appl. Math. Mech. 9(6), 1347–1363 (2017)

    Article  MathSciNet  Google Scholar 

  29. Hu, H.L., Chen, C.M., Pan, K.J.: Time-extrapolation algorithm (TEA) for linear parabolic problems. J. Comput. Math. 32, 183–194 (2014)

    Article  MathSciNet  MATH  Google Scholar 

  30. Pan, K.J., Tang, J.T., et al.: Extrapolation cascadic multigrid method for 2.5D direct current resistivity modeling. Chin. J. Geophys. 55, 2769–2778 (2012) (in Chinese)

    Google Scholar 

  31. Pan, K.J., Tang, J.T.: 2.5-D and 3-D DC resistivity modelling using an extrapolation cascadic multigrid method. Geophys. J. Int. 197(3), 1459–1470 (2014)

    Article  Google Scholar 

  32. Pan, K.J., He, D.D., et al.: A new extrapolation cascadic multigrid method for three dimensional elliptic boundary value problems. J. Comput. Phys. 344, 499–515 (2017)

    Article  MathSciNet  MATH  Google Scholar 

  33. Pan, K.J., He, D.D., Hu, H.L.: An extrapolation cascadic multigrid method combined with a fourth-order compact scheme for 3D Poisson equation. J. Sci. Comput. 70, 1180–1203 (2017)

    Article  MathSciNet  MATH  Google Scholar 

  34. Li, M., Li, C.L., et al.: Cascadic multigrid methods combined with sixth order compact scheme for Poisson equation. Numer. Algorithms 71(4), 715–727 (2016)

    Article  MathSciNet  MATH  Google Scholar 

  35. Li, M., Li, C.L.: New cascadic multigrid methods for two-dimensional Poisson problem based on the fourth-order compact difference scheme. Math. Methods Appl. Sci. 41(3), 920–928 (2018)

    Article  MathSciNet  MATH  Google Scholar 

  36. Hu, H.L., Ren, Z.Y., et al.: On the convergence of an extrapolation cascadic multigrid method for elliptic problems. Comput. Math. Appl. 74, 759–771 (2017)

    Article  MathSciNet  MATH  Google Scholar 

  37. Sun, H., Zhang, J.: A high order finite difference discretization strategy based on extrapolation for convection-diffusion equations. Numer. Methods Partial Differ. Equ. 20(1), 18–32 (2004)

    Article  MathSciNet  MATH  Google Scholar 

  38. Dai, R.X., Zhang, J., Wang, Y.: Higher order ADI method with completed Richardson extrapolation for solving unsteady convection-diffusion equations. Comput. Math. Appl. 71, 431–442 (2016)

    Article  MathSciNet  Google Scholar 

  39. Wang, Y., Zhang, J.: Sixth order compact scheme combined with multigrid method and extrapolation technique for 2D Poisson equation. J. Comput. Phys. 228, 137–146 (2009)

    Article  MathSciNet  MATH  Google Scholar 

  40. Zhang, J., Sun, H.W., Zhao, J.J.: High order compact scheme with multigrid local mesh refinement procedure for convection diffusion problems. Comput. Methods Appl. Mech. Eng. 191, 4661–4674 (2002)

    Article  MathSciNet  MATH  Google Scholar 

  41. Ge, Y.B., Cao, F.J.: Multigrid method based on the transformation-free HOC scheme on nonuniform grids for 2D convection diffusion problems. J. Comput. Phys. 230, 4051–4070 (2011)

    Article  MathSciNet  MATH  Google Scholar 

  42. Tian, Z.F., Dai, S.Q.: High-order compact exponential finite difference methods for convection-diffusion type problems. J. Comput. Phys. 220, 952–974 (2007)

    Article  MathSciNet  MATH  Google Scholar 

  43. He, D.D., Pan, K.J.: An unconditionally stable linearized CCD-ADI method for generalized nonlinear Schrödinger equations with variable coefficients in two and three dimensions. Comput. Math. Appl. 73, 2360–2374 (2017)

    Article  MathSciNet  MATH  Google Scholar 

  44. Lee, S.T., Liu, J., Sun, H.W.: Combined compact difference scheme for linear second-order partial differential equations with mixed derivative. J. Comput. Appl. Math. 264, 23–37 (2014)

    Article  MathSciNet  MATH  Google Scholar 

  45. Wang, Q.H., Pan, K.J., Hu, H.L.: Unique solvability of the CCD scheme for convection–diffusion equations with variable convection coefficients. Adv. Differ. Equ. 2018, 163 (2018)

    Article  MathSciNet  Google Scholar 

Download references

Acknowledgements

The research was supported by the National Natural Science Foundation of China (Nos. 41474103, 11661027, 11601012), the National Key Research and Development Program of China (Nos. 2017YFB0701700, 2017YFB0305601), the Excellent Youth Foundation of Hunan Province of China (No. 2018JJ1042), the Natural Science Foundation of Yunnan Province of China (No. 2017FH001-012), the Innovation-Driven Project of Central South University (No. 2018CX042) and the Reserve Talents Foundation of Honghe University (No. 2015HB0304). We are grateful to the two anonymous reviewers for their helpful comments.

Author information

Authors and Affiliations

Authors

Contributions

The authors declare that the work was realized in collaboration with the same responsibility. All authors read and approved the final manuscript.

Corresponding author

Correspondence to Kejia Pan.

Ethics declarations

Competing interests

The authors declare that they have no competing interests.

Additional information

Publisher’s Note

Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Rights and permissions

Open Access This article is distributed under the terms of the Creative Commons Attribution 4.0 International License (http://creativecommons.org/licenses/by/4.0/), which permits unrestricted use, distribution, and reproduction in any medium, provided you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons license, and indicate if changes were made.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Li, M., Zheng, Z. & Pan, K. An extrapolation full multigrid algorithm combined with fourth-order compact scheme for convection–diffusion equations. Adv Differ Equ 2018, 178 (2018). https://doi.org/10.1186/s13662-018-1631-x

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s13662-018-1631-x

MSC

Keywords