Next Article in Journal
Evaluation of Fast Sample Entropy Algorithms on FPGAs: From Performance to Energy Efficiency
Previous Article in Journal
WikiArtVectors: Style and Color Representations of Artworks for Cultural Analysis via Information Theoretic Measures
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

A Unified Lattice Boltzmann Model for Fourth Order Partial Differential Equations with Variable Coefficients

School of Mathematics and Information Science, North Minzu University, Yinchuan 750021, China
*
Author to whom correspondence should be addressed.
These authors contributed equally to this work.
Entropy 2022, 24(9), 1176; https://doi.org/10.3390/e24091176
Submission received: 20 July 2022 / Revised: 15 August 2022 / Accepted: 22 August 2022 / Published: 23 August 2022
(This article belongs to the Section Complexity)

Abstract

:
In this work, a unified lattice Boltzmann model is proposed for the fourth order partial differential equation with time-dependent variable coefficients, which has the form u t + α ( t ) ( p 1 ( u ) ) x + β ( t ) ( p 2 ( u ) ) x x + γ ( t ) ( p 3 ( u ) ) x x x + η ( t ) ( p 4 ( u ) ) x x x x = 0 . A compensation function is added to the evolution equation to recover the macroscopic equation. Applying Chapman-Enskog expansion and the Taylor expansion method, we recover the macroscopic equation correctly. Through analyzing the error, our model reaches second-order accuracy in time. A series of constant-coefficient and variable-coefficient partial differential equations are successfully simulated, which tests the effectiveness and stability of the present model.

1. Introduction

The analytical solution, also known as the exact solution, can accurately solve the partial differential equations( PDEs) [1,2,3,4], but it is quite difficult for us to obtain analytical solutions. The analytical solution may even be limited to some special types of PDEs. In such a context, it is very necessary and significant to study the numerical solution of PDEs. Compared with traditional numerical methods such as the finite difference method, finite volume method, finite element method, spectral method and so on, lattice Boltzmann method (LBM) is a novel numerical method with unique advantages, such as simple programming, easy treatment of boundary conditions and fit for parallel computing.
As a mesoscopic numerical simulation method, LBM has made some progress in the past 30 years [5,6]. With time and space made discrete, LBM is macroscopically discrete. However, LBM is microscopically continuous, which satisfies the conservation of mass, momentum conservation and energy conservation. The macroscopic equation can be correctly recovered by LBM. LBM attracts more and more experts and scholars’ attention internationally. Researchers mainly use LBM to simulate fluid flow [7,8] and solve PDEs [9,10,11,12,13,14].
Lai and Ma [9] presented a lattice Boltzmann (LB) model for fourth order generalized Kuramoto-Sivashinsky (GKS) equation, in which an amending function assumed to be second order of time step is applied to recover the GKS equation correctly. Hu and their collaborators [10] developed a LB model to solve a generalized Gardner equation with time-dependent variable coefficients (TDVCs) by means of adding a compensation function to the evolution equation. In order to solve a class of PDEs with the order up to six, Chai  et al. [11] introduced some suitable auxiliary moments to study a general LB model. Lan et al. [12] investigated a general propagation LB model and successfully simulated KdV-Burgers equation with TDVCs through adjusting the propagation step. Following the idea in the work of Chai and his collaborators, Qiao et al. [13] recently proposed a novel LB model with an auxiliary source distribution function to solve the general fourth order PDEs. In our previous work [14], a general propagation lattice Boltzmann model was developed to solve Boussinesq equations by selecting the appropriate parameters that affect the propagation process. In this work, we develop a unified lattice Boltzmann model for fourth order PDEs with TDVCs, so as to avoid the need to construct different models for different PDEs, including constant-coefficient PDEs and variable-coefficient PDEs. Furthermore, the equilibrium distribution functions and the compensation functions have a unified form for different PDEs according to our unified model. Based on our model and algorithm, the constant-coefficient KS equation, constant-coefficient GKS equation and variable-coefficient KdV equation, are successfully solved numerically.
We organize the paper as follows: a unified lattice Boltzmann model for fourth order partial differential equations with variable coefficients is proposed in Section 2, where we give a detailed derivation and analysis process of important equations, such as the Chapman-Enskog analysis, the equilibrium distribution functions, the compensation functions and so on. In Section 3, the algorithm for the present model and numerical results are shown. In the end, Section 4 is a summary of this work.

2. A Unified Lattice Boltzmann Model for Fourth Order Partial Differential Equations with Variable Coefficients

