Next Article in Journal
Payoffs and Coherence of a Quantum Two-Player Game in a Thermal Environment
Next Article in Special Issue
Entropy-Assisted Computing of Low-Dissipative Systems
Previous Article in Journal
A Novel Method for PD Feature Extraction of Power Cable with Renyi Entropy
Previous Article in Special Issue
A Truncation Scheme for the BBGKY2 Equation
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

From Lattice Boltzmann Method to Lattice Boltzmann Flux Solver

1
Department of Mechanical Engineering, National University of Singapore, 10 Kent Ridge Crescent, Singapore 119260, Singapore
2
Department of Aerodynamics, College of Aerospace Engineering, Nanjing University of Aeronautics and Astronautics, Yudao Street, Nanjing 210016, China
*
Author to whom correspondence should be addressed.
Entropy 2015, 17(11), 7713-7735; https://0-doi-org.brum.beds.ac.uk/10.3390/e17117713
Submission received: 10 September 2015 / Revised: 19 October 2015 / Accepted: 2 November 2015 / Published: 13 November 2015
(This article belongs to the Special Issue Non-Linear Lattice)

Abstract

:
Based on the lattice Boltzmann method (LBM), the lattice Boltzmann flux solver (LBFS), which combines the advantages of conventional Navier–Stokes solvers and lattice Boltzmann solvers, was proposed recently. Specifically, LBFS applies the finite volume method to solve the macroscopic governing equations which provide solutions for macroscopic flow variables at cell centers. In the meantime, numerical fluxes at each cell interface are evaluated by local reconstruction of LBM solution. In other words, in LBFS, LBM is only locally applied at the cell interface for one streaming step. This is quite different from the conventional LBM, which is globally applied in the whole flow domain. This paper shows three different versions of LBFS respectively for isothermal, thermal and compressible flows and their relationships with the standard LBM. In particular, the performance of isothermal LBFS in terms of accuracy, efficiency and stability is investigated by comparing it with the standard LBM. The thermal LBFS is simplified by using the D2Q4 lattice velocity model and its performance is examined by its application to simulate natural convection with high Rayleigh numbers. It is demonstrated that the compressible LBFS can be effectively used to simulate both inviscid and viscous flows by incorporating non-equilibrium effects into the process for inviscid flux reconstruction. Several numerical examples, including lid-driven cavity flow, natural convection in a square cavity at Rayleigh numbers of 107 and 108 and transonic flow around a staggered-biplane configuration, are tested on structured or unstructured grids to examine the performance of three LBFS versions. Good agreements have been achieved with the published data, which validates the capability of LBFS in simulating a variety of flow problems.

1. Introduction

Since its earliest appearance in 1988 [1], the lattice Boltzmann equation (LBE)-based method [2,3,4,5,6,7,8,9,10,11] has been developed into an effective and efficient solver for simulating a variety of complex fluid flow problems, such as isothermal and thermal flows [9,10,12], multi-phase and multi-component flows [8,13,14,15], compressible flows [16,17,18] and micro non-equilibrium flows [19,20,21]. To effectively study these problems, a large number of LBE-based methods have been continuously proposed and refined [9,10,11,12,13,14,15,16,17,18,19,20,21,22,23].
Historically, the LBM was developed from the lattice gas cellular automata (LGCA) method, aiming to remove its statistical noise and limitation to use Boolean numbers. It was later proven that the solid foundation of LBM roots in gas kinetic theory and the Chapman–Enskog expansion analysis, through which both continuous and lattice Boltzmann equation can recover the Navier–Stokes equations. This confers the LBM with an appealing kinetic nature. Besides, LBM has very simple numerical algorithms with algebraic manipulations. In particular, two simple steps of streaming and collision are involved in its solution process. The streaming process is linear, which moves particles with different distribution functions to neighboring points, but effectively considers non-linear physics in fluid dynamics. The collision process takes place locally in either lattice velocity space or macroscopic moment space according to different collision models [2,4,22]. Both single relaxation time (SRT) model (lattice Bhatnagar–Gross–Krook (LBGK) model) [4] and multiple-relaxation-time (MRT) model [22] can be applied. It seems that the MRT model eliminates some defects of the LBGK model and enriches the connotation of LBM, although the computational effort is also increased. With these distinguishing features, the LBM has emerged as an alternative powerful tool in many complex fluid flow problems [13,20,23,24,25]. However, the LBM also suffers from some drawbacks. Due to lattice regularity, the standard LBM usually restricts its applications to uniform grids, which hinders its direct application in certain problems with curved boundaries. In addition, as compared with conventional Navier–Stokes solvers, LBM usually needs more virtual storage to store both the distribution functions and flow variables. Furthermore, the time step in LBM is coupled with mesh spacing, which presents a great challenge for applications on multi-block and adaptive grids. Moreover, LBM is mostly applied to simulate incompressible flows since the equilibrium distribution function is obtained from low Mach number approximation.
To remove the drawbacks of standard LBM, some efforts [5,6,7,21] have been made to directly solve the discrete velocity Boltzmann equation (DVBE) with well-established numerical approaches. This way eliminates the coupling issue between the mesh spacing and time step in standard LBM and can be effectively applied on non-uniform grids. However, it loses the primary advantages of LBM such as simple implementation and algebraic operation. It may also involve a large numerical dissipation and encounter numerical instability [26,27].
Recently, from Chapman–Enskog (C-E) analysis, several versions of lattice Boltzmann flux solver (LBFS) [8,9,10,11] have been developed based on the standard LBM for simulating isothermal, thermal, multiphase and compressible flows. LBFS is a finite volume solver for direct update of the macroscopic flow variables at cell centers. The key idea of the LBFS is to evaluate numerical fluxes at each cell interface by local application of LBM solution for one streaming step. In other words, in LBFS, LBM is applied locally and independently at each interface, and the streaming time step is nothing to do with the real time step. Instead, it is only applied to calculate the relaxation parameter used in the process of solution reconstruction by LBM. For a control cell with four cell interfaces of a two-dimensional case, the local LBM solution at different interface is reconstructed independently and the streaming time step could be different. This gives us a great flexibility for application of the solver to non-uniform meshes and complex geometry. This feature effectively removes the drawback of coupling issue between the mesh spacing and time step in the conventional LBM. In addition, the LBFS does not track the evolution of distribution function and the dependent variables are the macroscopic flow variable. As a consequence, the required virtual memory is reduced substantially, and the physical boundary conditions can be implemented directly without converting to those for distribution functions. Moreover, as compared with conventional incompressible Navier–Stokes solvers, such as the well-known semi-implicit method for pressure linked equations (SIMPLE) method and its variants [28], the LBFS overcomes their drawbacks of tedious discretization of the second order derivatives, the requirement of staggered grids for preventing pressure oscillations and slow convergence on fine grids [29]. Indeed, the LBFS combines the advantages of lattice Boltzmann solver (simplicity and kinetic nature) with those of Navier–Stokes solver by the finite volume method (FVM) (geometric flexibility and easy implementation of boundary conditions). It shows the progressive development from LBM to LBFS.
Since LBFS is a new solver, its performance has not been fully investigated and further improvements and simplifications for different flow problems may be required. Particularly, there is a lack of a systematic investigation on its accuracy, efficiency, stability and capability in simulating isothermal flows, thermal flows at high Reynolds/Rayleigh numbers, and compressible flows. Motived by this, the LBFS will be refined and examined comprehensively in this paper. Firstly, numerical simulations of two-dimensional lid-driven cavity flows [30,31,32,33,34] are considered. A detailed comparison of its performances with the standard LBM will be carried out. Secondly, the thermal LBFS will be simplified in this work by using the D2Q4 model and then applied to simulate natural convection at two high Rayleigh numbers of R a = 10 7  and 10 8 . The obtained results on different grids will be compared with those by MRT-based LBM [35]. Thirdly, the compressible LBFS will be improved by incorporating non-equilibrium effects into the process for inviscid flux reconstruction and introducing a switch function to control numerical diffusion. Its performance will be examined by simulating transonic inviscid and viscous flows around a staggered-biplane configuration on unstructured grids. The obtained results will be compared with the published data.

