Conference PaperPDF Available

The lattice Boltzmann method in acoustics

Authors:

Abstract and Figures

The lattice Boltzmann method, a method based in kinetic theory and used for simulating fluid behaviour, is presented with particular regard to usage in acoustics. A point source method of generating acoustic waves in the computational domain is presented, and simple simulation results with this method are analysed. The simulated waves' transient wavefronts in one dimension are shown to agree with analytical solutions from acoustic theory. The phase velocity and absorption coefficients of the waves and their deviations from theory are analysed. Finally, the physical time and space steps relating simulation units with physical units are discussed and shown to limit acoustic usage of the method to small scales in time and space.
Content may be subject to copyright.
The lattice Boltzmann method in acoustics
Erlend Magnus Viggen
Acoustics Group, Department of Electronics and Telecommunications, NTNU, O.S. Bragstads Plass 2,
7034 Trondheim, Norway
(Dated: Presented at SSPA10 9 February 2010)
The lattice Boltzmann method, a method based in kinetic theory and used for simulating fluid
behaviour, is presented with particular regard to usage in acoustics. A point source method of
generating acoustic waves in the computational domain is presented, and simple simulation results
with this method are analysed. The simulated waves’ transient wavefronts in one dimension are
shown to agree with analytical solutions from acoustic theory. The phase velocity and absorption
coefficients of the waves and their deviations from theory are analysed. Finally, the physical time and
space steps relating simulation units with physical units are discussed and shown to limit acoustic
usage of the method to small scales in time and space.
I. INTRODUCTION
We can subdivide numerical methods in acoustics into
two main types:
Top-down methods which attempt to find a solution
to a set of differential equations by different meth-
ods of discretisation (e.g. finite difference and finite
element methods).
Bottom-up methods which compute microscale algo-
rithms which give rise to macroscale physical be-
haviour (e.g. cellular automata, the TLM method,
lattice gas automata, lattice Boltzmann method).
The lattice Boltzmann method is of the latter type,
being based in mesoscopic kinetic theory and used for
simulations of macroscopic behaviour. It can be seen
as either an evolution of the older method of lattice gas
automata, or as a discretisation of the Boltzmann equa-
tion, which is a fundament of kinetic theory. The method
works by tracking the movement and interaction of par-
ticle distributions inside the computational domain.
Since its beginning in 1988,
1
the method has been used
for a number of acoustically related purposes, includ-
ing simulations of acoustic streaming,
2,3
shock fronts,
4
particle motion in ultrasound fields,
5
flow simulations in
reed instrument mouthpieces,
6
and investigation of glot-
tal flow.
7
II. LATTICE BOLTZMANN BACKGROUND
A d-dimensional domain is discretised by an evenly
spaced lattice, defined by q different lattice vectors c
i
,
which also represent possible particle velocities. Each
node contains q different particle distributions f
i
(x, t),
each representing the density of particles at position x
and time t with velocity c
i
.
From these particle distributions, we can find each
node’s macroscopic quantities of density and momentum.
The density ρ is found by summing the particle distribu-
tions at a node,
ρ(x, t) =
X
i
f
i
(x, t), (1)
(a)D1Q3 (b)D2Q9
(c)D3Q19
FIG. 1. Velocity vectors in different lattices. Rest vectors
c
0
= 0 are not indicated.
while momentum is found by summing the individual mo-
menta of each particle distribution,
ρ(x, t)u(x, t) =
X
i
c
i
f
i
(x, t), (2)
where u is particle velocity.
A lattice is characterised by its number of dimensions
d and its number of velocity vectors q, and is denoted
by DdQq. Fig. 1 and Table I show the different velocity
vectors in the common D1Q3, D2Q9, and D3Q19 lattices.
The method’s time step update is described by the
lattice Boltzmann evolution equation,
f
i
(x + c
i
, t + 1) = f
i
(x, t) +
i
(x, t). (3)
This equation states that incoming particle distributions
f
i
(x, t) are streamed to neighbouring nodes in their di-
rection of velocity, after being modified by the collision
33rd Scandinavian Symposium on Physical Acoustics The lattice Boltzmann method in acoustics 1
TABLE I. Basic velocity vectors and their weighting factors
for the three lattices used in this article. The complete set of
vectors is all possible spatial permutations of the basic vectors
given here.
(a) D1Q3
c
i
t
i
(0) 2/3
(±1) 1/6
(b) D2Q9
c
i
t
i
(0, 0) 4/9
(±1, 0) 1/9
(±1, ±1) 1/36
(c) D3Q19
c
i
t
i
(0, 0, 0) 1/3
(±1, 0, 0) 1/18
(±1, ±1, 0) 1/36
operator
i
(x, t). This collision operator represents col-
lisions by redistributing particles between distributions
in such a way that conservation of mass and momentum
is upheld.
The simplest and most common collision operator is
the lattice Bhatnagar-Gross-Krook (LBGK) operator,
i
=
1
τ
[f
i
f
eq
i
] , (4)
which is based on relaxation to an equilibrium distri-
bution f
eq
i
(x, t) with a relaxation time τ . We have here
simplified our notation by considering (x, t) implicit. The
equilibrium distribution is given by
f
eq
i
= ρt
i
1 +
u · c
i
c
2
s
+
(u · c
i
)
2
2c
4
s
u
2
2c
2
s
, (5)
which is the particle distribution which maximises en-
tropy, in analogy with the Maxwell-Boltzmann distribu-
tion in gases. The equilibrium distribution is constructed
from the node’s pre-collision values of ρ and u. c
s
is the
lattice speed of sound, which is equal to 1/
3 for the lat-
tices given in Table I and Figure 1, while t
i
is a weighting
factor which ensures that the lattices satisfy certain sym-
metry properties necessary for isotropic behaviour.
8
The
values of t
i
are given in Table I for each lattice.
The macroscopic behaviour of the lattice Boltzmann
method can be found by a procedure known as Chapman-
Enskog analysis, where a multiple-scale analysis of the
Taylor expansion of equation 3 is performed.
8,9
This anal-
ysis is performed under the assumptions of low excursions
from equilibrium (all terms of order Ma
3
or higher are ne-
glected), and the fluid being an isothermal perfect gas.
It results in the equation of continuity and the compress-
ible Navier-Stokes equation, with kinematic shear and
bulk viscosities ν and ν
0
given directly by the relaxation
time τ as
ν = c
2
s
τ
1
2
, (6a)
ν
0
=
2
3
ν. (6b)
Because of the assumptions taken, these results are only
valid in the isothermal limit of low Mach number.
Since the method results in a macroscopic behaviour
consistent with the compressible Navier-Stokes equation
under these constraints it should be possible to use for
simulations of acoustics, since acoustic particle velocities
tend to be very small compared to the speed of sound,
and since the isothermal perfect gas approximation holds
for small acoustic compressions and rarefactions.
In fluid mechanics, the lattice Boltzmann method has
largely been used to simulate incompressible flow. It has
therefore been associated with incompressible flow simu-
lations, and there has unfortunately been relatively little
research into wave propagation with the method.
III. POINT SOURCE
The author’s method of researching acoustic wave
propagation with the lattice Boltzmann method has been
to perform benchmark comparisons with acoustic theory,
where acoustic behaviour with known theoretical solu-
tions is simulated with the lattice Boltzmann method.
Since wave propagation usually involves some sort of
wave source, it is necessary to use a point source to per-
form these kinds of simulation. Unfortunately, no arti-
cles describing point sources for the lattice Boltzmann
method with the BGK collision operator could be found.
Only related concepts have been developed so far.
3,10
The initial attempt by the author at creating a point
source for the lattice Boltzmann method works by defin-
ing one or more nodes as source nodes, where the particle
density ρ is forced to oscillate around an equilibrium den-
sity ρ
0
,
ρ = ρ
0
+ ρ
src
sin
2π
T
t
. (7)
In the simplest kind of free-field simulation, a point
source is placed in the middle of a periodic 1D, 2D, or
3D system at equilibrium and is left to propagate waves
outwards until the first wavefront approaches the bound-
ary. The waves are then measured as a function of dis-
tance from the point source. The 2D system is sketched
in Figure 2, and results in one to three dimensions are
shown in Figure 3.
x
y
r
FIG. 2. Sketch for the two-dimensional case of the periodic
system used in free-field simulations.
In Figure 3, the numerical results have been matched
with modified (i.e. scaled and phase-shifted) steady-state
analytical solutions of the system.
11
As can be seen, there
is a very good visual match between the wave shape in
33rd Scandinavian Symposium on Physical Acoustics The lattice Boltzmann method in acoustics 2
r
ρ/ρ
0
0
20
40 60 80 100 120
140
4
2
0
2
4
×10
7
(a)D1Q3 lattice
r
r
ρ/ρ
0
020406080
100
120 140
1
0
1
×10
7
(b)D2Q9 lattice
r
rρ/ρ
0
020406080
100
120 140
5
0
5
×10
8
(c)D3Q19 lattice
FIG. 3. Non-steady-state lattice Boltzmann solution of the radial field from a free-field point source in a viscous medium at
t = 200 (circles), along with steady-state analytical solution of the same (lines), in one-, two- and three-dimensional lattices
with τ = 0.75. The point source used has a period T = 25 and an amplitude ρ
src
0
= 10
6
. Note that in the two- and
three-dimensional lattices, the solutions are scaled with
r and r respectively, for visibility.
theory and simulation, and the rate of viscous damping
seems correct.
Some problems with the point source were also found
from these simulations. First, the radiated waves from
the source do not have the expected amplitude compared
with the source’s amplitude. Also, in two and three di-
mensions (Figures 3(b) and 3(c)), there is some unex-
pected chaotic behaviour near the source the neigh-
bouring points are out of phase with the source, resulting
in a propagated wave which has been phase-shifted com-
pared to the source. These factors are the reasons for
the aforementioned scaling and phase shift when match-
ing analytical and simulated results.
The peaks which are visible around the first wavefronts
around r = 116 in Figure 3 are not errors. When sound is
radiated into a viscous fluid, a slowly decaying transient
occurs around the first wavefront. This was described
analytically in 1D by Blackstock in 1967,
12
and the sim-
ulated wavefront is compared with his analytical solu-
tion in Figure 4. As we can see, the agreement is very
good. This illustrates the power of the lattice Boltzmann
method to naturally simulate acoustic behaviour beyond
33rd Scandinavian Symposium on Physical Acoustics The lattice Boltzmann method in acoustics 3
r
ρ/ρ
0
80 100 120
140
4
2
0
2
4
6
8
×10
8
FIG. 4. First wavefront from Fig. 3(a) (circles), with ana-
lytical solution (Blackstock (1967)) of such a wavefront for a
viscous medium (line).
the standard wave equation.
IV. DEVIATIONS IN PHASE VELOCITY AND
ABSORPTION
The point source allows us to examine if spatially
damped waves (i.e. waves which originate at a point and
are affected by viscous absorption) in the lattice Boltz-
mann method behave as theoretically expected. By set-
ting up a one-dimensional simulation such as the one de-
scribed in the previous section we can measure the phase
velocity and absorption coefficient of the outgoing waves.
An acoustic wave where the absorption is only affected
by the viscous relaxation time
τ
S
=
1
c
2
s
4
3
ν + ν
0
= 2τ 1 (8)
can be shown to have a phase velocity of
c
p
= c
s
1 +
3
8
(ωτ
S
)
2
(9)
and an absorption coefficient of
α =
ω
2c
s
(ωτ
S
) (10)
in the limit of ωτ
S
1.
11
If we define a characteristic number
K =
ωτ
S
2π
(11)
we see that the phase velocity c
p
should be constant if
K is held constant. We also see that the quantity αT /K
always should be constant.
Figure 5 shows the measured phase velocity as a func-
tion of λ
2
in four cases where K was held constant while
T was varied, while Figure 6 shows αT/K as a function
of λ
2
in the same cases. With both the phase velocity
and absorption, there is a deviation from theory of order
O(k
2
+ K
2
), so that the simulations agree with theory in
the limit k 0, K 0.
The results of a regression analysis in λ
2
and K
2
on
the results can be used to predict the values of c
p
and
λ
2
c
p
01
2
3
×10
3
0.575
0.576
0.577
0.578
0.579
FIG. 5. Measured values of c
p
(gray circles), with predictions
based on a polynomial regression (black lines) for four dif-
ferent characteristic numbers. In ascending order, these lines
represent K = 1 × 10
3
, 5 × 10
3
, 8 × 10
3
, 1 × 10
2
.
λ
2
αT /K
0
1
23
×10
3
34
34.2
34.4
34.6
34.8
FIG. 6. Measured values of αT /K (gray circles), with predic-
tions based on a polynomial regression (black lines). In de-
scending order, these lines represent K = 1 ×10
3
, 5 ×10
3
,
8 × 10
3
, 1 × 10
2
.
α a priori with an accuracy of respectively 0.001 55 %
and 0.0176 % compared to the measurements performed
here. The lines in Figures 5 and 6 are predictions based
on these regressions.
V. UNIT CONSIDERATIONS
We have hitherto used lattice units, where the space
and time steps have been normalised to 1. The lattice
units can be related to a physical system through the
physical time step t and physical space step x. The
speed of sound and viscosity are related in lattice and
physical units through
c
s,phy
= c
s,lat
x
t
, (12a)
ν
phy
= ν
lat
x
2
t
. (12b)
33rd Scandinavian Symposium on Physical Acoustics The lattice Boltzmann method in acoustics 4
Inserting for the known lattice speed of sound and vis-
cosity and solving for t and x, we find
t =
ν
phy
c
2
s,phy
(τ 1/2)
, (13a)
x =
ν
phy
3
c
s,phy
(τ 1/2)
. (13b)
Inserting physical values for air at 20
C, this becomes
t =
1.30 × 10
10
τ 1/2
s, (14a)
x =
7.73 × 10
8
τ 1/2
m, (14b)
which shows that the time and space steps are restricted
to orders of respectively ns and µm, since τ 1/2 can-
not be arbitrarily close to zero for accuracy and stability
reasons
13
.
This problem does not occur when using the lattice
Boltzmann method to simulate incompressible flow, since
in that case the speed of sound is not a physically rele-
vant quantity. This affords considerably more freedom in
choosing units.
14
VI. CONCLUSION
The lattice Boltzmann method has several desirable
properties, in particular an inherent simplicity. The al-
gorithm is easy to implement and use, and complex ge-
ometries of no-slip hard walls can be implemented simply
by letting wall nodes bounce incoming particles back to
their point of origin. Since each time step update is local
to each node, the computational domain can be divided
into subdomains handled by different processors, and it
is possible to achieve a near-linear speedup in number of
processors.
15
It has been shown here that waves simulated with the
lattice Boltzmann method suffer from deviations from
theory of order O(k
2
+ (ωτ
S
)
2
) in phase velocity and
absorption, at least with the BGK collision operator. It
may be possible to solve this problem by changing to a
more advanced collision operator or by using an extended
lattice.
Unfortunately, acoustic use of the lattice Boltzmann
method seems to be limited to very high frequencies and
very small geometries, limiting the area of usage to ul-
trasound microacoustics in fluids. Hopefully this can be
rectified, but the manner in which this might be done is
not yet clear to the author.
1
G. McNamara and G. Zanetti, “Use of the Boltzmann
Equation to Simulate Lattice-Gas Automata”, Physical
Review Letters 61, 2332–2335 (1988).
2
D. Haydock and J. M. Yeomans, “Lattice Boltzmann sim-
ulations of acoustic streaming”, J. Phys. A 34, 5201–5213
(2001).
3
D. Haydock and J. M. Yeomans, “Lattice Boltzmann simu-
lations of attenuation-driven acoustic streaming”, J. Phys.
A 36, 5683–5694 (2003).
4
J. M. Buick, C. L. Buckley, C. A. Greated, and J. Gilbert,
“Lattice Boltzmann BGK simulation of nonlinear sound
waves: the development of a shock front”, Journal of
Physics A 33, 3917–3928 (2000).
5
J. A. Cosgrove, J. M. Buick, D. M. Campbell, and C. A.
Greated, “Numerical simulation of particle motion in an
ultrasound field using the lattice Boltzmann model”, Ul-
trasonics 43, 21–25 (2004).
6
A. R. da Silva, G. P. Scavone, and M. van Walstijn, “Nu-
merical simulations of fluid-structure interactions in single-
reed mouthpieces”, J. Acous. Soc. Am. 122, 1798–1809
(2007).
7
B. R. Kucinschi, A. A. Afjeh, and R. C. Scherer, “On the
application of the lattice Boltzmann method to the inves-
tigation of glottal flow”, J. Acous. Soc. Am. 124, 523–534
(2008).
8
J. Latt, “Hydrodynamic limit of lattice Boltzmann equa-
tions”, Ph.D. thesis, University of Geneva (2007).
9
E. M. Viggen, “The lattice Boltzmann method with appli-
cations in acoustics”, Master’s thesis, Norwegian Univer-
sity of Science and Technology (2009).
10
B. Chopard, P. O. Luthi, and J.-F. Wagen, “Lattice
Boltzmann method for wave propagation in urban micro-
cells”, IEE Proc.-Microw. Antennas Propag. 144, 251–255
(1997).
11
L. E. Kinsler, A. R. Frey, A. B. Coppens, and J. V. Sanders,
Fundamentals of acoustics, 4th edition (John Wiley &
Sons) (2000).
12
D. T. Blackstock, “Transient solution for sound radiated
into a viscous fluid”, J. Acous. Soc. Am. 41, 1312–1319
(1967).
13
B. Chopard, P. O. Luthi, and A. Masselot, “Cellular Au-
tomata and Lattice Boltzmann Techniques: An Approach
to Model and Simulate Complex Systems”, Advances in
Complex Systems 5, 103–246 (2002).
14
J. Latt, “Choice of units in lattice Boltzmann simulations”,
Freely available online at http://lbmethod.org/_media/
howtos:lbunits.pdf.
15
“Palabos benchmarks”, URL http://www.lbmethod.org/
palabos/benchmarks.html.
33rd Scandinavian Symposium on Physical Acoustics The lattice Boltzmann method in acoustics 5
... Viggen [43] introduces the point source method that imposes an oscillatory density value in a source cell (lattice node) with a given frequency. A low viscosity degrades the solution (relaxation time near 0.5 in an SRT model). ...
... Point source method[42,43] in a square domain, pressure field over the diagonal ( = 1.9999): (a) Regularized; (b) Entropic. ...
Article
Full-text available
The Lattice Boltzmann Method (LBM) can be applied to several fluid dynamic problems in the time domain. This numerical method indirectly solves the Navier-Stokes equations in a weakly compressible limit that allows acoustic wave propagation. This work presents a systematic literature review concerning the application of the LBM in acoustics. Applications found in the literature are classified and presented in different categories, including wave theory, boundary conditions, sound absorption materials, aeroacoustics, and musical acoustics. The increasing amount of research in recent years about aeroacoustics is remarkable, thanks to the intrinsically coupled treatment of the acoustical field and the mean flow, the potential of studying different wave phenomena such as diffraction and scattering, the easy way to model complex geometric boundaries in 2D and 3D, and finally thanks to the increasing available computational power. Some examples were included to illustrate the LBM capabilities to simulate sound wave phenomena, including point source modeling, diffraction and interference of sound waves, jet noise, and edge noise. This work will give a retrospective of the research developed in the past and a perspective on how this numerical method might evolve in the acoustical field.
... In the second numerical test an acoustic wave is temporary generated by a point source at x = −1. We follow the simple approach given in [25]. The populations at the corresponding source node are computed by the equilibrium distribution (3) determined by velocity u(0, t) = 0 and an oscillating density according to ...
Article
This article deals with artificial boundaries which you encounter when a large spatial domain is confined to a smaller computational domain. Such an artificial boundary condition should not preferably interact with the fluid at all. Standard boundary conditions, e.g., a pressure or velocity condition, result in unphysical reflections. So far, existing artificial boundary conditions for the lattice Boltzmann method (LBM) are transferred from macroscopic formulations. In this work we propose novel discrete artificial boundary conditions (ABCs) which are tailored on the LBM's mesoscopic level. They are derived directly for the chosen LBM with the aim of higher accuracy. We describe the idea of discrete ABCs in a three velocity (D1Q3) model governing the Navier-Stokes equations in one dimen-sion. We emphasize the fact that our approach has the approved potential to be generalized to higher dimensions and general collision models. Numerical results fi-nally demonstrate the superiority of our new boundary condition in terms of accuracy compared to previously used ABCs.
... In fact, the solid lines in Fig. 5 represent analytical expressions [38][39][40]; we fit the analytical values to the simulation results. In the analytical expression, we use the spatial absorption coefficient α s = ω 2 τ s /2c s , where the viscous relaxation time τ s = (4ν/3 + ν b )/c 2 s = t (2τ − 1) is defined by the kinematic shear viscosity ν = tc 2 s (2τ − 1)/2 and bulk viscosity ν b = 2ν/3. ...
Article
The usual lattice-Boltzmann schemes for fluid flow simulations operate with square and cubic lattices. Instead of relying on square lattices it is possible to use rectangular and orthorombic lattices as well. Schemes using rectangular lattices can be constructed in several ways. Here we construct a rectangular scheme, with the BGK collision operator, by introducing 2 additional discrete velocities into the standard D2Q9 stencil and show how the same procedure can be applied in three dimensions by extending the D3Q19 stencil. The weights and scaling factors for the new stencils are found as the solutions of the well-known Hermite quadrature problem, assuring isotropy of the lattice tensors up to rank four (Philippi et al., Phys. Rev. E 73(5):056702, 2006) This isotropy is a necessary and sufficient condition for assuring the same second order accuracy of lattice-Boltzmann equation with respect to the Navier–Stokes hydrodynamic equations that is found with the standard D2Q9 and D3Q19 stencils. The numerical validation is done, in the two-dimensional case, by using the new rectangular scheme with D2R11 stencil for simulating the Taylor–Green vortex decay. The D3R23 stencil is numerically validated with three-dimensional simulations of cylindrical sound waves propagating from a point source.
... The BGK operator allows no freedom to affect this, so addressing this problem would require an alternate method. On the other hand, the actual behaviour in the infinite resolution limit k → 0 has been quantified in Table 1, and the regularity of the deviations makes it quite possible to predict LB phase velocities and absorption coefficients a priori [11]. ...
Article
Full-text available
Acoustic wave propagation in lattice Boltzmann Bhatnagar-Gross-Krook simulations may be analysed using a linearization method. This method has been used in the past to study the propagation of waves that are viscously damped in time, and is here extended to also study waves that are viscously damped in space. Its validity is verified against simulations, and the results are compared with theoretical expressions. It is found in the infinite resolution limit k→0 that the absorption coefficients and phase differences between density and velocity waves match theoretical expressions for small values of ωτ(ν), the characteristic number for viscous acoustic damping. However, the phase velocities and amplitude ratios between the waves increase incorrectly with (ωτ(ν))(2), and agree with theory only in the inviscid limit k→0, ωτ(ν)→0. The actual behaviour of simulated plane waves in the infinite resolution limit is quantified.
Article
Full-text available
Flow control of a low-aspect-ratio flat-plate heaving wing at an average angle of attack of 1010^{\circ } by a steady-blowing jet is numerically studied by using a feedback immersed boundary–lattice Boltzmann method. Blowing jets at the leading edge, mid-chord and trailing edge are considered. The wing enjoys the highest lift production with the trailing-edge downstream blowing jet, which improves the average lift by 50.0 % at Re=1000Re = 1000 and 22.9 % at Re=5000Re = 5000 through the enhancement of the tip vortex circulation caused by the increase in the mass flux of the shear layer at the wing tips. This increase in mass flux decreases as Re increases from 1000 to 5000 due to its self-limiting mechanism. A mid-chord vertical blowing jet induces a middle vortex which enhances the lift production but the enhancement is smaller than that of trailing-edge downstream blowing jet. Other jet arrangements do not significantly increase the lift coefficient, but the mid-chord upstream blowing jet experiences a significant reduction in the drag coefficient, leading to an increase of 50.6 % in the average lift-to-drag ratio. The effectiveness of the flow control is not significantly affected by the aspect ratio.
Article
Full-text available
We study the diffusivity of a small particle immersed in a square box filled with a non-ideal multicomponent fluid in the presence of thermal fluctuations. Our approach is based on the numerical integration of fluctuating lattice Boltzmann models (LBM) for multicomponent mixtures. At changing the wettability on the particle's surface, we measure the mean square displacement (MSD) and compare with the prediction of the Stokes-Einstein theory. Two main set-ups are tested, involving periodic boundary conditions and wall boundary conditions realized on the computational box. We find that full periodic boundary conditions give rise to random advection after millions of lattice Boltzmann time steps, while this effect is mitigated in the presence of wall boundary conditions. The matching with the Stokes-Einstein relation is therefore guaranteed when we use the appropriate frictional properties measured in the presence of confinement. Our results will help the exploration of nanoscale applications with multicomponent fluids using LBM in the presence of thermal fluctuations.
Article
Full-text available
A hybrid Lattice Boltzmann(LB)-Finite Difference(FD) numerical scheme for the simulation of reacting flows at low Mach numbers is presented. The FD solver is used to model the energy and species fields while the LB model computes the flow field. The proposed LB solver is a modified version of the classical iso-thermal weakly compressible LB scheme with the hydrodynamic pressure as its zeroth-order moment instead of density, recovering the well-known low Mach number approximation for thermo-compressible flows. The proposed numerical approach is used to model a variety of test-cases ranging from 1-D to 3-D configurations, involving premixed and non-premixed flames. In all cases results obtained by this solver are shown to agree very well with reference data.
Preprint
In this paper, we develop an efficient lattice Boltzmann (LB) model for simulating immiscible incompressible N-phase flows (N2)(N \geq 2) based on the Cahn-Hilliard phase field theory. In order to facilitate the design of LB model and reduce the calculation of the gradient term, the governing equations of the N-phase system are reformulated, and they satisfy the conservation of mass, momentum and the second law of thermodynamics. In the present model, (N1)(N-1) LB equations are employed to capture the interface, and another LB equation is used to solve the Navier-Stokes (N-S) equations, where a new distribution function for the total force is delicately designed to reduce the calculation of the gradient term. The developed model is first validated by two classical benchmark problems, including the tests of static droplets and the spreading of a liquid lens, the simulation results show that the current LB model is accurate and efficient for simulating incompressible N-phase fluid flows. To further demonstrate the capability of the LB model, two numerical simulations, including dynamics of droplet collision for four fluid phases and dynamics of droplets and interfaces for five fluid phases, are performed to test the developed model. The results show that the present model can successfully handle complex interactions among N (N2N \geq 2) immiscible incompressible flows.
Article
Fully three-dimensional, time-dependent, direct simulations of the non-ideal Navier-Stokes equations for a two-component fluid shed light into the mechanism which inhibits droplet breakup in step emulsifiers below a critical threshold of the width-to-height (w/h) ratio of the microfluidic nozzle. Below w/h ∼ 2.6, the simulations provide evidence of a smooth topological transition of the fluid from the confined rectangular channel geometry to an isotropic (spherical) expansion of the fluid downstream the nozzle step. Above such threshold, the transition from the inner to the outer space involves a series of dynamical rearrangements which keep the free surface in mechanical balance. Such rearrangements also induce a backflow of the ambient fluid which, in turn, leads to jet pinching and ultimately to its rupture, namely, droplet formation. The simulations show remarkable agreement with the experimental value of the threshold, which is found around w/h ∼ 2.56.
Thesis
Full-text available
The lattice Boltzmann method has been widely used as a solver for incompressible flow, though it is not restricted to this application. More generally, it can be used as a compressible Navier-Stokes solver, albeit with a restriction that the Mach number is low. While that restriction may seem strict, it does not hinder the application of the method to the simulation of sound waves, for which the Mach numbers are generally very low. Even sound waves with strong nonlinear effects can be captured well. Despite this, the method has not been as widely used for problems where acoustic phenomena are involved as it has been for incompressible problems. The research presented this thesis goes into three different aspects of lattice Boltzmann acoustics. Firstly, linearisation analyses are used to derive and compare the sound propagation properties of the lattice Boltzmann equation and comparable fluid models for both free and forced waves. The propagation properties of the fully discrete lattice Boltzmann equation are shown to converge at second order towards those of the discrete-velocity Boltzmann equation, which itself predicts the same lowest-order absorption but different dispersion to the other fluid models. Secondly, it is shown how multipole sound sources can be created mesoscopically by adding a particle source term to the Boltzmann equation. This method is straightforwardly extended to the lattice Boltzmann method by discretisation. The results of lattice Boltzmann simulations of monopole, dipole, and quadrupole point sources are shown to agree very well with the combined predictions of this multipole method and the linearisation analysis. The exception to this agreement is the immediate vicinity of the point source, where the singularity in the analytical solution cannot be reproduced numerically. Thirdly, an extended lattice Boltzmann model is described. This model alters the equilibrium distribution to reproduce variable equations of state while remaining simple to implement and efficient to run. To compensate for an unphysical bulk viscosity, the extended model contains a bulk viscosity correction term. It is shown that all equilibrium distributions that allow variable equations of state must be identical for the one-dimensional D1Q3 velocity set. Using such a D1Q3 velocity set and an isentropic equation of state, both mechanisms of nonlinear acoustics are captured successfully in a simulation, improving on previous isothermal simulations where only one mechanism could be captured. In addition, the effect of molecular relaxation on sound propagation is simulated using a model equation of state. Though the particular implementation used is not completely stable, the results agree well with theory.
Thesis
Full-text available
An introduction is given to the lattice Boltzmann method and its background, with a view towards acoustic applications of the method. To make a larger range of acoustic applications possible, a point source method is proposed. This point source is applied to simulate cylindrical waves and plane waves, and is shown to give a very good numerical result compared with analytic solutions of viscously damped cylindrical and plane waves. Good results are found for simulations of Doppler effect, diffraction, and viscously damped standing waves. It is concluded that the lattice Boltzmann method could be suitable for simulating acoustics in complex flows, at ultrasound frequencies and very small spatial scales. The lattice Boltzmann method is shown to be unfeasible at lower frequencies or for larger systems.
Article
Full-text available
The application of the lattice Boltzmann model to simulating nonlinear propagative acoustic waves is considered. The lattice Boltzmann model, and its application to the study of nonlinear sound propagation, are discussed. Lattice Boltzmann simulations of the development of a shock front are performed when a sound wave is emitted from a high-amplitude sinusoidal source. For a number of parameters, representing different physical situations, the wave development is compared with inviscid shock theory and with the solution of Burgers' equation for a fully viscous fluid. The simulations show good agreement with Burgers' equation and with the inviscid theory when propagation at high Reynolds number is considered. These results suggest that the lattice Boltzmann model is a useful technique for studying a range of problems in nonlinear acoustics.
Article
Full-text available
The production of voice is directly related to the vibration of the vocal folds, which is generated by the interaction between the glottal flow and the tissue of the vocal folds. In the current study, the aerodynamics of the symmetric glottis is investigated numerically for a number of static configurations. The numerical investigation is based on the lattice Boltzmann method (LBM), which is an alternative approach within computational fluid dynamics. Compared to the traditional Navier-Stokes computational fluid dynamics methods, the LBM is relatively easy to implement and can deal with complex geometries without requiring a dedicated grid generator. The multiple relaxation time model was used to improve the numerical stability. The results obtained with LBM were compared to the results provided by a traditional Navier-Stokes solver and experimental data. It was shown that LBM results are satisfactory for all the investigated cases.
Article
Full-text available
We discuss the cellular automata approach and its extensions, the lattice Boltzmann and multiparticle methods. The potential of these techniques is demonstrated in the case of modeling complex systems. In particular, we consider applications taken from various fields of physics, such as reaction-diffusion systems, pattern formation phenomena, fluid flows, fracture processes and road traffic models.
Article
Sinusoidal vibration of a plane at the edge x = 0 of a viscous fluid causes sound to be radiated into the fluid. The motion begins at time t = 0. Of primary interest is the transient signal. The wave equation, which in this case is of third order because of the presence of viscosity, is solved by changing the form of the viscosity term slightly. The approximation made is justified as long as αλ≪1, where αλ is the dimensionless attenuation coefficient. The altered equation is reducible to the diffusionequation, whose solutions are well known. One of these solutions is adapted for the present problem. It turns out that the transient part of this solution can be represented in terms of the error function of complex argument, a tabulated function. The transient proves to be significant in the vicinity of the main wave front x=c 0 l. When the wave is first generated, the transient is very weak, but it grows in importance as the wave travels away. Near the point x = 1/α the transient has its maximum amplitude. The diffusive character of the transient is shown by the fact that if the transient signal is integrated from t = 0 to t = ∞, the integral never vanishes, not even at x = ∝. Improved solutions are also discussed.
Article
We show that lattice Boltzmann simulations can be used to model the attenuation-driven acoustic streaming produced by a travelling wave. Comparisons are made to analytical results and to the streaming pattern produced by an imposed body force approximating the Reynolds stresses. We predict the streaming patterns around a porous material in an attenuating acoustic field.
Article
Lattice Boltzmann simulations are used to model the acoustic streaming produced by the interaction of an acoustic wave with a boundary. Comparison is made with analytic results for Rayleigh streaming in the appropriate limits and we show how deviations from those limits affect the streaming. Acoustic streaming patterns around a cylinder and between two plates of finite length are then predicted.
Article
An analysis of the lattice Boltzmann (LB) method is conducted, and various conclusions are drawn on how to exploit this method for the numerical resolution of the Navier-Stokes equation. A novel LB model is introduced, first for the simulation of advection-diffusion problems, and then for the resolution of the Navier-Stokes equation. The latter model, presented under the name of "regularized lattice Boltzmann", is shown to substantially increase the stability and accuracy of LB models in numerical simulaiton. The model is furthermore found to be innovative due to the fact that it possesses an accurate dimensionless formulation in terms of macroscopic variables. Based on this observation, the regularized model is investigated to address various challenges of LB, such as the implementaiton of boundary conditions and spatially refined grids.
Article
An alternative to the lattice-gas automata (LGA) for the investigation of hydrodynamic properties is proposed, i.e., the lattice gas is modeled with a Boltzmann equation. It is found that this approach completely eliminates the statistical noise connected with the usual lattice-gas simulations and thus permits simulations that demand much less computer time. This technique is estimated to be more efficient that the LGA for intermediate to low Reynolds numbers (less than about 100).