A unified LB model for fourth order PDEs with TDVCs, i.e., Equation (1) is investigated,
u t + α ( t ) x p 1 ( u ) + β ( t ) 2 x 2 p 2 ( u ) + γ ( t ) 3 x 3 p 3 ( u ) + η ( t ) 4 x 4 p 4 ( u ) = 0 .
In Equation (1), x , t represent spatial position and time, respectively, u = u ( x , t ) is an unknown scalar function. It should be noticed that unlike previous work, the coefficients α ( t ) , β ( t ) , γ ( t ) , η ( t ) in front of the partial derivative of space are functions of time, i.e., time-dependent variable coefficients, and  P i ( u ) ( i = 1 , 2 , , 4 ) is a polynomial function of u, such as p 1 ( u ) = u 2 and so on.

2.1. A Unified Lattice Boltzmann Model for Fourth Order Partial Differential Equations with Variable Coefficients

As for Equation (1), we introduce the discrete velocity lattice Boltzmann equation with Bhatnagar-Gross-Krook (BGK) collision operator, which satisfies this form:
f k x + α k Δ t , t + Δ t f k ( x , t ) = Δ t [ f k e q ( x , t ) f k ( x , t ) ] τ 0 + Δ t g k ( x , t ) ,
where f k ( x , t ) and f k e q ( x , t ) ( k = 0 , 1 , , n 1 ) are the local particle distribution function and the local equilibrium distribution function, respectively, and  τ 0 is the single relaxation time. It should be noted that we append a compensation function g k ( x , t ) to recover Equation (1) exactly. There are some other important parameters in Equation (2), such as Δ t representing the time step, Δ x representing the lattice space step, α k representing the discrete velocity. In this paper, we apply the simple and efficient D1Q5 velocity model. It means that the n = 5 and α k = c e k = c 0 , 1 , 1 , 2 , 2 = 0 , c , c , 2 c , 2 c , where c is a scale factor constant satisfying c Δ t = Δ x .
We let
τ 0 Δ t = τ , i . e . , Δ t τ 0 = 1 τ .
Applying Taylor expansion to Equation (2) to O ( Δ t 5 ) , and using Equations (2) and (3), we obtain
Δ t t + α k x f k + Δ t 2 2 t + α k x 2 f k + Δ t 3 6 t + α k x 3 f k + Δ t 4 24 t + α k x 4 f k + O Δ t 5 = f k e q f k τ + Δ t g k .
We apply Chapman-Enskog(C-E) expansion to Equation (4) in space and time [15]:
x 1 = 1 ε x ,
t = i = 1 4 ε i t i + O ( ε 5 ) ,
f k = i = 0 4 ε i f k i + O ( ε 5 ) ,
g k 1 = 1 ε g k .
Substituting Equations (5)–(8) into Equation (4), we derive the equations from ε 0 to ε 4 :
O ( ε 0 ) : 1 τ ( f k 0 f k e q ) = 0 , i . e . , f k 0 = f k e q ,
O ( ε 1 ) : Δ t t 1 f k 0 + Δ t α k x 1 f k 0 = 1 τ f k 1 + Δ t g k 1 ,
O ( ε 2 ) : Δ t ( t 1 f k 1 + t 2 f k 0 + α k x 1 f k 1 ) + Δ t 2 2 ( t 1 2 + 2 α k x 1 t 1 + α k 2 x 1 2 ) f k 0 = 1 τ f k 2 ,
O ( ε 3 ) : Δ t ( t 1 f k 2 + t 2 f k 1 + t 3 f k 0 + α k x 1 f k 2 ) + Δ t 2 ( t 1 , t 2 2 + α k x 1 t 2 ) f k 0 + Δ t 2 2 t 1 2 + 2 α k x 1 t 1 + α k 2 x 1 2 f k 1 + Δ t 3 6 ( t 1 3 + 3 α k x 1 t 1 2 + 3 α k 2 x 1 2 t 1 + α k 3 x 1 3 ) f k 0 = 1 τ f k 3 ,
O ( ε 4 ) : Δ t ( t 1 f k 3 + t 2 f k 2 + t 3 f k 1 + t 4 f k 0 + α k x 1 f k 3 ) + Δ t 2 2 ( 2 t 1 , t 3 2 + t 2 2 + 2 α k x 1 t 3 ) f k 0 + Δ t 2 ( t 1 , t 2 2 + α k x 1 t 2 ) f k 1 + Δ t 2 2 ( t 1 2 + 2 α k x 1 t 1 + α k 2 x 1 2 ) f k 2 + Δ t 3 6 3 t 1 2 t 2 + 6 α k x 1 t 1 , t 2 2 + 3 α k 2 x 1 2 t 2 f k 0 + Δ t 3 6 ( t 1 3 + 3 α k x 1 t 1 2 + 3 α k 2 x 1 2 t 1 + α k 3 x 1 3 ) f k 1 + Δ t 4 24 t 1 4 + 4 α k x 1 t 1 3 + 6 α k 2 x 1 2 t 1 2 + 4 α k 3 x 1 3 t 1 + α k 4 x 1 4 f k 0 = 1 τ f k 4 .
Using Equations (9)–(13), we obtain:
f k 1 τ Δ t = t 1 + α k x 1 f k 0 g k 1 ,
f k 2 τ Δ t = Δ t 2 t 1 2 + Δ t α k x 1 t 1 + Δ t 2 α k 2 x 1 2 + t 2 f k 0 + t 1 + α k x 1 f k 1 ,
f k 3 τ Δ t = t 3 + Δ t t 1 , t 2 2 + Δ t α k x 1 t 2 + Δ t 2 6 t 1 3 + Δ t 2 2 α k x 1 t 1 2 + Δ t 2 2 α k 2 x 1 2 t 1 + Δ t 2 6 α k 3 x 1 3 f k 0 + t 2 + Δ t 2 t 1 2 + Δ t α k x 1 t 1 + Δ t 2 α k 2 x 1 2 f k 1 + ( t 1 + α k x 1 ) f k 2 ,
f k 4 τ Δ t = t 4 + Δ t t 1 , t 3 2 + Δ t 2 t 2 2 + Δ t α k x 1 t 3 + Δ t 2 2 t 1 2 t 2 + Δ t 2 α k x 1 t 1 , t 2 2 + Δ t 2 2 α k 2 x 1 2 t 2 + Δ t 3 24 t 1 4 + Δ t 3 6 α k x 1 t 1 3 + Δ t 3 4 α k 2 x 1 2 t 1 2 + Δ t 3 6 α k 3 x 1 3 t 1 + Δ t 3 24 α k 4 x 1 4 f k 0 + t 3 + Δ t t 1 , t 2 2 + Δ t α k x 1 t 2 + Δ t 2 6 t 1 3 + Δ t 2 2 α k x 1 t 1 2 + Δ t 2 2 α k 2 x 1 2 t 1 + Δ t 2 6 α k 3 x 1 3 f k 1 + t 2 + Δ t 2 t 1 2 + Δ t α k x 1 t 1 + Δ t 2 α k 2 x 1 2 f k 2 + t 1 + α k x 1 f k 3 .
Simplifying Equation (14), we have:
f k 1 = τ Δ t t 1 + α k x 1 f k 0 g k 1 .
Coupling Equations (15) and (18), one can obtain:
f k 2 = τ Δ t 2 ( 1 2 τ ) t 1 2 + ( 1 2 τ ) α k 2 x 1 2 + ( 1 2 τ ) α k x 1 t 1 + 1 Δ t t 2 f k 0 + τ t 1 + τ α k x 1 g k 1 .
Substituting Equations (18) and (19) into Equation (16), we have:
f k 3 = τ Δ t 3 1 Δ t 2 t 3 + 1 Δ t ( 1 2 τ ) t 1 , t 2 2 + 1 Δ t ( 1 2 τ ) α k x 1 t 2 + τ 1 t 1 3 + τ 2 α k x 1 t 1 2 + τ 2 α k 2 x 1 2 t 1 + τ 1 α k 3 x 1 3 f k 0 + τ Δ t t 2 + ( τ 2 τ 2 ) t 1 2 + ( τ 2 τ 2 ) α k x 1 t 1 + ( τ 2 τ 2 ) α k 2 x 1 2 g k 1 .
Finally, with the help of Equations (18)–(20), we rewrite Equation (17):
f k 4 = τ Δ t 4 1 Δ t 3 t 4 + 1 2 Δ t 2 ( 1 2 τ ) t 2 2 + 1 Δ t 2 ( 1 2 τ ) t 1 , t 3 2 + 1 Δ t 2 ( 1 2 τ ) α k x 1 t 3 + τ 2 Δ t t 2 t 1 2 + 6 τ 1 Δ t α k x 1 t 1 , t 2 2 + τ 2 Δ t α k 2 x 1 2 t 2 + τ 3 t 1 4 + 4 τ 3 α k x 1 t 1 3 + 6 τ 3 α k 2 x 1 2 t 1 2 + τ 3 α k 4 x 1 4 + 4 τ 3 α k 3 x 1 3 t 1 f k 0 + τ Δ t 2 t 3 + 1 Δ t ( τ 2 τ 2 ) t 1 , t 2 2 + 1 Δ t ( τ 2 τ 2 ) α k x 1 t 2 + τ 4 t 1 3 + 3 τ 4 α k x 1 t 1 2 + 3 τ 4 α k 2 x 1 2 t 1 + τ 4 α k 3 x 1 3 g k 1 .
where:
τ 1 = τ 2 τ + 1 6 , τ 2 = 3 τ 2 3 τ + 1 2 , τ 3 = τ 3 + 3 2 τ 2 7 12 τ + 1 24 , τ 4 = τ 3 τ 2 + τ 6 .
f k and f k e q should satisfy the constraint:
k f k = k f k e q = u .
Using Equation (9), we obtain:
k f k 0 = u , k f k m = 0 , m > 0 .
We can recover the equation exactly with minimal truncation error if both f k 0 and g k satisfy the following conditions:    
k α k f k 0 = 0 ,
k α k 2 f k 0 = 0 ,
k α k 3 f k 0 = γ ( t ) P 3 ( u ) Δ t 2 τ 1 ,
k α k 4 f k 0 = η ( t ) P 4 ( u ) Δ t 3 τ 3 .
k g k = 0 ,
k α k g k = α ( t ) p 1 ( u ) Δ t τ ,
k α k 2 g k = β ( t ) p 2 ( u ) Δ t 2 ( τ 2 τ 2 ) ,
k α k 3 g k = 0 .
Summing Equation (18) over k, and using Equations (22) and (23), we have:
t 1 u = 0 .
Summing Equation (19) over k and applying Equations (23)–(29), one can obtain:
t 2 u = 1 ε 2 x α ( t ) p 1 ( u ) .
Summing Equation (20) over k and with the aim of Equations (23)–(30), we obtain:
t 3 u = 1 ε 3 x 3 γ ( t ) P 3 ( u ) 1 ε 3 x 2 β ( t ) p 2 ( u ) Δ t ε 2 ( 1 2 τ ) x p 1 ( u ) t 1 α ( t ) .
Summing Equation (21) over k and coupling with Equations (23)–(31), we have:
t 4 u = τ Δ t Δ t 2 t 2 2 u 1 ε 4 x 4 η ( t ) P 4 ( u ) 4 Δ t τ 3 τ 1 ε 3 x 3 P 3 ( u ) t 1 γ ( t ) + Δ t ε 2 2 τ 1 x p 1 ( u ) t 2 α ( t ) Δ t 2 ε 2 τ 2 x p 1 ( u ) t 1 2 α ( t ) 6 Δ t τ 1 ε 3 1 2 τ x 2 p 2 ( u ) t 1 β ( t ) .
Combining Equations (32)–(35) in order of ε k ( k = 1 , 2 , 3 , 4 ) and assuming ε = Δ t , we are able to recover fourth order PDEs with TDVCs:
u t + α ( t ) x p 1 ( u ) + β ( t ) 2 x 2 p 2 ( u ) + γ ( t ) 3 x 3 p 3 ( u ) + η ( t ) 4 x 4 p 4 ( u ) = ζ ,
where the truncation error ζ of the model is:
ζ = ε 2 1 2 τ x p 1 ( u ) t 1 α ( t ) ε 2 4 τ 3 τ 1 x 3 P 3 ( u ) t 1 γ ( t ) ε 3 1 2 τ x p 1 ( u ) t 2 α ( t ) ε 4 τ 2 x p 1 ( u ) t 1 2 α ( t ) ε 2 6 τ 1 1 2 τ x 2 p 2 ( u ) t 1 β ( t ) ε 5 1 2 τ t 2 2 u = O ( ε 2 ) .