2. Lattice Boltzmann Method

For a general case, we consider incompressible thermal fluid flows and the LBE with BGK approximation can be written as [34,36]:
f α ( r + e α δ t , t + δ t ) = f α ( r , t ) + f α e q ( r , t ) f α ( r , t ) τ v , α = 0 , 1 , ... , N ,
g α ( r + e α δ t , t + δ t ) = g α ( r , t ) + g α e q ( r , t ) g α ( r , t ) τ c , α = 0 , 1 , ... , M ,
where f α and g α are density distribution functions (DDF) and temperature distribution functions (TDF) respectively; f α e q and g α e q are equilibrium states of f α and g α ; τ v and τ c are relaxation parameters; δ t is the streaming time; M and N are the total number of discrete particles for f α and g α . The macroscopic fluid properties of density ρ , velocity u and temperature T are evaluated from lattice moments of f α and g α :
ρ = α = 0 N f α ,   ρ u = α = 0 N f α e α ,   T = α = 0 M g α
The equilibrium DDF f α e q is given by [4]:
f α e q ( r , t ) = ρ w α [ 1 + e α u c s 2 + ( e α u ) 2 ( c s | u | ) 2 2 c s 4 ]
The D2Q9 model, whose lattice components are written as e α = ( 0 , 0 ) , ( ± 1 , 0 ) , ( 0 , ± 1 ) and ( ± 1 , ± 1 ) , is commonly applied for f α e q . The weights w α and the sound speed c s in Equation (4) are w 0 = 4 / 9 , w 1 ~ 4 = 1 / 9 , w 5 ~ 8 = 1 / 36 and c s = 1 / 3 . The equilibrium TDF g α e q is given by [37]:
g α e q ( r , t ) = T 4 [ 1 + 2 e α u ]
The D2Q4 lattice velocity model, whose lattice components are written as e α = ( ± 1 , ± 1 ) , is usually used for g α e q . τ ν and τ c are respectively calculated by the dynamic viscosity μ and thermal diffusivity κ :
μ = ( τ ν 1 2 ) ρ c s 2 δ t
κ = 1 2 ( τ c 1 2 ) δ t
Note that Equations (1) and (2) are applied to simulate thermal flows. If isothermal flows are considered, we can just apply Equation (1). For the application of LBM, we have to apply Equations (1) and (2) in the whole computational domain and track the evolution of distribution functions f α and g α . In addition, physical boundary conditions for macroscopic variables are converted to those for f α and g α . For no-slip condition, bounce-back scheme can be easily applied. In some cases, accurate implementation of other boundary conditions in the LBM may not be as straightforward as in Navier–Stokes solvers.

3. Chapman–Enskog Analysis

As a mesoscopic method with microscopic particle distribution functions, the LBM described in Section 2 has been well applied to study weakly compressible fluid flows in incompressible limit. Conventionally, such flows are governed and solved by the macroscopic conservation laws of mass, momentum and energy. This indicates that the solution of a physical flow problem can be either obtained by applying the mesoscopic LBM or the macroscopic Navier–Stokes solver. It is interesting to note that these two intrinsically different numerical methods, one from microscopic statistical physics and the other from macroscopic conservation laws, are both able to study the same fluid flow problem. From this point of view, it can be inferred that these two methods should have some connections. Indeed, it has been proven that the lattice Boltzmann equation is able to recover the Navier–Stokes equation through the multi-scale Chapman–Enskog expansion analysis, which is briefly introduced below.
A multi-scale expansion of the DDF, TDF, the temporal derivative and the spatial derivative can be respectively given by:
f α = f α ( 0 ) + ε f α ( 1 ) + ε 2 f α ( 2 )
g α = g α ( 0 ) + ε g α ( 1 ) + ε 2 g α ( 2 )
t = ε t 0 + ε 2 t 1
r = ε r 1
where ε is a small parameter proportional to the Knudsen number. Applying the second order Taylor-series expansion to Equations (1) and (2) gives:
( t + e α ) f α + δ t 2 ( t + e α ) 2 f α + 1 τ δ t ( f α f α e q ) + O ( δ t 2 ) = 0 ,
( t + e α ) g α + δ t 2 ( t + e α ) 2 g α + 1 τ δ t ( g α g α e q ) + O ( δ t 2 ) = 0 .
The macroscopic Navier–Stokes equations for conservation laws can be recovered by substituting Equation (7) into Equations (8) and (9) [9,10]:
W t + F = 0
where:
W = { ρ ρ u T }   and   F = { P Π Q }
In Equation (11), P ,   Π and Q are respectively mass, momentum and energy fluxes and can be given by lattice summations of DDFs and TDFs [9,10]:
P = ρ u = α = 0 N f α e q e α
Π = ρ u u + p I μ ( u + ( u ) T ) = α = 0 N e α e α f α ^
Q = u T κ T = α = 0 N e α g α ^
where:
f α ^ = f α e q + ( 1 1 2 τ ν ) f α n e q   and   g α ^ = g α e q + ( 1 1 2 τ c ) g α n e q
f α n e q τ ν δ t ( t + e α ) f α e q
g α n e q τ c δ t ( t + e α ) g α e q
In the conventional LBM, the Chapman–Enskog (C-E) analysis is usually used to verify that the flow variables obtained by LBM can satisfy the macroscopic Navier–Stokes equations. In some interesting works, this C-E analysis is also applied to build a hybrid solver by combing the LBM with the FVM scheme for Navier–Stokes equations [37,38,39]. In our recent work [9,10], it was found that the relationship between flow variables/fluxes and particle distribution functions given in Equation (12) can be applied to build a new solver named LBFS with a better performance, which effectively combines the advantages of Navier–Stokes solver and lattice Boltzmann solver and at the same time removes some of their drawbacks. The reliability and flexibility of the LBFS have been demonstrated in [8,9,10].

4. LBFS for Isothermal and Thermal Incompressible Flows

Based on the LBM given by Equations (1) and (2), the LBFS [9] has been proposed by solving Equation (10) directly. Unlike conventional Navier–Stokes solver, which applies well-established schemes to discretize Equation (10), the LBFS is a finite volume solver and reconstructs its fluxes locally with Equation (12) derived from Chapman–Enskog analysis. It may be pointed out that Equation (12) for flux reconstruction can be applied with different lattice velocity models. In our previous work [9], the D2Q9 thermal model for temperature field is applied, which is obviously complex and inefficient as compared with the D2Q4 model [34]. In this work, this drawback will be removed by applying the D2Q4 model. The details are given below.

