here

advertisement
Improved treatment of the open
boundary in the method of lattice
Boltzmann equation
Dazhi Yu, Renwei Mei and Wei Shyy
Department of Mechanical and Aerospace Engineering, University of
Florida, Gainesville, FL 32611-6250 USA
Abstract: The method of lattice Boltzmann equation (LBE) is a kineticbased approach for fluid flow computations. In LBE, the distribution functions on various boundaries are often derived approximately. In this paper,
the pressure interaction between an inlet boundary and the interior of the
flow field is analysed when the bounce-back condition is specified at the
inlet. It is shown that this treatment reflects most of the pressure waves
back into the flow field and results in a poor convergence towards the steady
state or a noisy flow field. An improved open boundary condition is developed to reduce the inlet interaction. Test results show that the new
treatment greatly reduces the interaction and improves the computational
stability and the quality of the flow field.
Keywords: lattice Boltzmann equation; boundary condition; inlet;
bounce-back.
Reference to this paper should be made as follows: Yu, D., Mei, R. and
Shyy, W. (xxxx) ‘Improved treatment of the open boundary in the method
of lattice Boltzmann equation’, Progress in Computational Fluid Design,
Vol. x, No. x, pp.xxx–xxx.
Biographical notes: Dazhi Yu received his PhD in Aerospace from
University of Florida. He is now a Postdoctoral Research Associate in
Aerospace Department at Texas A&M University. His research interests
include lattice Boltzmann method, parallel computation, and turbulence.
Renwei Mei is Professor of the Department of Mechanical and Aerospace
Engineering at University of Florida. His research areas include particle
dispersion and collision in turbulence, boiling heat transfer and two-phase
flow, lattice Boltzmann method, and desalination. He is interested in applying computational methods and applied mathematics to solve practical
thermal fluid problem.
Wei Shyy is currently Professor and Chairman of the Department of Mechanical and Aerospace Engineering at University of Florida (UF). He is
the author or a coauthor of three books dealing with computational and
modelling techniques involving fluid flow, interfacial dynamics, and moving
boundary problems. He has written papers dealing with computational and
modelling issues related to fluid dynamics, heat/mass transfer, combustion,
material processing, parallel computing, biological flight and aerodynamics,
1
design optimisation, micro-scale and biofluid dynamics.
1 INTRODUCTION
1.1
General description of the method
Since the last two decades or so, there has been a
rapid progress in developing the method of the lattice
Boltzmann equation (LBE) as an alternative, computational technique for solving a variety of complex fluid dynamic systems [1–16]. Adopting the
macroscopic method for computational fluid dynamics (CFD), macroscopic variables of interest, such as
velocity u and pressure p, are usually obtained by
solving the Navier-Stokes (NS) equations (e.g., see
[17,18]). In the LBE approach, one solves the kinetic
equation for the particle velocity distribution function f (x, ξ, t), where ξ is the particle velocity vector,
x is the spatial position vector, and t is the time. The
macroscopic quantities (such as mass density ρ and
momentum density ρu) can then be obtained by evaluating the hydrodynamic moments of the distribution function f . Lattice gas automata, the predecessor of LBE, were first proposed by Frisch et al. [19].
The theoretical foundation of LBE was established
in the subsequent papers, notably in McNamara and
Zanetti [20], Higuera and Jimenez [21], Koelman [22]
and Qian et al. [23].
A popular kinetic model adopted in the literature
is the single relaxation time approximation, the socalled BGK model [24]:
∂f
1
+ ξ · ∇f = − (f − f (eq) )
∂t
λ
Figure 1: A 2-D, 9-velocity lattice (Q9D2) model
librium distribution function. The 9-bit square lattice model, which is often referred to as the D2Q9
model (Figure 1), has been successfully used for simulating 2-D flows. In the D2Q9 model, we use eα to
denote the discrete velocity set and we have
e0 = 0,
eα = c(cos((a − 1)p/4), sin((a − 1)p/4))
forα = 1, 3, 5, 7,
√
eα = 2c(cos((a − 1)p/4), sin((a − 1)p/4))
forα = 2, 4, 6, 8
(3)
(1)
where c = δx/δt, δx and δt are the lattice constant
and the time step size, respectively. The equilibrium
distribution for D2Q9 model is of the following form
[23]
3
9
3
(eq)
2
fa = wa ρ + 2 eα · u + 4 (eα · u) − 2 u · u
c
2c
2c
(4)
where f (eq) is the equilibrium distribution function
(the Maxwell-Boltzmann distribution function), and
λ is the relaxation time.
To solve for f numerically, equation (1) is first discretised in the velocity space using a finite set of velocities {ξα } without affecting the conservation laws
[15, 24,25],
where wα is the weighting factor given by