2.2. Selecting Appropriate Equilibrium Distribution Functions and Compensation Functions

By solving Equations (23)–(27), the equilibrium distribution functions f k 0 ( k = 0 , 1 , , 4 ) are expressed by
f 0 0 = u + η ( t ) P 4 ( u ) 4 c 4 Δ t 3 τ 3 ,
f 1 0 = γ ( t ) p 3 ( u ) 6 c 3 Δ t 2 τ 1 η ( t ) p 4 ( u ) 6 c 4 Δ t 3 τ 3 ,
f 2 0 = γ ( t ) p 3 ( u ) 6 c 3 Δ t 2 τ 1 η ( t ) p 4 ( u ) 6 c 4 Δ t 3 τ 3 ,
f 3 0 = γ ( t ) p 3 ( u ) 12 c 3 Δ t 2 τ 1 + η ( t ) p 4 ( u ) 24 c 4 Δ t 3 τ 3 ,
f 4 0 = γ ( t ) p 3 ( u ) 12 c 3 Δ t 2 τ 1 + η ( t ) p 4 ( u ) 24 c 4 Δ t 3 τ 3 .
Then, assuming
g 4 = u 2 ,
and solving Equations (28)–(31), the compensation functions g k ( k = 0 , 1 , , 4 ) can be derived:
g 0 = 6 u 2 β ( t ) p 2 ( u ) c 2 Δ t 2 τ 2 τ 2 α ( t ) p 1 ( u ) 2 c Δ t τ ,
g 1 = 4 u 2 + β ( t ) p 2 ( u ) 2 c 2 Δ t 2 τ 2 τ 2 + α ( t ) p 1 ( u ) c Δ t τ ,
g 2 = 4 u 2 + β ( t ) p 2 ( u ) 2 c 2 Δ t 2 τ 2 τ 2 α ( t ) p 1 ( u ) 3 c Δ t τ ,
g 3 = u 2 α ( t ) p 1 ( u ) 6 c Δ t τ ,
g 4 = u 2 .