4.1. Finite Volume Discretization

A finite volume discretization of Equation (10) over a control volume Ω i gives the following formulation:
d W i d t = 1 d V i k R k d l k ,   R k = ( n F ) k
where d V i is the area of the control cell Ω i , d l k is the length of the k-th control surface enclosed Ω i and n = ( n x , n y ) is the unit normal vector on the k-th control surface. With the D2Q9 and D2Q4 models, the flux R k at each cell interface can be written as follows:
R k = ( n x ( f 1 e q f 3 e q + f 5 e q f 6 e q f 7 e q + f 8 e q ) + n y ( f 2 e q f 4 e q + f 5 e q + f 6 e q f 7 e q f 8 e q ) n x ( f 1 ^ + f 3 ^ + f 5 ^ + f 6 ^ + f 7 ^ + f 8 ^ ) + n y ( f 5 ^ f 6 ^ + f 7 ^ f 8 ^ ) n x ( f 5 ^ f 6 ^ + f 7 ^ f 8 ^ ) + n y ( f 2 ^ + f 4 ^ + f 5 ^ + f 6 ^ + f 7 ^ + f 8 ^ ) n x ( g 1 ^ g 3 ^ ) + n y ( g 2 ^ g 4 ^ ) ) k
As can be seen, the formulation of the energy flux reconstructed by the simplified D2Q4 lattice velocity model is much simpler than that given by the original D2Q9 model [9]. In Equation (16), the unknowns are f α ^ and g α ^ defined in Equation (13), which include both equilibrium and non-equilibrium density and temperature distribution functions f α e q , f α n e q , g α e q and g α n e q . All these unknowns can be obtained through local reconstruction of the LBE solution without tracking the evolution of the DDF and TDF.

4.2. Local Reconstruction of Fluxes at Each Interface