(2)
 4/9, α = 0
1/9, α = 1, 3, 5, 7
wα =
(5)

In the above equation, fα (x, t) ≡ f (x, ξα , t) is the
1/36, α = 2, 4, 6, 8.
distribution function associated with the α-th dis(eq)
crete velocity ξα and fα is the corresponding equi- With the discretised velocity space, the density and
1
∂fa
+ ξa · ∇fa = − (fa − fa(eq) )
∂t
λ
2
momentum fluxes can be evaluated as
the LBE method. Two classes of boundaries are often
encountered in computational fluid dynamics: open
8
8
(eq)
fα =
(6) boundaries and the solid wall. The open boundaries
fα
ρ=
typically include lines (or planes) of symmetry, perik=0
k=0
odic cross-sections, infinity, and inlet and outlet. At
and
these boundaries, velocity or pressure is usually specified in the macroscopic description of fluid flow. Un8
8
eα fα =
(7) like solving the NS equations where the macroscopic
eα fα(eq)
ρu =
variables, their derivatives, or a well established conk=1
k=1
straint (such as the mass continuity for pressure dis√
The speed of sound in this model is cs = c/ 3 and tributions) can often be explicitly specified at boundthe equation of state is that of an ideal gas,
ary [28], in the LBE method, these conditions need
to be converted into distribution function f .
2
(8)
p = ρcs
Equation (2) can be further discretised in space and
time. The completely discretised form of equation 2 COMPUTATIONAL ASSESSMENT
(1), with the time step δt and space step eα δt, is:
In the computational cases to be presented and disfα (xi + eα δt, t + δt) − fα (xi , t)
cussed, the following questions are addressed:
1
(9) • Will the interpolation-based superposition
= − [fα (xi , t) − fα(eq) (xi , t)]
τ
scheme give the same accuracy as those of
where τ = λ/δt, and xi is a point in the discretised
bounce back if both conditions lead to converged
physical space. The above equation is the discrete
results?
lattice Boltzmann equation [20,21,26] with BGK approximation [24]. Equation (9) is usually solved in • How does the inlet/free-stream boundary condition impact the convergence of the solution and
the following two steps where ∼ represents the postthe quality of the flow field?
collision state.
The viscosity in the NS equation derived from
At the symmetric and periodic boundaries, the
equation (9) is
conditions for fα s can be given exactly. At the outν = (τ − 1/2)c2s δt
(10) let of a computational domain, fα s can usually be
approximated by simple extrapolation. In general,
This modification of the viscosity formally makes the the boundary condition for fα s on a solid wall with
LBGK scheme a second-order method for solving in- a known velocity can only be given approximately.
compressible flows [25,27]. The positivity of the vis- A popular approach is to employ the bounce-back
scheme [29–31]. It is intuitively derived from lattice
cosity requires that τ > 1/2.
It is noted that the collision step is completely lo- gas automata and has been extensively applied in latcal and the streaming step takes very little computa- tice Boltzamnn equation simulations. The same idea
tional effort. Equation (9) is explicit, easy to imple- for the solid wall has been directly extended to the
inlet boundary with known velocity to provide the
ment, and straightforward to parallelise.
required inlet condition for fα s [31–34].
Let us consider a horizontal flow at an inlet (Figure
1.2 Issues in the boundary condition
2). The first vertical grid line is at xA . The inlet is
treatment
arbitrarily xI which is between lattice node A at xA
Like in any other fluid flow computations, the numer- and located at node B at xB . The node B at xB is the
ical boundary condition is a very important issue in first fluid node next to the inlet. Using the bounce
3
based inlet condition results in slower convergence
towards steady or dynamically steady state and
causes stronger interaction between the inlet and
interior field. Such interaction may affect the longterm behaviour of the solution, especially at higher
Re. The interpolation-based superposition scheme
can reduce the impact of the boundary-interior
interaction on the unsteady development of the flow
field, improves the convergence rate, improves the
computational stability, and improves the quality of
the overall solution.
ACKNOWLEDGEMENTS
Figure 2: Schematic of lattice nodes at inlet
The work reported in this paper has been partially
supported by NASA Langley Research Center, with
David Rudy as the project monitor. The authors
thank Dr. Li-Shi Luo for many helpful discussions.
The work reported in this paper has been partially
supported by NASA Langley Research Center, with
David Rudy as the project monitor. The authors
thank Dr. Li-Shi Luo for many helpful discussions.
back on the link scheme [29], one typically requires
that the known velocity profile u(xI ) be specified at
xA + 12 e1 dt with Ω = 0.5, where Ω is the fraction of a
link in the fluid region intersected by inlet boundary,
Ω=
|xB − xI |
0 ≤Ω≤1
|xB − xA |
(11)
The standard bounce-back scheme for f˜ᾱ (xA ) at the REFERENCES
inlet xA gives:
1
1
3
+ 2wα ρ(xA + eā dt) 2 eᾱ · u(x(12)
i)
2
c
Alves, A.S. (Ed.) (1991) Discrete Models of Fluid
Dynamics, Figueira da Foz, Portugal, September
19–22, 1990, World Scientific, Singapore.
2
for ᾱ = 1, 2, 8 and α = 5, 6, 4. We note that
(
(
f˜ᾱ xA ) in equation (12) depends on f˜α xA + eᾱ δt) and
ρ(xA + 1/2eᾱ δt). Thus, it creates a mechanism for
the pressure waves to propagate along the eα direc(
tion through f˜α xA + eᾱ δt)and to reflect back to the
interior of computational domain along the eᾱ direction through f˜ᾱ (xA ).
Verheggen, T.M.M. (Ed.) (1992) ‘Numerical methods for the simulation of multi-phase and complex flow’, Proceedings of a Workshop held at
Koninklijke/Shell-Laboratorium, Amsterdam, The
Netherlands, May 30th June 1, 1990, Springer,
Berlin.
3
Lebowitz, J.L., Orszag, S.A. and Qian, Y.H. (Eds.)
(1995) J. Stat. Phys., Vol. 81, Nos. 1/2, pp.1–
538, Proceedings of the 5th International Conference
on Discrete Models for Fluid Mechanics, Princeton,
New Jersey, June 27–29, 1994.
4
Boghosian, B.M., Alexander, F.J. and Coveney, P.V.
(Eds.) (1997) Int. J. Mod. Phys., Vol. 8, No. 4,
pp.637–1011, Proceedings of 1996 Conference on
Discrete Models for Fluid Mechanics, Boston, Massachusetts, August 26–28, 1996.
5
Boghosian, B.M. (Ed.) (1998) Int. J. Mod. Phys. C,
Vol. 9, No. 8, pp.1123–1617, Proceedings of the 7th
f˜ᾱ (xA )
= f˜a (xA + eᾱ δt)
3 CONCLUSIONS
Computations based on the bounce-back based inlet
condition and interpolation-based superposition condition are performed for various cases. Bounce-back
4
International Conference on the Discrete Simulation
of Fluids, Oxford, UK, July 14–18, 1998.
6
7
8
Ohashi, H. and Chen, Y. (Eds.) (2000) Comp. Phys.
Commun., Vol. 129, Nos. 1–3, pp.1–291, Proceedings
of the 8th International Symposium on the Discrete
Simulation of Fluid Dynamics, Tokyo, Japan, July
28–30, 1999.
Lebowitz, J.L. (Ed.) (2002) J. Stat. Phys., Vol. 107,
Nos. 1–2, pp.1–598, Special issue based on the 9th
Annual International Conference on Discrete Simulation of Fluid Dynamics, Santa Fe, New Mexico,
August 21–24, 2000.
Coveney, P.V. and Succi, S. (Eds.) (2002) Phil.
Trans. R. Soc. Lond. A., Vol. 360, No. 1792, pp.1–
573, Discrete Modeling and Simulation of Fluid Dynamics, the 10th International Conference on Discrete Simulation of Fluid Dynamics, Cargese, July
2–6, 2001.
18
Fletcher, C.A.J. (1988) Computational Techniques
for Fluid Dynamics, Vol. I and II, Springer-Verlag,
New York.
19
Frisch, U., Hasslacher, B. and Pomeau, Y. (1986)
‘Lattice-gas automata for the Navier-Stokes equations’, Phys. Rev. Lett., Vol. 56, pp.1505–1508.
20
McNamara, G. and Zanetti, G. (1988) ‘Use of
the Boltzmann equation to simulate lattice-gas automata’, Phys. Rev. Lett., Vol. 61, pp.2332–2335.
21
Higuera,
F.J.
and
Jimenez,
J.
(1989)
‘Boltzmann approach to lattice gas simulations’, Europhys. Lett., Vol. 9, pp.663–
668.
22
Koelman, J.M.V.A. (1991) ‘A simple lattice Boltzmann scheme for Navier-Stokes fluid flow’, Europhys. Lett., Vol. 15, pp.603–607.
23
Qian, Y., d’Humieres, D. and Lallemand, P. (1992)
‘Recovery of Navier-Stokes equations using a latticegas Boltzmann method’, Europhys. Lett., Vol. 17,
pp.479–484.
24
Bhatnagar, P.L., Gross, E.P. and Krook, M. (1954)
‘A model for collision processes in gases, I. small
amplitude processes in charged and neutral onecomponent system’, Phys. Rev., Vol. 94, pp.511–525.
9
Monaco, R. and Preziosi, L. (1991) Fluid Dynamic
Applications of the Discrete Boltzmann Equation,
World Scientific, Singapore.
10
Chopard, B. and Droz, M. (1998) Cellular Automata
Modeling of Physical Systems, Cambridge University
Press, Cambridge, UK.
11
Wolf-Gladrow, D.A. (2000) Lattice-Gas Cellular Automata and Lattice Boltzmann Models, Springer,
Berlin.
25
Succi, S. (2001) The Lattice Boltzmann Equation
for Fluid Dynamics and Beyond, Oxford University
Press, New York.
He, X. and Luo, L.-S. (1997) ‘A priori derivation of
the lattice Boltzmann equation’, Phys. Rev. E, Vol.
55, pp.R6333–R6336.
26
Chen, H., Chen, S. and Matthaeus, W.H. (1992)
‘Recovery of the Navier-Stokes equations using a
lattice-gas Boltzmann method’, Phys. Rev. A., Vol.
45, pp.R5339–R5342.
12
13
Benzi, R., Succi, S. and Vergassola, M. (1992)
‘The lattice Boltzmann equation theory and applications’, Phys. Reports, Vol. 222, pp.45–197.
27
14
Qian, Y.H, Succi, S. and Orszag, S.A. (1996) ‘Recent advances in lattice Boltzmann computing’, in
Stauffer, D. (Ed.): Annual Reviews of Computational Physics III, World Scientific, Singapore.
He, X., Zou, Q., Luo, L.-S. and Dembo, M.
(1997) ‘Analytic solutions and analysis on non-slip
boundary condition for the lattice Boltzmann BGK
model’, J. Stat. Phys., Vol. 87, pp.115–136.
28
15
Chen, S. and Doolen GD. (1986) ‘Lattice Boltzmann
method for fluid flows’, Ann. Rev. Fluid. Mech., Vol.
30, pp.329–364.
Shyy, W., Liu, J. and Wright, J. (1994) ‘Pressurebased viscous flow computation using multiblock
overlapping curvilinear grid’, Numer. Heat Transf.,
Vol. 25, pp.39–59.
16
Luo, L-S. (2000) ‘The lattice-gas and lattice Boltzmann methods: past, present, and future’, in Wu,
J-H. and Zhu, Z-J. (Ed.): Proceedings of the International Conference on Applied Computational Fluid
Dynamics, Beijing, China, pp.52–83.
29
Ladd, A.J.C. (1994) ‘Numerical simulation of particular suspensions via a discretized Boltzmann equation. Part 1. Theoretical foundation’, J. Fluid Mech.,
Vol. 271, pp.285–309.
30
17
Peyret, R. and Taylor, T.D. (1983) Computational
Technique for Fluid Dynamics, Vol. II, SpringerVerlag, New York.
Ladd, A.J.C. (1994) ‘Numerical simulation of particular suspensions via a discretized Boltzmann equation. Part 2. Numerical results’, J. Fluid Mech., Vol.
271, pp.311–339.
5
31
Behrend, Q. (1995) ‘Solid-fluid boundaries in particle suspension simulation via the lattice Boltzmann
method’, Phys. Rev. E., Vol. 52, pp.1164–1175.
32
Cornubert, R., Dhumieres, D. and Levermore, D. ‘A
Knudsen layer theory for lattice gases’, Physica D,
Vol. 47, pp.291–297.
33
Ziegler, D.P. (1993) ‘Boundary conditions for lattice Boltzmann simulations’, J. Stat. Phys., Vol. 71,
pp.1171–1177.
34
Zou, Q. and He, X. (1997) ‘On pressure and velocity
boundary conditions for the lattice Boltzmann BGK
model’, Phys. Fluids, Vol. 9, pp.1591–1598.
35
Filippova, O. and Hänel, D. (2000) ‘A novel lattice
BGK approach for low mach number combustion’,
J. Comp. Phys., Vol. 158, pp.139–160.
36
Gruna, D.W. (1993) ‘Lattice methods for modeling
hydrodynamics’, PhD Dissertation, Colorado State
University.
6
Download