3. Numerical Solutions

Our numerical simulation is based on Algorithm 1. Some fourth order PDEs with TDVCs are simulated to verify the effectiveness and stability of the model. For the treatment of boundary conditions, we use the nonequilibrium extrapolation method [16]. In addition, the initial and boundary value are determined by the exact solution. We apply global relative error (i.e., GRE) to measure error between the LBM solutions and the exact solutions.
Algorithm 1: Numerical Simulation
  • Set initial value: u 0 = the exact solution, compute p j ( u ) ( j = 1 , 2 , , 4 ) and f k ( k = 0 , 1 , , 4 )
  • u = u 0
  • for r = 1 to Nt do
  •     for i = 1 to m + 1 do
  •         Compute p j , i ( u ) ( j = 1 , 2 , , 4 )
  •         Compute coefficients
  •         Compute f k , i ( u ) and g k , i ( u ) ( k = 0 , 1 , , 4 )
  •         Collision
  •     end for
  •     Stream
  •     Compute u = f k , i 0 ( u ) ( k = 0 , 1 , , 4 )
  •     Treat boundary condition
  • end for
G R E = n = 1 L ϑ x n , t ϑ x n , t n = 1 L ϑ x n , t ,
where ϑ ( x n , t ) and ϑ ( x n , t ) are the LBM solution and the exact solution, respectively, L represents the number of lattices.
Example 1.
Let α ( t ) = 1 2 ,   p 1 ( u ) = u 2 ,   β ( t ) = 1 ,   p 2 ( u ) = u ,   γ ( t ) = 0 ,   η ( t ) = 1 ,   p 4 ( u ) = u , and Equation (1) is transformed into Kuramoto-Sivashinsky (KS) equation with such a form:
u t + u u x 2 u x 2 + 4 u x 4 = 0 .
We obtain the exact solution u ( x , t ) of Equation (49) by Ref. [1]
u ( x , t ) = b + 15 19 19 3 tanh k x b t x 0 + tanh 3 k x b t x 0 .
In the simulation, we set x [ 50 , 50 ] , τ = 1.28 , Δ x = 0.1 , Δ t = 0.0001 . Some other parameters in Equation (50) are k = 1 2 19 , b = 5 , and x 0 = 25 . The three-dimensional visual comparisons between the LBM solutions and exact solutions with time are shown in Figure 1. We show the space-time evolution graph of the LBM solutions and exact solutions in Figure 2. Besides, we compare the present model with the one in Ref. [9]. We also list the GRE of two models at different times in Table 1. It can find that our model is more accurate and performs better than the one in Ref. [9]. Based on Figure 1 and Figure 2 and Table 1, the LBM solutions and the exact solutions are in good agreement.
Example 2.
When α ( t ) = 1 2 ,   p 1 ( u ) = u 2 ,   β ( t ) = 1 ,   p 2 ( u ) = u ,   γ ( t ) = 4 ,   p 3 ( u ) = u ,   η ( t ) = 1 , p 4 ( u ) = u , and Equation (1) is called the generalized Kuramoto-Sivashinsky (GKS) equation with the following form,
u t + u u x + 2 u x 2 + 4 3 u x 3 + 4 u x 4 = 0 .
We obtain the exact solution u ( x , t ) of Equation (51) by Ref. [2]
u ( x , t ) = b + 9 15 tanh k x b t x 0 + tanh 2 k x b t x 0 tanh 3 k x b t x 0 .
In the simulation, we set x [ 40 , 40 ] , τ = 1.3 , Δ x = 0.1 , and Δ t = 0.0001 . Some other parameters in Equation (52) are b = 0.6 , k = 1 2 , and x 0 = 10 . The three-dimensional visual comparisons between the LBM solutions and exact solutions with time are shown in Figure 3. We show the space-time evolution graph of the LBM solutions and exact solutions in Figure 4. We also list the GRE of the model at different times in Table 2. Based on Figure 3 and Figure 4 and Table 2, the LBM solutions and the exact solutions are in good agreement.
Example 3.
When α ( t ) = 3 4 ,   p 1 ( u ) = u 4 ,   β ( t ) = 1 ,   p 2 ( u ) = u ,   γ ( t ) = 1 ,   p 3 ( u ) = u ,   η ( t ) = 1 ,   p 4 ( u ) = u , and Equation (1) is also a GKS equation with the different from:
u t + 3 u 3 u x + 2 u x 2 3 u x 3 + 4 u x 4 = 0 .
We obtain the exact solution u ( x , t ) of Equation (53) by Ref. [3]
u ( x , t ) = 3 2 2 tanh 3 4 2 x x 0 29 144 t + 1 2 + 1 6 .
In the simulation, we set x [ 30 , 30 ] , τ = 1.8 , Δ x = 0.1 , and Δ t = 0.0001 . One free parameter in Equation (54) is x 0 = 0 . The three-dimensional visual comparisons between the LBM solutions and exact solutions with time are shown in Figure 5. We show the space-time evolution graph of the LBM solutions and exact solutions in Figure 6. We also list the GRE of the model at different times in Table 3. Based on Figure 5 and Figure 6 and Table 3, the LBM solutions and the exact solutions are in good agreement.
Example 4.
Let α ( t ) = 3 cos ( 2 t ) ,   p 1 ( u ) = u 2 ,   β ( t ) = 0 ,   γ ( t ) = cos ( 2 t ) ,   p 3 ( u ) = u ,   η ( t ) = 0 , and Equation (1) becomes a variable coefficient Korteweg-de Vries (KdV) equation with the following form,
u t + 6 cos ( 2 t ) u u x + cos ( 2 t ) 3 u x 3 = 0 .
The exact solution [4] u ( x , t ) of Equation (55) is
u ( x , t ) = r 2 sech 2 r 2 x r 2 sin ( 2 t ) 7 .
In the simulation, we set x [ 0 , 40 ] , τ = 1.5 , Δ x = 0.1 , and Δ t = 0.0001 . One free parameter r is set at 0.5 in Equation (56). The three-dimensional visual comparisons between the LBM solutions and exact solutions with time are shown in Figure 7. We show the space-time evolution graph of the LBM solutions and exact solutions in Figure 8. We also list the GRE of the model at different times in Table 4. Based on Figure 7 and Figure 8 and Table 4, the LBM solutions and the exact solutions are in good agreement.