Figure 1 shows an interface between two adjacent control cells for local reconstruction of fluxes [10], in which the D2Q9 and D2Q4 lattice velocity models respectively for DDF and TDF are embedded. The non-equilibrium parts for DDF and TDF are given by Equation (14). At each cell interface, discretization of Equation (14) with the second-order Taylor-series expansion gives the following equations [9]:
f α n e q ( r , t ) = τ ν [ f α e q ( r , t ) f α e q ( r e α δ t , t δ t ) ]
g α n e q ( r , t ) = τ c [ g α e q ( r , t ) g α e q ( r e α δ t , t δ t ) ]
where r represents the location of the cell interface. Equation (17) shows that both f α n e q and g α n e q can be approximated from f α e q and g α e q at the interface and its surrounding points r e α δ t . Following the convention in LBM, f α e q and g α e q at the position and time ( r e α δ t , t δ t ) are computed by using Equations (4) and (5). The involved flow quantities of density ρ , velocity u and temperature T at ( r e α δ t , t δ t ) can be obtained through interpolations:
ψ ( r e α δ t , t δ t ) = { ψ ( r i ) + ( r e α δ t r i ) · ψ ( r i ) ,         when  r e α δ t  is in  Ω i ψ ( r i + 1 ) + ( r e α δ t r i + 1 ) · ψ ( r i + 1 ) ,  when  r e α δ t  is in   Ω i + 1
where r i and r i + 1 are the locations of the two cell centers and ψ represents any of the flow variables. After interpolation, f α e q ( r e α δ t , t δ t ) and g α e q ( r e α δ t , t δ t ) can be obtained.
Figure 1. Evaluation of flux at an interface between two control cells.
Figure 1. Evaluation of flux at an interface between two control cells.
Entropy 17 07713 g001
Similarly, f α e q ( r , t ) and g α e q ( r , t ) can be calculated by Equations (4) and (5) if macroscopic flow variables are known. So, the challenging issue is to evaluate ρ , u and T at the cell interface ( r , t ) . Previous studies [9,10] have shown that they can be reconstructed locally by streaming the particle from the neighboring point ( r e α δ t , t δ t ) to the cell interface. As a result, we have:
ρ ( r , t ) = α = 0 N f α e q ( r e α δ t , t δ t ) ,
ρ ( r , t ) u ( r , t ) = α = 0 N f α e q ( r e α δ t , t δ t ) e α
T ( r , t ) = α = 0 N g α e q ( r e α δ t , t δ t )
With the flow quantities obtained from Equation (19), f α e q ( r , t ) and g α e q ( r , t ) can be computed by using Equations (4) and (5). Once f α e q , f α n e q , g α e q and g α n e q are obtained, the fluxes at each cell interface can be evaluated numerically. Then Equation (15) can be solved by conventional Runge–Kutta scheme.

5. LBFS for Compressible Flows

5.1. Navier–Stokes Equations Discretized by FVM and Compressible Lattice Boltzmann Model

In Section 4, the local LBM solution is reconstructed by using the conventional lattice Boltzmann model, which is limited to incompressible flows. Thus, LBFS in Section 4 can only be applied to simulate incompressible flows. To simulate compressible flows by LBFS, we need to use the compressible lattice Boltzmann model to reconstruct the solution at the cell interface. However, the existing compressible lattice Boltzmann models are very complicated and inefficient for 2D and 3D cases. To simplify the solution process and make LBFS be applicable for simulation of compressible flows, we apply the 1D compressible lattice Boltzmann model along the normal direction of cell interface to evaluate the inviscid flux, and the viscous flux is still approximated by conventional finite difference schemes. This process is equivalent to developing a Riemann solver by 1D compressible lattice Boltzmann model.
In LBFS, the Navier–Stokes equations are discretized by FVM and the fluxes at the cell interface are evaluated by local reconstruction of LBM solutions [11]. Thanks to the application of FVM, it is convenient for LBFS to apply on arbitrary meshes. The compressible Navier–Stokes equations discretized by FVM can be written as:
d W i d t = 1 d V i k = 1 N f ( F c k F v k ) d l k
where i is the index of a control volume, d V i and N f represent the volume and the number of interfaces of the control volume i, respectively. W , F c and F v are the conservative variables at the cell center and the inviscid and viscous fluxes at the cell interface given by:
W = [ ρ ρ u ρ v ρ E ] ,   F c = [ ρ U n ρ u U n + n x p ρ v U n + n y p ( ρ E + p ) U n ] ,   F v = [ 0 n x τ x x + n y τ x y n x τ y x + n y τ y y n x Θ x + n y Θ y ]
Here, ρ and p are the density and pressure of mean flow, respectively. ( u , v ) and ( n x , n y ) denote the velocity vector and unit normal vector on the control surface in the Cartesian coordinate system, respectively. E is the total energy of mean flow. U n represents the normal velocity. Furthermore, τ i j denotes the components of viscous stress tensor and Θ i represents the term describing the work of viscous stress and the heat conduction in the fluid.
To compute F c by LBFS, the compressible lattice Boltzmann model is required. In this work, the non-free parameter D1Q4 model [11] is utilized. The configuration of this model is shown in Figure 2, and it is given by:
g 1 = ρ ( d 1 d 2 2 d 2 2 u + d 1 u 2 + d 1 c 2 + u 3 + 3 u c 2 ) 2 d 1 ( d 1 2 d 2 2 ) g 2 = ρ ( d 1 d 2 2 + d 2 2 u + d 1 u 2 + d 1 c 2 u 3 3 u c 2 ) 2 d 1 ( d 1 2 d 2 2 ) g 3 = ρ ( d 1 2 d 2 + d 1 2 u d 2 u 2 d 2 c 2 u 3 3 u c 2 ) 2 d 2 ( d 1 2 d 2 2 ) g 4 = ρ ( d 1 2 d 2 d 1 2 u d 2 u 2 d 2 c 2 + u 3 + 3 u c 2 ) 2 d 2 ( d 1 2 d 2 2 )
d 1 = u 2 + 3 c 2 4 u 2 c 2 + 6 c 4 d 2 = u 2 + 3 c 2 + 4 u 2 c 2 + 6 c 4
where c represents the peculiar velocity of particles defined as c = p / ρ . Note that in Equation (22), g is the equilibrium distribution function f e q . As D1Q4 model is a one-dimensional model, it needs to be applied along the normal direction of cell interface for multi-dimensional problems [11]. That is, the velocity u in Equations (22) and (23) should be replaced by normal velocity U n when multi-dimensional problems are considered.
Figure 2. Configuration of non-free parameter D1Q4 model.
Figure 2. Configuration of non-free parameter D1Q4 model.
Entropy 17 07713 g002
Suppose that the cell interface is located at r = 0 . For simplicity, a local-coordinate system with x-axis pointing to the normal direction and y-axis pointing to the tangential direction of the cell interface is used. As a result, the inviscid flux at the cell interface in the local-coordinate system can be written as:
F c * = [ ρ U n ρ U n U n + p ρ U n U τ ( ρ E + p ) U n ] T = F c n + F c t
F c n = [ ρ U n ρ U n U n + p 0 ( ρ ( 1 2 U n 2 + e ) + p ) U n ] T
F c t = [ 0 0 ρ U n U τ 1 2 ρ U τ 2 U n ] T
Here, F c n and F c t are respectively the flux attributed to the normal velocity and tangential velocity, e is the potential energy of mean flow. From Chapman–Enskog analysis, and with the use of non-free parameter D1Q4 model, F c n can be computed by:
F c n = i = 1 4 ξ i φ i f i ( 0 , t )
where:
f i ( 0 , t ) = f e q ( 0 , t ) + f n e q ( 0 , t ) = g i ( 0 , t ) τ 0 [ g i ( 0 , t ) g i ( ξ i δ t , t δ t ) ] ,
ξ i is the particle velocity in the i -direction, i.e., ξ 1 = d 1 , ξ 2 = d 1 , ξ 3 = d 2 and ξ 4 = d 2 . φ i stands for the moments:
φ i = ( 1 , ξ i , 0 , 1 2 ξ i 2 + e p ) T
Here, e p is the potential energy of particles; f i ( 0 , t ) is the distribution function at the cell interface. g i ( 0 , t ) and g i ( ξ i δ t , t δ t ) are respectively the equilibrium distribution function at the cell interface and the surrounding point of the cell interface. The non-equilibrium part in Equation (26) is viewed as the numerical dissipation since only the inviscid flux is computed by LBFS. τ 0 is the dimensionless collision time, which can be regarded as the weight of the numerical dissipation [40,41]. Substituting Equation (26) into Equation (25), we have the final expression of F c n as follows:
F c n = ( 1 τ 0 ) F c n , I + τ 0 F c n , I I
where:
F c n , I = i = 1 4 ξ i φ a g i ( 0 , t )   and   F c n , I I = i = 1 4 ξ i φ a g i ( ξ i δ t , t δ t )
To evaluate the flux attributed to the tangential velocity, one of the feasible ways can be expressed as:
F c t ( 3 ) = i = 1 , 3 ξ i f i ( 0 , t ) U τ L + i = 2 , 4 ξ i f i ( 0 , t ) U τ R
F c t ( 4 ) = 1 2 [ i = 1 , 3 ξ i f i ( 0 , t ) ( U τ L ) 2 + i = 2 , 4 ξ i f i ( 0 , t ) ( U τ R ) 2 ]
where, U τ L and U τ R are the tangential velocity at the left and right side of cell interface, respectively. From F c * , the actual inviscid flux F c in Equation (20) in the Cartesian coordinate system can be obtained by a transformation [41]:
F c = [ F c * ( 1 ) F c * ( 2 ) n x F c * ( 3 ) n y F c * ( 2 ) n y + F c * ( 3 ) n x F c * ( 4 ) ]
Equation (31) forms the LBFS for inviscid compressible flows. It can be treated as a Riemann solver developed by 1D compressible lattice Boltzmann model. As for the viscous flux F v , it is still approximated by conventional finite difference schemes in this work.

5.2. Evaluation of Inviscid Flux by LBFS

To compute F c n , I , the equilibrium distribution function at the cell interface should be computed in advance. As the equilibrium distribution function is the function of conservative variables, we just need to calculate the conservative variables at the cell interface first. The conservative variables at the cell interface in the local-coordinate system can be expressed as:
W * = [ ρ ρ U n ρ U τ ρ E ] T = W n + W t
W n = [ ρ ρ U n 0 ρ ( 1 2 U n 2 + e ) ] T
W t = [ 0 0 ρ U τ 1 2 ρ U τ 2 ] T
Like Equation (19), the conservative variables at the cell interface attributed to the normal velocity can be evaluated by:
W n = i = 1 4 φ i g i ( ξ i δ t , t δ t )
It is assumed that a local Riemann problem is formed at the cell interface. Then, the equilibrium distribution function g i ( ξ i δ t , t δ t ) can be given by:
g i ( ξ i δ t , t δ t ) = { g i L     if   i = 1 , 3 g i R    if   i = 2 , 4
where g i L and g i R are the equilibrium distribution functions at the left and right sides of cell interface as shown in Figure 3. In addition, the conservative variables attributed to the tangential velocity can be approximated by:
W t ( 3 ) = i = 1 , 3 g i ( ξ i δ t , t δ t ) U τ L + i = 2 , 4 g i ( ξ i δ t , t δ t ) U τ R
W t ( 4 ) = 1 2 [ i = 1 , 3 g i ( ξ i δ t , t δ t ) ( U τ L ) 2 + i = 2 , 4 g i ( ξ i δ t , t δ t ) ( U τ R ) 2 ]
Once the conservative variables at the cell interface W * are obtained, the flux attributed to the equilibrium distribution function at the cell interface F c n , I can be calculated by substituting the above conservative variables directly into the expression of inviscid flux. As for the flux F c n , I I , it can be obtained by substituting Equation (34) into Equation (29) directly.
Figure 3. Streaming process of D1Q4 model at the cell interface.
Figure 3. Streaming process of D1Q4 model at the cell interface.
Entropy 17 07713 g003

6. Numerical Examples and Discussion

In this section, several benchmark cases will be studied to examine the performance of newly-developed LBFS. In particular, lid-driven cavity flows and steady natural convection in a square cavity at high Rayleigh numbers of 107 and 108 will be simulated on non-uniform grids by the incompressible LBFS. Transonic flows around a staggered-biplane configuration will be studied on unstructured grids by using the compressible LBFS.

6.1. Lid-Driven Cavity Flows

As a benchmark problem, the classical lid-driven cavity flow has been studied extensively by many researchers [30,31,32,33,34]. This problem involves several geometrical and flow parameters: the length of the cavity L , the velocity of the lid U and the density and dynamic viscosity of the fluid ρ and μ . With these parameters, the Reynolds number is defined as Re = ρ U L / μ . In present study, this problem will be solved by using the LBFS and the standard LBM to compare their accuracy, stability and efficiency in detail.
At first, the accuracy of the LBFS and LBM are examined by comparing the pressure and velocity profiles for lid-driven cavity flows at Re = 5000. In the computation, a non-uniform grid of 101 × 101 for the LBFS and uniform grid of 301 × 301 for LBM are applied. Note that much finer grid is required for the LBM to maintain numerical stability at this Reynolds number. Figure 4 compares the pressure and velocity profiles obtained by these two methods. It can be seen that excellent agreements have been achieved. Note that the LBFS uses about one-ninth of the total grid points adopted by the LBM, which shows its advantage and capability in applying non-uniform grids. It may also be noted that both LBFS and LBM have the second order of accuracy and quantitatively similar solutions will be obtained when the same grids are applied [8,9,10].
Figure 4. Comparison of pressure and velocity profiles on the vertical centerline for lid-driven cavity flows at Re = 5000. (a) Pressure; (b) Velocity.
Figure 4. Comparison of pressure and velocity profiles on the vertical centerline for lid-driven cavity flows at Re = 5000. (a) Pressure; (b) Velocity.
Entropy 17 07713 g004
After that, the pure stability of the LBFS and LBM is investigated without considering numerical accuracy. This test is conducted by simulating the lid-driven cavity flows at Reynolds numbers from 100 to 5000. The minimum grids to get stable solution required respectively by the LBFS and LBM are recorded and shown in Table 1. It can be seen that, with the increase of Reynolds number, the LBM requires more grid points to maintain stability while the LBFS only needs a grid size of 4 × 4 for all cases considered. This feature indicates that the LBFS is more stable than LBM. In addition, the stability of these two methods can be further examined by comparing numerical solutions for pressure. Figure 5 compares the pressure contours of lid-driven cavity flows at Reynolds number of 5000. A grid size of 101 × 101 is applied by the LBFS and 301 × 301 is applied by the LBM. It is obvious that the results of LBM for pressure field have substantial unphysical oscillations at the top left, top right and bottom right corners while those of the LBFS are smooth all over the flow domain. This phenomenon indicates that the stability of LBFS is superior to that of the LBM.
Table 1. Minimum required mesh resolution of the lattice Boltzmann flux solver (LBFS) and lattice Boltzmann method (LBM) for lid-driven cavity flows at different Reynolds numbers.
Table 1. Minimum required mesh resolution of the lattice Boltzmann flux solver (LBFS) and lattice Boltzmann method (LBM) for lid-driven cavity flows at different Reynolds numbers.
Re100100050007500
LBGK5 × 539 × 39219 × 219341 × 341
LBFS4 × 44 × 44 × 44 × 4
Figure 5. Comparison of pressure contours for lid-driven cavity flows at Re = 5000. (a) lattice Boltzmann flux solver (LBFS); (b) lattice Boltzmann method (LBM).
Figure 5. Comparison of pressure contours for lid-driven cavity flows at Re = 5000. (a) lattice Boltzmann flux solver (LBFS); (b) lattice Boltzmann method (LBM).
Entropy 17 07713 g005
Moreover, the efficiency of the LBFS and LBM are investigated by considering two cases. The first one is their efficiency on the same uniform grid of 301 × 301 by simulating the lid-driven cavity flow at Re = 5000. The other case is to examine the computational effort of the LBFS on non-uniform grids when its results agree well with those of the LBM. Table 2 compares the CPU time consumed by each solver in these two cases. As can be seen, when applied on the same grid, the LBFS takes about 3.8 times the computational time and 47% of the virtual memory that are required by the LBM. This is mainly attributed to the fact that, in the LBFS, interpolations of physical quantities are performed at each cell for flux reconstruction, which degrades its efficiency. On the other hand, when the solution of the LBFS compares well with that of LBM as shown in Figure 4, the LBFS only needs a non-uniform grid of 101 × 101 . As compared with those of LBM, only about 16.6% of computational time and 5.3% of virtual memory are consumed by the LBFS. This indicates that the LBFS needs less computational resources and can be more efficient for applications on non-uniform grids.
Table 2. Comparison of performance of the lattice Boltzmann flux solver (LBFS) and lattice Boltzmann method (LBM) on different grids for 2D lid-driven cavity flows at Re = 5000.
Table 2. Comparison of performance of the lattice Boltzmann flux solver (LBFS) and lattice Boltzmann method (LBM) on different grids for 2D lid-driven cavity flows at Re = 5000.
Object TypeMethodMin.Max.Avg.Std. Dev.
FacilityV2SFCA56725.5313.95
EV2SFCA511827.7123.88
PopulationV2SFCA56323.2015.08
EV2SFCA57025.4917.54

6.2. Natural Convection in a Square Cavity at High Rayleigh Number

Natural convection in a square cavity is a benchmark case for validating various numerical methods [35,37,42]. For instance, Peng et al. [42] simulated this problem at Rayleigh numbers from Ra = 103 to 106 to validate their simplified SRT-based thermal LB model. Guo et al. [37] studied this problem to examine their D2Q4 thermal LB model. Contrino et al. [35] validated their MRT-based thermal LB model by simulating this flow at high Rayleigh numbers of 107 and 108. Recently, with SRT-based D2Q9 thermal LB model, the LBFS [9] has also been validated through its application to simulate this problem from Ra = 103 to 106. It is noticed that, to study this problem, all versions of LBM restrict their computations on uniform grids. However, non-uniform grids may be more accurate and efficient to capture thin boundary layers, especially for flows at high Rayleigh numbers. This provides a good chance to examine the performance of the LBFS with D2Q4 thermal LB model.
The flow pattern of this problem is characterized by two normalized parameters: the Prandtl number P r and the Rayleigh number Ra, which can be respectively defined as:
P r = ν χ ,   R a = g β Δ T L 3 ν χ = V c 2 L 2 ν χ
where L is the length of the square cavity, Δ T is the temperature difference between the hot and cold walls and V c = g β L Δ T is the characteristic thermal velocity. The flow parameters are set as follows: L = 1 , V c = 0.1 , Pr = 0.71. Two high Rayleigh numbers of R a = 10 7 and 108 are considered. Non-uniform grids with different grid sizes ( 201 × 201 and 301 × 301 for R a = 10 7 ; 301 × 301 and 401 × 401 for R a = 10 8 ) are applied. To quantify the result, the mean Nusselt number N u 1 / 2 along the line of x = L / 2 is computed and compared:
N u 1 / 2 = L χ Δ T 1 L x = L / 2 ( u T χ T x ) d l
Table 3 and Table 4 show the maximum absolute value of the stream-function | φ | max and its position, the mean Nusselt number N u 1 / 2 along the vertical centerline, the maximum u-velocity Umax along x = L / 2 and its vertical position, the maximum v-velocity Vmax along y = L / 2 and its horizontal position. The numerical results of Contrino et al. [35] obtained by the MRT-LBM and those of Quere [43] obtained by a high order pseudo-spectral method are also included for comparison. With the increase of the grid size, the present solution is closer to the benchmark solution of Quere [43] for all cases considered. In particular, the relative error of | φ | max between the present solution on the finest grid and those of Quere [43] is within 0.26% and that of N u 1 / 2 is within 0.08%. This indicates that both the strength of the flow field represented by the stream-function and the heat transfer rate represented by the mean Nusselt number are well predicted by the LBFS. Figure 6 and Figure 7 show the streamlines and isotherms at Rayleigh numbers of 107 and 108 respectively. At Ra = 107, a large clock-wise recirculation is formed and attached to all walls. Both the flow and temperature boundary layers close to the hot and cold walls are very thin. The temperature at the same height of the cavity is almost a constant near central area. As Ra is increased to 108, the boundary layer separates near the bottom left and top right region. Figure 8 shows the u-velocity along the vertical centerline and v-velocity along the horizontal centerline. As can be seen, the velocity component v is almost zero in a large zone except for those near the wall. This indicates that vertical convection in the central area can be very weak and heat conduction dominates this region. This is consistent with the observation that the temperature on the same latitude is almost a constant in the central area of the cavity.
Table 3. Comparison of representative quantities for natural convection in a square cavity at Ra = 107.
Table 3. Comparison of representative quantities for natural convection in a square cavity at Ra = 107.
Grid SizePresentContrino et al. [35]Quere [43]
2012301237921019215312
| φ | max 30.16530.16430.34930.31030.18530.165
x0.08680.08570.08480.08560.08570.86
y0.55450.55590.55780.55620.55590.556
Nu1/216.55016.54316.52616.52316.52316.52
Umax148.17148.84148.48148.57148.58148.59
y0.87880.87890.87940.87930.87930.879
Vmax699.19699.91699.11699.27699.31699.18
x0.02040.02160.02140.02130.02130.021
Table 4. Comparison of representative quantities for natural convection in a square cavity at Ra = 108.
Table 4. Comparison of representative quantities for natural convection in a square cavity at Ra = 108.
Grid SizePresentContrino et al. [35]Quere [43]
301401237921019215312
| φ | max 53.95553.89354.87054.10653.95353.85
x0.04820.47600.04690.04780.04800.048
y0.55360.55280.55940.55450.55330.553
Nu1/230.35330.30130.25730.22930.22730.225
Umax316.07323.65315.08320.74321.37321.9
x0.92670.92880.92390.92730.92760.928
Vmax2221.12222.92221.42222.12222.32222
y0.01180.11920.01210.01200.01200.012
Figure 6. Streamlines and isotherms for natural convection at Ra = 107. (a) Streamlines; (b) Isotherms.
Figure 6. Streamlines and isotherms for natural convection at Ra = 107. (a) Streamlines; (b) Isotherms.
Entropy 17 07713 g006
Figure 7. Streamlines and isotherms for natural convection at Ra = 108. (a) Streamlines; (b) Isotherms.
Figure 7. Streamlines and isotherms for natural convection at Ra = 108. (a) Streamlines; (b) Isotherms.
Entropy 17 07713 g007
Figure 8. Illustration of the velocity profiles at the centerlines for natural convection at Ra = 107 and 108. (a) Ra = 107; (b) Ra = 108.
Figure 8. Illustration of the velocity profiles at the centerlines for natural convection at Ra = 107 and 108. (a) Ra = 107; (b) Ra = 108.
Entropy 17 07713 g008

6.3. Inviscid and Viscous Transonic Flows Around a Staggered-Biplane Configuration

To validate the compressible LBFS for simulation of flows with complex geometry, the inviscid and viscous transonic flows around a staggered-biplane configuration are simulated. This test example is taken from the work of Jawahar and Kamath [44]. It comprises two NACA0012 airfoils, staggered by half a chord length in the pitchwise as well as chordwise directions. At first, the inviscid flow with the free-stream Mach number of 0.7 and the angle of attack of 0 degree is simulated. In the test, the unstructured grid containing 256 points on each airfoil and 36,727 triangular cells in the computational domain is utilized, and its partial view is shown in Figure 9a. The pressure contours obtained from present scheme are shown in Figure 9b. It can be seen from the figure that, a strong normal shock is formed between two airfoils and near the trailing edge of bottom airfoil, which is in line with those observed by Jawahar and Kamath [44] and Lerat and Wu [45]. Figure 10 shows the pressure coefficient distribution on the airfoil surface computed by present scheme. Also displayed in this figure are the results of Jawahar and Kamath [44] and Lerat and Wu [45]. Clearly, the results of current scheme agree well with the published data.
Figure 9. Partial view of computational mesh and pressure contours for inviscid biplane configuration. (a) Computational mesh; (b) Pressure contours.
Figure 9. Partial view of computational mesh and pressure contours for inviscid biplane configuration. (a) Computational mesh; (b) Pressure contours.
Entropy 17 07713 g009
Figure 10. Comparison of pressure coefficient distribution on the surface of bottom and top airfoils for inviscid biplane configuration. (a) Bottom airfoil; (b) Top airfoil.
Figure 10. Comparison of pressure coefficient distribution on the surface of bottom and top airfoils for inviscid biplane configuration. (a) Bottom airfoil; (b) Top airfoil.
Entropy 17 07713 g010
In addition, the viscous flow with the free-stream Mach number of 0.8, the Reynolds number of 500 and the angle of attack of 10 degree is simulated. In the simulation, the unstructured grid containing 512 points on each airfoil and 65,861 cells in the computational domain is used, and its partial view is shown in Figure 11a. Figure 11b shows the streamline pattern obtained from present scheme. From this figure, it can be observed that the separation region on the upper surface of top airfoil reveals two vortices. This observation is consistent with the results reported in [44]. As pointed out by Jawahar and Kamath [44], the secondary vortex is introduced by the bottom airfoil. The comparison of pressure coefficient and skin friction coefficient distributions on the airfoil surface obtained by present scheme with those reported in [44] is shown in Figure 12. Once again, the results obtained by present scheme compare well with the reference data.
Figure 11. Partial view of computational mesh and streamline pattern for viscous biplane configuration. (a) Computational mesh; (b) Streamline pattern.
Figure 11. Partial view of computational mesh and streamline pattern for viscous biplane configuration. (a) Computational mesh; (b) Streamline pattern.
Entropy 17 07713 g011
Figure 12. Comparison of pressure coefficient and skin friction coefficient distributions for viscous biplane configuration. (a) Pressure coefficient distribution; (b) Skin friction distribution.
Figure 12. Comparison of pressure coefficient and skin friction coefficient distributions for viscous biplane configuration. (a) Pressure coefficient distribution; (b) Skin friction distribution.
Entropy 17 07713 g012

7. Conclusions

As a finite-volume solver, the LBFS directly updates macroscopic flow variables at cell centers by solving macroscopic governing equations. Its fluxes are reconstructed locally at each interface through lattice moments of particle distribution functions, in which the relationships obtained from the Chapman–Enskog theory are applied. During local reconstruction, the LBM is applied locally in one streaming time step, which is different from the global application of the conventional LBM. As a consequence, the LBFS is able to combine the advantages of the finite volume method and the LBM.
In this work, the historic development from the LBM to the LBFS is briefly introduced and their relationships with the macroscopic conservation laws are also described through the multi-scale Chapman–Enksog analysis. The major contribution of this work is to refine and examine three different versions of the LBFS, proposed respectively for isothermal, thermal and compressible flows. In particular, the accuracy, stability and efficiency of the isothermal LBFS are compared with the LBM in detail. The LBFS for temperature field is simplified by the D2Q4 model, which reduces computational effort as compared with that by D2Q9 model. The LBFS for compressible flows is improved by incorporating non-equilibrium effects into the process for inviscid flux reconstruction, in which numerical dissipation can be controlled through a switch function.
Several benchmark problems, including lid-driven cavity flows, natural convection in a square cavity at high Rayleigh numbers of 107 and 108 and transonic flows around a staggered-biplane configuration, have been carried out to examine the solvers. Numerical results show that the LBFS is able to obtain comparable solutions with much less non-uniform grid points and its efficiency can be greatly improved. It is also shown that LBFS is much more stable than LBM and does not generate unphysical pressure oscillations for lid-driven cavity flows. With the application of one-dimensional compressible lattice Boltzmann model, the LBFS can be effectively applied for simulation of compressible flows on unstructured grids.

Author Contributions

The authors contributed equally to the research and writing of this article. All authors have read and approved the final manuscript.

Conflicts of Interest

The authors declare no conflict of interest.

References

  1. McNamara, G.R.; Zanetti, G. Use of the Boltzmann Equation to Simulate Lattice-Gas Automata. Phys. Rev. Lett. 1988, 61, 2332–2335. [Google Scholar] [CrossRef] [PubMed]
  2. Higuera, F.J.; Succi, S.; Benzi, R. Lattice gas-dynamics with enhanced collisions. Europhys. Lett. 1989, 9, 345–349. [Google Scholar] [CrossRef]
  3. Chen, S.Y.; Chen, H.D.; Martinez, D.; Matthaeus, W. Lattice Boltzmann model for simulation of magnetohydrodynamics. Phys. Rev. Lett. 1991, 67, 3776–3779. [Google Scholar] [CrossRef] [PubMed]
  4. Qian, Y.H.; D’Humières, D.; Lallemand, P. Lattice BGK models for Navier–Stokes equation. Europhys. Lett. 1992, 17, 479–484. [Google Scholar] [CrossRef]
  5. Mei, R.; Shyy, W. On the Finite Difference-Based Lattice Boltzmann Method in Curvilinear Coordinates. J. Comput. Phys. 1998, 143, 426–448. [Google Scholar] [CrossRef]
  6. Hejranfar, K.; Ezzatneshan, E. Implementation of a high-order compact finite-difference lattice Boltzmann method in generalized curvilinear coordinates. J. Comput. Phys. 2014, 267, 28–49. [Google Scholar] [CrossRef]
  7. Zarghami, A.; Ubertini, S.; Succi, S. Finite-volume lattice Boltzmann modeling of thermal transport in nanofluids. Comput. Fluids 2013, 77, 56–65. [Google Scholar] [CrossRef]
  8. Wang, Y.; Shu, C.; Huang, H.B.; Teo, C.J. Multiphase lattice Boltzmann flux solver for incompressible multiphase flows with large density ratio. J. Comput. Phys. 2015, 280, 404–423. [Google Scholar] [CrossRef]
  9. Wang, Y.; Shu, C.; Teo, C.J. Thermal lattice Boltzmann flux solver and its application for simulation of incompressible thermal flows. Comput. Fluids 2014, 94, 98–111. [Google Scholar] [CrossRef]
  10. Shu, C.; Wang, Y.; Teo, C.J.; Wu, J. Development of Lattice Boltzmann Flux Solver for Simulation of Incompressible Flows. Adv. Appl. Math. Mech. 2014, 6, 436–460. [Google Scholar]
  11. Yang, L.M.; Shu, C.; Wu, J. A moment conservation-based non-free parameter compressible lattice Boltzmann model and its application for flux evaluation at cell interface. Comput. Fluids 2013, 79, 190–199. [Google Scholar] [CrossRef]
  12. Guo, Z.; Shi, B.; Wang, N. Lattice BGK Model for Incompressible Navier–Stokes Equation. J. Comput. Phys. 2000, 165, 288–306. [Google Scholar] [CrossRef]
  13. Shan, X.; Chen, H. Lattice Boltzmann model for simulating flows with multiple phases and components. Phys. Rev. E 1993, 47, 1815–1819. [Google Scholar] [CrossRef]
  14. Lee, T.; Lin, C.-L. A stable discretization of the lattice Boltzmann equation for simulation of incompressible two-phase flows at high density ratio. J. Comput. Phys. 2005, 206, 16–47. [Google Scholar] [CrossRef]
  15. He, X.; Chen, S.; Zhang, R. A Lattice Boltzmann Scheme for Incompressible Multiphase Flow and Its Application in Simulation of Rayleigh–Taylor Instability. J. Comput. Phys. 1999, 152, 642–663. [Google Scholar] [CrossRef]
  16. Li, Q.; He, Y.L.; Wang, Y.; Tao, W.Q. Coupled double-distribution-function lattice Boltzmann method for the compressible Navier–Stokes equations. Phys. Rev. E 2007, 76, 056705. [Google Scholar] [CrossRef] [PubMed]
  17. Chen, F.; Xu, A.; Zhang, G.; Li, Y.; Succi, S. Multiple-relaxation-time lattice Boltzmann approach to compressible flows with flexible specific-heat ratio and Prandtl number. Europhys. Lett. 2010, 90. [Google Scholar] [CrossRef]
  18. He, Y.-L.; Liu, Q.; Li, Q. Three-dimensional finite-difference lattice Boltzmann model and its application to inviscid compressible flows with shock waves. Physica A 2013, 392, 4884–4896. [Google Scholar] [CrossRef]
  19. Nie, X.; Doolen, G.D.; Chen, S. Lattice-Boltzmann Simulations of Fluid Flows in MEMS. J. Stat. Phys. 2002, 107, 279–289. [Google Scholar] [CrossRef]
  20. Lim, C.Y.; Shu, C.; Niu, X.D.; Chew, Y.T. Application of lattice Boltzmann method to simulate microchannel flows. Phys. Fluids 2002, 14, 2299–2308. [Google Scholar] [CrossRef]
  21. Meng, J.; Zhang, Y. Accuracy analysis of high-order lattice Boltzmann models for rarefied gas flows. J. Comput. Phys. 2011, 230, 835–849. [Google Scholar] [CrossRef] [Green Version]
  22. Lallemand, P.; Luo, L.-S. Theory of the lattice Boltzmann method: Dispersion, dissipation, isotropy, Galilean invariance, and stability. Phys. Rev. E 2000, 61, 6546–6562. [Google Scholar] [CrossRef]
  23. Niu, X.D.; Shu, C.; Chew, Y.T. A lattice Boltzmann BGK model for simulation of micro flows. Europhys. Lett. 2004, 67, 600–606. [Google Scholar] [CrossRef]
  24. Yuan, H.-Z.; Niu, X.-D.; Shu, S.; Li, M.; Yamaguchi, H. A momentum exchange-based immersed boundary-lattice Boltzmann method for simulating a flexible filament in an incompressible flow. Comput. Math. Appl. 2014, 67, 1039–1056. [Google Scholar] [CrossRef]
  25. Yuan, H.-Z.; Shu, S.; Niu, X.-D.; Li, M.; Hu, Y. A Numerical Study of Jet Propulsion of an Oblate Jelly fish Using a Momentum Exchange-Based Immersed Boundary-Lattice Boltzmann Method. Adv. Appl. Math. Mech. 2014, 6, 307–326. [Google Scholar]
  26. Ubertini, S.; Succi, S. Recent advances of Lattice Boltzmann techniques on unstructured grids. Prog. Comput. Fluid Dyn. Int. J. 2005, 5, 85–96. [Google Scholar] [CrossRef]
  27. Rossi, N.; Ubertini, S.; Bella, G.; Succi, S. Unstructured lattice Boltzmann method in three dimensions. Int. J. Numer. Methods Fluids 2005, 49, 619–633. [Google Scholar] [CrossRef]
  28. Patankar, S.V.; Spalding, D.B. A calculation procedure for heat, mass and momentum transfer in three-dimensional parabolic flows. Int. J. Heat Mass Transf. 1972, 15, 1787–1806. [Google Scholar] [CrossRef]
  29. Sun, D.L.; Qu, Z.G.; He, Y.L.; Tao, W.Q. An efficient segregated algorithm for incompressible fluid flow and heat transfer problems-IDEAL (Inner Doubly Iterative Efficient Algorithm for Linked Equations) Part I: Mathematical formulation and solution procedure. Numer. Heat Transf. B 2008, 53. [Google Scholar] [CrossRef]
  30. Bruneau, C.-H.; Saad, M. The 2D lid-driven cavity problem revisited. Comput. Fluids 2006, 35, 326–348. [Google Scholar] [CrossRef]
  31. Kalita, J.C.; Gupta, M.M. A streamfunction–velocity approach for 2D transient incompressible viscous flows. Int. J. Numer. Methods Fluids 2010, 62, 237–266. [Google Scholar] [CrossRef]
  32. Lin, L.-S.; Chang, H.-W.; Lin, C.-A. Multi relaxation time lattice Boltzmann simulations of transition in deep 2D lid driven cavity using GPU. Comput. Fluids 2013, 80, 381–387. [Google Scholar] [CrossRef]
  33. Zhuo, C.; Zhong, C.; Cao, J. Filter-matrix lattice Boltzmann simulation of lid-driven deep-cavity flows, Part I—Steady flows. Comput. Math. Appl. 2013, 65, 1863–1882. [Google Scholar] [CrossRef]
  34. Zhuo, C.; Zhong, C.; Cao, J. Filter-matrix lattice Boltzmann simulation of lid-driven deep-cavity flows, Part II—Flow bifurcation. Comput. Math. Appl. 2013, 65, 1883–1893. [Google Scholar] [CrossRef]
  35. Contrino, D.; Lallemand, P.; Asinari, P.; Luo, L.-S. Lattice-Boltzmann simulations of the thermally driven 2D square cavity at high Rayleigh numbers. J. Comput. Phys. 2014, 275, 257–272. [Google Scholar] [CrossRef]
  36. Luan, H.-B.; Xu, H.; Chen, L.; Sun, D.-L.; He, Y.-L.; Tao, W.-Q. Evaluation of the coupling scheme of FVM and LBM for fluid flows around complex geometries. Int. J. Heat Mass Transf. 2011, 54, 1975–1985. [Google Scholar] [CrossRef]
  37. Guo, Z.; Shi, B.; Zheng, C. A coupled lattice BGK model for the Boussinesq equations. Int. J. Numer. Methods Fluids 2002, 39, 325–342. [Google Scholar] [CrossRef]
  38. Chen, L.; He, Y.-L.; Kang, Q.; Tao, W.-Q. Coupled numerical approach combining finite volume and lattice Boltzmann methods for multi-scale multi-physicochemical processes. J. Comput. Phys. 2013, 255, 83–105. [Google Scholar] [CrossRef]
  39. Chen, L.; Luan, H.; Feng, Y.; Song, C.; He, Y.-L.; Tao, W.-Q. Coupling between finite volume method and lattice Boltzmann method and its application to fluid flow and mass transport in proton exchange membrane fuel cell. Int. J. Heat Mass Transf. 2012, 55, 3834–3848. [Google Scholar] [CrossRef]
  40. Yang, L.M.; Shu, C.; Wu, J.; Zhao, N.; Lu, Z.L. Circular function-based gas-kinetic scheme for simulation of inviscid compressible flows. J. Comput. Phys. 2013, 255, 540–557. [Google Scholar] [CrossRef]
  41. Yang, L.M.; Shu, C.; Wu, J. A three-dimensional explicit sphere function-based gas-kinetic flux solver for simulation of inviscid compressible flows. J. Comput. Phys. 2015, 295, 322–339. [Google Scholar] [CrossRef]
  42. Peng, Y.; Shu, C.; Chew, Y.T. Simplified thermal lattice Boltzmann model for incompressible thermal flows. Phys. Rev. E 2003, 68, 026701. [Google Scholar] [CrossRef] [PubMed]
  43. Le Quéré, P. Accurate solutions to the square thermally driven cavity at high Rayleigh number. Comput. Fluids 1991, 20, 29–41. [Google Scholar] [CrossRef]
  44. Jawahar, P.; Kamath, H. A High-Resolution Procedure for Euler and Navier–Stokes Computations on Unstructured Grids. J. Comput. Phys. 2000, 164, 165–203. [Google Scholar] [CrossRef]
  45. Lerat, A.; Wu, Z.N. Stable Conservative Multidomain Treatments for Implicit Euler Solvers. J. Comput. Phys. 1996, 123, 45–64. [Google Scholar] [CrossRef]

Share and Cite

MDPI and ACS Style

Wang, Y.; Yang, L.; Shu, C. From Lattice Boltzmann Method to Lattice Boltzmann Flux Solver. Entropy 2015, 17, 7713-7735. https://0-doi-org.brum.beds.ac.uk/10.3390/e17117713

AMA Style

Wang Y, Yang L, Shu C. From Lattice Boltzmann Method to Lattice Boltzmann Flux Solver. Entropy. 2015; 17(11):7713-7735. https://0-doi-org.brum.beds.ac.uk/10.3390/e17117713

Chicago/Turabian Style

Wang, Yan, Liming Yang, and Chang Shu. 2015. "From Lattice Boltzmann Method to Lattice Boltzmann Flux Solver" Entropy 17, no. 11: 7713-7735. https://0-doi-org.brum.beds.ac.uk/10.3390/e17117713

Article Metrics

Back to TopTop