4. Conclusions

In this paper, we developed a unified lattice Boltzmann model for the fourth order partial differential equation with time-dependent variable coefficients. In practice, as for the one-dimensional problems, we can use a unified lattice Boltzmann model to solve nth ( n 4 ) order PDEs with the specific form like Equations (1). From the C-E analysis, the macroscopic Equation (1) was recovered with second-order accuracy in time. Based on the proposed model and algorithm, some different types of PDEs such as in Equation (1), including the constant-coefficient KS equation, constant-coefficient GKS equation and variable-coefficient KdV equation, were numerically solved by selecting appropriate equilibrium distribution functions f k 0 , compensation functions g k , the time step Δ t , space step Δ x and single relaxation time τ . The performance of the model was tested with a comparison between the numerical solution and the analytical solution. The numerical results show that the model is an effective method that can be used to simulate the equations such as Equatios (1).
Finally, we would like to point out that only one-dimensional problems with time-dependent variable coefficients in the form of Equation (1), were investigated in our model, while space-dependent variable coefficients PDEs and high-dimensional problems were not considered. We will replenish these inadequacies in the further work.

Author Contributions

W.Y. contributed to the conceptualization, the methodology, the investigation and the writing. C.L. helped reviewing and editing the article. All authors have read and agreed to the published version of the manuscript.

Funding

This research was financially supported by the National Natural Science Foundation of China (Grant No. 11761005).

Institutional Review Board Statement

Not applicable.

Informed Consent Statement

Not applicable.

Data Availability Statement

Not applicable.

Conflicts of Interest

The authors declare no conflict of interest.

References

  1. Yan, X.; Shu, C.W. Local discontinuous Galerkin methods for the Kuramoto-Sivashinsky equations and the Ito-type coupled KdV equations. Comput. Methods Appl. Mech. Eng. 2005, 25, 3430–3447. [Google Scholar]
  2. Fan, E.G. Extended tanh–function method and its applications to nonlinear equations. Phys. Lett. A 2000, 4, 212–218. [Google Scholar] [CrossRef]
  3. Zhang, J.W.; Zhang, J.G. Exact Solutions of the Generalized Kuramoto-Sivashinsky type Equations with the dispersive Effects. Math. Pract. Theory 2001, 31, 427–429. [Google Scholar]
  4. Zhang, X.C. Numerical Solutions of a Class of Kdv and mKdV Equation with Variable Coefficients by Lie–Group Method. Ph.D. Thesis, Lanzhou University, Lanzhou, China, 2013. [Google Scholar]
  5. Qian, Y.H.; Succi, S.; Orszag, S.A. Recent advances in lattice Boltzmann computing. Annu. Rev. Comput. Phys. 1995, 3, 195–242. [Google Scholar]
  6. Mohamad, A.A. Lattice Boltzmann Method; Electronic Industry Press: Beijing, China, 2015. [Google Scholar]
  7. Inamuro, T.; Ogata, T.; Tajima, S.; Konishi, N. A lattice Boltzmann method for incompressible two-phase flow with large density differences. J. Comput. Phys. 2004, 198, 628–644. [Google Scholar] [CrossRef]
  8. Krüger, T.; Kusumaatmaja, H.; Kuzmin, A.; Shardt, O.; Silva, G.; Viggen, E.M. The Lattice Boltzmann Method: Principles and Practice; Springer: Cham, Switzerland, 2017. [Google Scholar]
  9. Lai, H.L.; Ma, C.F. Lattice Boltzmann method for the generalized Kuramoto–Sivashinsky equation. Phys. A Stat. Mech. Its Appl. 2009, 388, 1405–1412. [Google Scholar] [CrossRef]
  10. Hu, W.Q.; Gao, Y.T.; Lan, Z.Z.; Su, C.Q.; Feng, Y.J. Lattice Boltzmann model for a generalized Gardner equation with time-dependent variable coefficients. Appl. Math. Model. 2017, 46, 126–140. [Google Scholar] [CrossRef]
  11. Chai, Z.H.; He, N.Z.; Guo, Z.L.; Shi, B.C. Lattice Boltzmann model for high-order nonlinear partial differential equations. Phys. Rev. E 2018, 97, 013304. [Google Scholar] [CrossRef] [PubMed]
  12. Lan, Z.Z.; Hu, W.Q.; Guo, B.L. General propagation lattice Boltzmann model for a variable-coefficient compound KdV-Burgers equation. Appl. Math. Model. 2019, 73, 695–714. [Google Scholar] [CrossRef]
  13. Qiao, Z.H.; Yang, X.G.; Zhang, Y.Z. A Novel Lattice Boltzmann Model for Fourth Order Nonlinear Partial Differential Equations. J. Sci. Comput. 2021, 87, 51. [Google Scholar] [CrossRef]
  14. Yang, W.; Li, C.G. General Propagation Lattice Boltzmann Model for the Boussinesq Equation. Entropy 2022, 24, 486. [Google Scholar] [CrossRef] [PubMed]
  15. Chapman, S.; Cowling, T.G. The Mathematical Theory of Non-Uniform Gases, 3rd ed.; Cambridge University Press: Cambridge, UK, 1970. [Google Scholar]
  16. Guo, Z.L.; Zheng, C.G.; Shi, B.C. Non-equilibrium extrapolation method for velocity and pressure boundary conditions in the lattice Boltzmann method. Chin. Phys. 2002, 11, 366. [Google Scholar]
Figure 1. The 3D visual comparisons of LBM solutions (a) and exact solutions (b) from t = 0 to t = 12 for Example 1.
Figure 1. The 3D visual comparisons of LBM solutions (a) and exact solutions (b) from t = 0 to t = 12 for Example 1.
Entropy 24 01176 g001
Figure 2. LBM solutions versus exact solutions at (a) t = 6 ; (b) t = 8 ; (c) t = 10 ; (d) t = 12 for Example 1.
Figure 2. LBM solutions versus exact solutions at (a) t = 6 ; (b) t = 8 ; (c) t = 10 ; (d) t = 12 for Example 1.
Entropy 24 01176 g002
Figure 3. The 3D visual comparisons of LBM solutions (a) and exact solutions (b) from t = 0 to t = 5 for Example 2.
Figure 3. The 3D visual comparisons of LBM solutions (a) and exact solutions (b) from t = 0 to t = 5 for Example 2.
Entropy 24 01176 g003
Figure 4. LBM solutions versus exact solutions at (a) t = 3 ; (b) t = 4 ; (c) t = 5 ; (d) t = 6 for Example 2.
Figure 4. LBM solutions versus exact solutions at (a) t = 3 ; (b) t = 4 ; (c) t = 5 ; (d) t = 6 for Example 2.
Entropy 24 01176 g004
Figure 5. The 3D visual comparisons of LBM solutions (a) and exact solutions (b) from t = 0 to t = 4 for Example 3.
Figure 5. The 3D visual comparisons of LBM solutions (a) and exact solutions (b) from t = 0 to t = 4 for Example 3.
Entropy 24 01176 g005
Figure 6. LBM solutions versus exact solutions at (a) t = 1 ; (b) t = 2 ; (c) t = 3 ; (d) t = 4 for Example 3.
Figure 6. LBM solutions versus exact solutions at (a) t = 1 ; (b) t = 2 ; (c) t = 3 ; (d) t = 4 for Example 3.
Entropy 24 01176 g006
Figure 7. The 3D visual comparisons of LBM solutions (a) and exact solutions (b) from from t = 0 to t = 5 for Example 4.
Figure 7. The 3D visual comparisons of LBM solutions (a) and exact solutions (b) from from t = 0 to t = 5 for Example 4.
Entropy 24 01176 g007
Figure 8. LBM solutions versus exact solutions at (a) t = 2 ; (b) t = 3 ; (c) t = 4 ; (d) t = 5 for Example 4.
Figure 8. LBM solutions versus exact solutions at (a) t = 2 ; (b) t = 3 ; (c) t = 4 ; (d) t = 5 for Example 4.
Entropy 24 01176 g008
Table 1. Comparison of LBM solutions and exact solutions for Example 1 at different times.
Table 1. Comparison of LBM solutions and exact solutions for Example 1 at different times.
t = 6 t = 8 t = 10 t = 12
GRE in Example 1 4.1706 × 10 6 5.2269 × 10 6 6.1676 × 10 6 7.2045 × 10 6
GRE in Ref. [9] 7.8808 × 10 6 9.5324 × 10 6 1.0891 × 10 5 1.1793 × 10 5
Table 2. Comparison of LBM solutions and exact solutions for Example 2 at different times.
Table 2. Comparison of LBM solutions and exact solutions for Example 2 at different times.
t = 3 t = 4 t = 5 t = 6
GRE 7.012 × 10 3 6.576 × 10 3 1.082 × 10 2 1.753 × 10 2
Table 3. Comparison of LBM solutions and exact solutions for Example 3 at different times.
Table 3. Comparison of LBM solutions and exact solutions for Example 3 at different times.
t = 1 t = 2 t = 3 t = 4
GRE 2.3170 × 10 4 4.7307 × 10 4 7.3427 × 10 4 1.127 × 10 3
Table 4. Comparison of LBM solutions and exact solutions for Example 4 at different times.
Table 4. Comparison of LBM solutions and exact solutions for Example 4 at different times.
t = 2 t = 3 t = 4 t = 5
GRE 6.622 × 10 2 2.628 × 10 2 8.783 × 10 2 4.597 × 10 2
Publisher’s Note: MDPI stays neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Share and Cite

MDPI and ACS Style

Yang, W.; Li, C. A Unified Lattice Boltzmann Model for Fourth Order Partial Differential Equations with Variable Coefficients. Entropy 2022, 24, 1176. https://doi.org/10.3390/e24091176

AMA Style

Yang W, Li C. A Unified Lattice Boltzmann Model for Fourth Order Partial Differential Equations with Variable Coefficients. Entropy. 2022; 24(9):1176. https://doi.org/10.3390/e24091176

Chicago/Turabian Style

Yang, Wei, and Chunguang Li. 2022. "A Unified Lattice Boltzmann Model for Fourth Order Partial Differential Equations with Variable Coefficients" Entropy 24, no. 9: 1176. https://doi.org/10.3390/e24091176

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

Article Metrics

Back to TopTop