Вы находитесь на странице: 1из 12

Computers and Fluids 172 (2018) 340–351

Contents lists available at ScienceDirect

Computers and Fluids


journal homepage: www.elsevier.com/locate/compfluid

Sediment transport in turbulent flows with the lattice Boltzmann


method
Helen E. Morrison∗, Alfred Leder
Chair of Fluid Mechanics, University of Rostock, Albert-Einstein-Str. 2, Rostock 18059, Germany

a r t i c l e i n f o a b s t r a c t

Article history: The burial and scour of objects at the bottom of the ocean is governed by a range of different factors
Received 28 October 2017 and is thus a complex system to simulate with numerical methods. In this work, we present a sediment
Revised 1 February 2018
transport model based on the lattice Boltzmann method which is capable of predicting the influence of a
Accepted 9 April 2018
unidirectional flow field on the development of the sand bed in the vicinity of arbitrarily shaped objects,
Available online 10 April 2018
even under turbulent conditions and relatively low resolution. The underlying lattice Boltzmann method
Keywords: for the fluid phase of the simulation is governed by the three-dimensional entropic multi-relaxation time
Lattice Boltzmann method collision model and further makes use of appropriate three-dimensional grid refinement and off-lattice
Sediment transport boundaries. The corresponding framework was implemented in the open-source Palabos library and en-
Turbulent flows ables accurate turbulent flow simulations around arbitrarily shaped objects without the need to tune any
Scour specific model parameters. For the simulation of the sediment transport, the advection–diffusion equa-
Sedimentation
tion is solved via the lattice Boltzmann method with an adapted version of the entropic multi-relaxation
time collision model for a three-dimensional lattice with seven discrete lattice velocities (D3Q7). The pre-
sented sediment transport model thus inherits the unconditional numerical stability and the simplicity
of the entropic multi-relaxation time collision model. Furthermore, erosion and sedimentation processes
are included based on the critical Shields parameter, i.e. on the wall shear stress. An initial simulation of
the flow and sediment transport around a horizontally bedded finite cylinder shows that the presented
model is generally able to capture the major sediment processes which govern the development of the
sand bed.
© 2018 Elsevier Ltd. All rights reserved.

1. Introduction tremely challenging though, as the flow around the objects is char-
acterised by turbulent structures. These correspondingly affect the
The understanding of sediment transport processes in the vicin- erosion and sedimentation of the sand bed, which also needs to
ity of objects is important for a variety of fields. When it comes be simulated appropriately. In the context of Navier–Stokes solvers,
to designing off-shore wind structures or pipelines for example, several such numerical models have thus far been introduced in
the scouring of the objects due to their respective shapes should the literature. These very often deal with the sediment trans-
be minimized as much as possible in order to prevent significant port around vertical cylinders [e.g. [2–5]], but also with the sed-
damage to the structures. The shape of the objects usually results iment transport around horizontally bedded finite cylinders such
in typical sand bed structures which could therefore also be used as mines for example [6] or half-buried spheres [7].
to characterise objects buried at the bottom of the ocean. An in- Recently though, the lattice Boltzmann method (LBM) has also
sight into the processes which govern the sediment transport in become a viable alternative for modelling complex turbulent flows.
the vicinity of mines for example is given by Wilkens and Richard- Beside the fact that no complicated mesh generation is needed and
son [1]. the method exhibits excellent scalability on parallel systems, it is
An important tool towards determining and understanding also fairly simple to implement additional physical models [8]. Fur-
these processes is numerical simulation. Such simulations under thermore, several collision models have recently been introduced
the conditions at the bottom of the ocean or river beds are ex- which enable numerically stable and accurate turbulent flow sim-
ulations without the need of explicit turbulence models [9–13].
Several studies have previously also dealt with simulating sed-

Corresponding author. iment transport with the lattice Boltzmann method. Masselot and
E-mail addresses: helen.morrison@uni-rostock.de, helen_morrison@web.de (H.E. Chopard [14] and Dupuis and Chopard [15] for example described
Morrison).

https://doi.org/10.1016/j.compfluid.2018.04.015
0045-7930/© 2018 Elsevier Ltd. All rights reserved.
H.E. Morrison, A. Leder / Computers and Fluids 172 (2018) 340–351 341

the transport of snow and sand, respectively, using a combined lat- lattice specific constants. In the hydrodynamic limit, the Navier–
tice Boltzmann and cellular automata approach. Parmigiani et al. Stokes equations are then recovered via the Chapman–Enskog ex-
[16] on the other hand used a large eddy simulation (LES) ap- pansion with the kinematic viscosity given by
proach to LBM to simulate the fluid flow and included sediment  1

via an LBM description of the advection-diffusion equation. Fur- ν = cs2 τ − . (4)
2
thermore, Rettinger et al. [17] combined an LBM fluid simulation
Unfortunately, the LBGK model rapidly becomes numerically
with non-smooth granular dynamics to describe the formation of
unstable at moderate Reynolds numbers, when τ → 1/2. Therefore,
dunes in riverbeds. To the authors knowledge though, no LBM ap-
several collision models have been introduced which aim to in-
proach to sediment transport has so far been introduced, which is
crease the stability and accuracy at higher Reynolds numbers. In
able to couple sediment transport to turbulent flows which rely on
the following, we will discuss only the entropic multi-relaxation
collision models that provide unconditional numerical stability.
time lattice Boltzmann model, which was introduced by Karlin
The underlying work aims to provide such an LBM model,
et al. [9] and is therefore henceforth denoted as the Karlin–Bösch–
which is able to combine the simulation of complex turbulent
Chikatamarla (KBC) model. As the name suggests, it can be seen
flows with appropriate sediment transport using the entropic
as an extension of both the entropic lattice Boltzmann method
multi-relaxation time lattice Boltzmann model introduced by Kar-
(ELBM) [20,21] and the multi-relaxation time (MRT) lattice Boltz-
lin et al. [9] and Bösch et al. [10]. One of the main requirements
mann models [22–24]: While ELBM makes use of an additional pa-
to the model framework is that it should require as few simulation
rameter α to locally modify the viscosity in accordance with an
parameters as possible, while providing a good approximation of
entropy condition when and wherever needed, the MRT models
the resulting flow and sand bed structures. The sediment phase is
make use of the fact that not all moments of the distribution func-
modelled via an advection-diffusion approach in order to keep the
tions need to be relaxed with the same relaxation time in order
computational cost at a minimum. Furthermore, the framework is
to obtain the expected hydrodynamic behaviour. The KBC model
required to be able to handle arbitrarily shaped objects and local
combines these two aspects in that it keeps the unmodified vis-
grid refinement.
cosity and relaxation time for the moments that are relevant for
the Navier–Stokes equations, while using an entropy condition to
2. Fluid flow simulations locally fix the relaxation time of the higher order moments.
To begin with, the distribution functions fi are expressed in the
The following section will provide a detailed outline of the var- moment basis, where the moments for a three-dimensional lattice
ious implementations that were incorporated into the open-source with 27 discrete lattice velocities (D3Q27) are given by
Palabos code [18] for the simulation of the fluid flow. The main
intention is to provide a numerical setup that can be used to sim-
26
ρ M pqr = fi cixp ciy
q r
ciz , p, q, r ∈ {0, 1, 2}, ciα ∈ {−1, 0, 1}. (5)
ulate external flows around arbitrarily shaped with the additional
i=0
requirement that the simulation remain numerically stable even at
high Reynolds numbers. This means that the user should have to In this basis, the distribution functions can be written as
provide as few parameters as possible, alongside an STL file of the f i = ki + si + hi , (6)
desired object.
where ki is the kinematic part, which depends on the conserved
quantities, i.e. the density ρ and the velocity u, and si denotes the
2.1. The entropic multi-relaxation time lattice Boltzmann method shear part which must at least contain the deviatoric stress ten-
sor. Further moments may also be included into si though, thus
The general form of the lattice Boltzmann equation for incom- yielding a set of various slightly different KBC models. Finally, the
pressible flows is obtained by discretising the Boltzmann equation contribution of all other higher-order moments is denoted by hi .
on a lattice at the grid points x which is spanned by a discrete set Given the expression used in Eq. (6), the collision term becomes
of velocity vectors ci , i = 0, . . . , q − 1:
1

γ
i = − s i + h i (7)
f i ( x + c i , t + 1 ) = f i ( x , t ) + i , (1) τ 2
eq eq
where fi are distribution functions corresponding to the respective with si = si − si and hi = hi − hi . This ensures that the kine-
velocity vectors ci and i is the collision term. While the left-hand matic viscosity ν is still given by Eq. (4) while the parameter γ
side of the above equation corresponds to a streaming step on the controls the relaxation time of the higher order moments. Follow-
lattice, the right-hand side denotes the post-collision state of the ing Karlin et al. [9], γ can thus be obtained by maximizing the
distribution functions. entropy of the post-collision state under the constraint of a fixed
For the simple case of the single-relaxation time lattice state for the shear stress part. A sufficient approximation to this
Bathnagar–Gross–Krook (LBGK) model, based on the collision condition is given by
model of Bhatnagar et al. [19], the collision term can be approx-
−1
eq s i h i h i h i
imated by introducing a local equilibrium fi (x, t ): γ = 2τ − 2 ( 1 − τ ) . (8)
fieq fieq
1  i i
i = − fi (x, t ) − fieq (x, t ) , (2)
τ A more in-depth description of the KBC models can be found in
Bösch et al. [10], which also demonstrates the ability of the model
where the relaxation time τ is related to the kinematic viscos-
to produce accurate results even when the simulation is under-
ity ν . The equilibrium term itself corresponds to the discretised
resolved. Further, Dorschner et al. [12] showed that the KBC model
Maxwell-Boltzmann distribution, which is subsequently expanded
- specifically, the model which incorporates only the required de-
up to the second order in u:
viatoric stress tensor in the shear part si - can further be used in
 
u · ci (u · ci )2 − cs2 (u · u ) the presence of boundaries and is able to produce results compara-
fieq = ρ ti 1 + 2
+ , (3) ble to those of direct numerical simulations for both resolved and
cs 2cs4
under-resolved cases. This, together with the fact that no tunable
 
where ρ = i fi√is the density, u = 1/ρ i ci fi is the macroscopic parameters are required in advance, render it the ideal model for
velocity, cs = 1/ 3 is the sound speed in lattice units and ti are the simulation of fluid flows at high Reynolds numbers.
342 H.E. Morrison, A. Leder / Computers and Fluids 172 (2018) 340–351

2.2. Off-lattice boundary conditions 6


Wieselsberger (1921)
Tritton (1959)
Many technical and industrial flow problems involve external Lima E Silva et al. (2003)
flows around complex geometries at high Reynolds numbers (typi- 5 Shu et al. (2007)
BFL + TMS
cally up to Re ≈ 105 − 106 ). Because these objects tend to be rather
large and their movement is often limited in comparison to the
flow, we have chosen an approach based on a modified bounce- 4
back of the distribution function instead of using an immersed

cD
boundary method. In order to ensure locality and efficiency of
the method, the interpolated bounce-back scheme of Bouzidi, Fir- 3
daouss and Lallemand [25] (BFL) was chosen. By separately sav-
ing the distribution functions after each collision as f i,Cprev , this
2
bounce-back scheme can be applied locally to the distribution
functions which are initially missing after a streaming step:
fibb = fi˜(x, t + 1 )C,S 1
   10 100
2 fi,Cprev + (1 − 2) fiC,S + 2ti
cs2
ci˜ · ub ,  < 1/2 Re
=   (9)
1 C
f
2 i,prev
+ 2
2
−1 C
f˜ + 1
cs2 
ci˜ · ub ,  ≥ 1/2 Fig. 1. Drag coefficient for the flow around a cylinder at various Reynolds numbers.
i,prev

where  ∈ [0, 1] is the normalized distance of the fluid node to the


boundary, ub is the velocity of the boundary and ci˜ = −ci . Further- The resulting drag forces for Reynolds numbers from
more, fiC,S denotes the respective distribution functions after both 4 ≤ Re ≤ 300 are shown in Fig. 1, alongside experimental data
the collide and the streaming step. from Wieselsberger [30] and Tritton [31] as well as numerical data
Although this approach is extremely efficient and able to repro- from Lima E Silva et al. [32] and Shu et al. [33], which both used
duce the exact position of the boundary of an object, it can become the immersed boundary method to accurately depict the geometry
numerically unstable due to the fact that only a linear interpola- of the cylinder. It is apparent that the proposed combination of
tion is used. This is especially the case when the considered object the BFL interpolation and the subsequent TMS step can accurately
is allowed to move and the velocity of the flow becomes increased reproduce the expected flow behaviour around the cylinder.
locally in space and time. The numerical stability can be restored Furthermore, the method can also be used to simulate the flow
though by applying the Tomm–Mott–Smith (TMS) approximation around moving objects. For this, a special treatment is required for
as proposed by Chikatamarla and Karlin [26] after the interpolated solid nodes which become fluid nodes after the object has moved.
bounce-back step. This combination of both the BFL interpolation Several methods for dealing with this have been introduced in the
and the additional TMS step was previously already introduced in literature, including a second order extrapolation of the distribu-
Morrison et al. [27], where it was shown to provide the expected tion functions [34]. For the simulations presented here though, we
results for the flow around a three-dimensional circular cylinder, simply initialize the new fluid cells with the equilibrium distribu-
while also being able to suppress any potential local discontinu- tion function based on the boundary velocity and the average den-
ities at the boundaries, thereby rendering it indefinitely numer- sity of the surrounding fluid nodes, which were already fluid nodes
ically stable. Additionally, we also tested the method for several during the previous time step.
different benchmark cases. In order to test the proposed treatment for moving boundaries,
One such case is the two-dimensional flow around a cir- we again simulated the flow past a two-dimensional circular cylin-
cular cylinder with the diameter D at low Reynolds numbers, der. The simulation domain was chosen to be Lx = 30D long and
Re = U∞ D/ν , where U∞ denotes the undisturbed velocity of the Ly = 4D wide, with a stationary cylinder placed at x/D = 2.5 and
flow far away from the cylinder. The flow and thus also the drag y/D = 2.5. The inflow velocity in positive x-direction was set to
force experienced by the cylinder strongly depend on the chosen U∞ = 0.1 in lattice units at a Reynolds number of Re = 200. The
Reynolds number, making it an ideal test case for off-lattice bound- resolution was chosen to be N = 100 nodes per D. For compari-
ary conditions. son, a further simulation was run, where the cylinder was initially
The force acting on the cylinder can be evaluated by using the placed in a fluid at rest at x/D = 27.5 and y/D = 2.5 and subse-
momentum exchange method [28], which takes the momentum quently moved through the fluid at a velocity of ub = −0.1 in the
exchange of all boundary nodes xb into account. By denoting the x-direction. Hence, both simulations depict the same problem but
bounce-backed distribution functions as a sub-set D̄, the force can with different frames of reference: once with the cylinder at rest
be computed as follows: and once with the fluid initially at rest.
Fig. 2 shows the resulting vorticity of both runs in comparison
F= fi˜(x, t )ci˜ − fi (x, t + 1 )ci (10) at the point where the moving cylinder reaches the same position
(∀x=xb ) (i∈D̄ ) as the stationary cylinder at x/D = 2.5. As expected, both simula-
tions produce an identical flow field, thus proving the capability
 
= fi˜,prev + fibb ci˜ (11) of the proposed off-lattice boundary condition to accurately depict
(∀x=xb ) (i∈D̄ ) the flow around (moving) objects.

The drag coefficient per unit length is then given by


2.3. Three-dimensional multi-domain grid refinement
2Fx
cD = (12)
ρU∞
2D
Grid refinement is needed in order to refine certain areas of
where Fx is the horizontal force acting on the cylinder. The setup the simulation to allow for a higher computational accuracy, e.g.
of the simulations was chosen analogously to Dorschner et al. [29], directly around the object in order to ensure a correct detach-
with a minimal resolution of N = 20 nodes per D and a lattice ve- ment of the flow. This was achieved by implementing a three-
locity of U∞ = 0.05. dimensional multi-domain approach to grid refinement, which is
H.E. Morrison, A. Leder / Computers and Fluids 172 (2018) 340–351 343

Fig. 2. Comparison of the resulting vorticity contours of a moving (dotted lines) and stationary (solid lines) circular cylinder at Re = 200, obtained from corresponding LBM
simulations using a combined BFL and TMS off-lattice boundary condition.

essentially a three-dimensional extension of the method outlined and the non-equilibrium distribution functions need to be inter-
in Lagrava et al. [35]. For this approach, the user initially defines polated first before the distribution functions can be rescaled. In
a set of boxes within the simulation domain which should be re- the three-dimensional case, this interpolation is bi-cubic wherever
fined. These boxes are then subtracted from the original domain, possible in order to maintain the second order accuracy of the lat-
such that multiple domains of varying resolutions are obtained. tice Boltzmann scheme.
The domains then ultimately share an overlapping region of two
coarse grid cells, which is used to couple the respective domains.
Following Lagrava et al. [35], the resolution of each refinement 2.4. Flow around a wall-mounted finite cylinder
domain is twice as high as the resolution of the surrounding do-
main (x f = xc /2 ). With the choice of convective scaling, this The aforementioned additions to the open-source Palabos code
in turn means that the refinement domain also undergoes twice were combined to simulate the flow around a wall-mounted finite
as many iterations as the surrounding domain (t f = tc /2 ). Be- cylinder with an aspect ratio of L/D = 2. The flow around such a
cause the Reynolds number must remain the same on both grids, cylinder has previously been analysed in detail at a Reynolds num-
one also obtains a scaling relationship for the respective kinematic ber of Re = U∞ D/ν = 2 × 105 within our group, which resulted in
viscosities and with Eq. (4) thus also for the relaxation times: a range of measurement data based on three-dimensional laser
Doppler anemometry (LDA) [36–38] as well as time-resolved parti-
ν f = 2 νc (13)
cle image velocimetry (TR-PIV) [39,40]. Furthermore, this case was
also previously simulated using an LES [41–44].
1 For the simulation of the flow around the wall-mounted cylin-
⇒ τ f = 2 τc − (14) der with the lattice Boltzmann method, the cylinder was placed
2
on the floor of the simulation domain at x = (0, 0, 0 )T , where T
The latter is needed to adequately scale the distribution functions denotes the transpose of the vector for better readability. The do-
between the domains: main itself extends over −1.5 ≤ x/D ≤ 10.5, −5.0 ≤ y/D ≤ 5.0 and
fi = fieq (ρ , u ) + fineq (ρ , u, σ ) (15) 0.0 ≤ z/D ≤ 7.0 with the flow pointing in the positive x-direction
with a velocity of U∞ = 0.05 far away from the influence of the
While the equilibrium part only depends on the density and cylinder. The floor is placed at z/D = 0. The lateral walls in the y-
the velocity and is therefore invariant under convective scaling, direction as well as the top wall at z/D = 7 are set up as free-slip
the non-equilibrium term depends on the deviatoric stress tensor walls using the specular reflection boundary condition. The out-
σ ∝∇ u and thus needs to be rescaled accordingly. By considering let at x/D = 10.5 is constructed according to the approach outlined
only those terms of the distribution function that fully recover the in Chikatamarla et al. [45], with an additional sponge zone start-
Navier–Stokes equations during the Chapman–Enskog expansion, ing 1D before the outlet, where the local viscosity is manually in-
the non-equilibrium term can be approximated as follows: creased in order to dampen the effect of large velocity gradients at
 
τ ti ρ   ∂ uα ∂ uβ the outlet. The inflow velocity corresponds to time-averaged veloc-
fineq ≈− c iα c iβ − δ
cs2 αβ + (16) ity measurements at x/D = −1.5 in order to account for the block-
2cs2 ∂ xβ ∂ xα age due to the cylinder, though no further temporal variability or
This in turn leads to the following relationship between the re- artificial turbulence was added.
spective non-equilibrium parts of the distribution functions: In order to accurately capture the detachment of the flow, a to-
tal of four refinement levels was chosen (Fig. 3). The resolution of
τf
fi,neq = neq
fi,c (17) the finest refinement box is N = 80 nodes per D, resulting in a total
f 2 τc of 21.6 million nodes for the entire simulation domain. It is worth
These scaling relations are needed for the coupling between pointing out that no specific wall model was used in this case.
the two domains. When coupling the fine grid to the coarse grid, Fig. 4 shows the contour of the recirculation zone in the mid-
an additional filtering operation is applied to the non-equilibrium plane in the wake of the cylinder, given by the mean horizontal
distribution functions in order to increase the numerical stability velocity ū = 0. The LBM slightly over-predicts the length of the re-
[35]. No such filtering is required though for the coupling from the circulation zone, which is most likely due to the low resolution
coarse grid to the fine grid. Nevertheless, for fine grid points that close to the ground and the lack of an appropriate wall model. In
do not coincide with a coarse grid point, the density, the velocity general though, the shape of the recirculation zone obtained from
344 H.E. Morrison, A. Leder / Computers and Fluids 172 (2018) 340–351

Fig. 3. Multi-domain grid comprised of four refinement levels used for the LBM simulation of a wall-mounted cylinder. Every 5th grid node is depicted.

2.0 pling to determine the advection velocity from the fluid simula-
LBM
LES tion.
PIV

1.5 3.1. The lattice Boltzmann/advection–diffusion model

415 The advection and diffusion of an arbitrary quantity ϕ is given


by the following advection–diffusion equation:
z/D

1.0

ϕ + ∇ · (uϕ ) = D0 ∇ 2 ϕ , (18)
∂t
0.5 where u denotes the advection velocity and D0 is the diffusion co-
efficient. Following Flekkøy [46], it can be shown that the lattice
Boltzmann equation (Eq. (1)) can also be used to solve the above
advection–diffusion equation. In order to distinguish the distribu-
0.0
-0.5 0.0 0.5 1.0 1.5 2.0 2.5 3.0 tion functions used for the advection-diffusion equation from those
x/D used to solve the Navier–Stokes equations, they are usually de-
noted by gi in the lattice Boltzmann/advection–diffusion (LB/AD)
Fig. 4. Recirculation zone behind a wall-mounted cylinder at y/D = 0. Comparison model:
between averaged LBM, LES and TR-PIV data.  
g i ( x + c i , t + 1 ) − g i ( x , t ) = i τ , gi (x, t ), geq
i
( x, t ) (19)

The relaxation time τ is then related to the diffusion constant:


the lattice Boltzmann simulation agrees well with the TR-PIV mea-
 1

surements [39] and the LES data [42].
D0 = cs2 τ− (20)
Furthermore, Fig. 5 shows the mean velocity and Reynolds 2
stress profiles for a vertical line in the wake of the cylinder in com-
Furthermore, the advection–diffusion equation does not contain
parison with the previously obtained data from TR-PIV [39] and
any second-order velocity terms, such that the equilibrium term
LDA [38] measurements and from an LES [44]. The profiles ob-
can be simplified accordingly:
tained from the lattice Boltzmann simulation agree well with the  
previous data, with the differences between the various simulation 1
techniques being of the same order as the differences between the geq
i
= ti ϕ 1 + ci · u (21)
cs2
various experimental data. The obtained profiles thus prove that

the LBM is able to accurately capture the flow in the wake of the with ϕ = i gi . This approach is by far the simplest approach to
cylinder. solving the advection-diffusion equation with the lattice Boltz-
Overall, the presented simulation shows that the LBM in combi- mann method. Ginzburg [47] further introduced a set of various
nation with the KBC model, the aforementioned off-lattice bound- LB/AD models which also cover special cases, such as anisotropic
aries and multi-domain grid refinement is capable of producing diffusion, pure advection or pure diffusion. One of these models
satisfactory results, even at high Reynolds numbers and relatively was used by Stiebler et al. [48] for advection-diffusion problems
low resolution. on non-uniform grids. In their case, no specific scaling of the non-
equilibrium part of the distribution function was required when
transferring information between the grids. This is indeed required
3. Sediment transport with the lattice Boltzmann method though, when the above LB/AD model is used: for the above case,
neq
the non-equilibrium part of the distribution functions, gi , can be
The following section aims to introduce an initial approach to approximated according to Lätt [49]:
simulating sediment transport around objects in turbulent flows.
gneq
i
≈ −τ ti ci · ∇ϕ (22)
Because the sediment which is of interest in this study is rela-

tively fine, we shall neglect particle interactions and the effect of This form guarantees that the 0th (ϕ = i gi ) and 1st order mo-

the sediment on the fluid. Thus, we will use an advection–diffusion ments (ϕ u = i ci gi ) are dealt with correctly. The equilibrium part
approach to simulate the sediment phase and use a one-way cou- of the distribution functions (Eq. (21)) only depends linearly on u
H.E. Morrison, A. Leder / Computers and Fluids 172 (2018) 340–351 345

3.0 3.0
LBM LBM
LES LES
2.5 LDA 2.5 LDA
PIV PIV

2.0 2.0
z/D

z/D
1.5 1.5

1.0 1.0

0.5 0.5

0.0 0.0
-0.4 -0.2 0.0 0.2 0.4 0.6 0.8 1.0 1.2 -0.20 -0.15 -0.10 -0.05 0.00 0.05 0.10 0.15 0.20
ū/U∞ v̄/U∞
3.0 3.0
LBM LBM
LES LES
2.5 LDA 2.5 LDA
PIV PIV

2.0 2.0
z/D

z/D
1.5 1.5

1.0 1.0

0.5 0.5

0.0 0.0
-0.7 -0.6 -0.5 -0.4 -0.3 -0.2 -0.1 0.0 0.1 0.00 0.05 0.10 0.15 0.20 0.25 0.30

w̄/U∞ u u /U∞
3.0 3.0
LBM LBM
LES LES
2.5 LDA 2.5 LDA
PIV PIV

2.0 2.0
z/D

z/D

1.5 1.5

1.0 1.0

0.5 0.5

0.0 0.0
0.00 0.05 0.10 0.15 0.20 0.25 0.30 0.35 0.40 0.00 0.05 0.10 0.15 0.20 0.25 0.30 0.35 0.40
√ √
v v /U∞ w w /U∞

Fig. 5. Averaged velocity profiles from the LBM simulation of a wall-mounted cylinder along a vertical line in the wake of the cylinder at y/D = 0 and x/D = 2.2 in comparison
with measurements (TR-PIV and LDA) and LES.

and therefore remains constant under convective scaling. The non- c0 = (0, 0, 0 )T , c1 = (1, 0, 0 )T , c2 = (−1, 0, 0 )T , c3 = (0, 1, 0 )T , c4 =
equilibrium part on the other hand depends on τ and ∇ϕ and thus (0, −1, 0 )T , c5 = (0, 0, 1 )T , c6 = (0, 0, −1 )T . The lattice constants
needs to be rescaled: are given by t0 = 1 − 3cs2 and ti = cs2 /2 for i = 1, . . . ,6. The sound
τ f (∇ϕ ) f τ f x f τf speed is arbitrarily set to cs2 = 1/4. Because the aim is to eventually
gneq = gneq = gneq = gneq (23)
i, f i,c τc (∇ϕ )c i,c τ c x c i,c 2 τc combine the LB/AD model with the aforementioned fluid model, a
description of the KBC model on the D3Q7 lattice is required. For
Comparing this to Eq. (17) shows that the scaling of the distri-
this we shall first define the moment basis. Following Yoshida and
bution functions for the LB/AD model is analogous to that of the
Nagaoka [50] and with
lattice Boltzmann model used for the fluid flow. This means that
no additional treatment is required to adapt the existing multi-
domain grid refinement to the LB/AD model.
6
The LB/AD model can be solved on the D3Q7 lattice. This M pqr = gi cixp ciy
q r
ciz , p, q, r ∈ 0, 1, 2 (24)
lattice is defined by the following discretised velocity vectors: i=0
346 H.E. Morrison, A. Leder / Computers and Fluids 172 (2018) 340–351

this moment basis is given as follows: et al. [51] state the necessity of such a term, Flekkøy [46] also
⎛ ⎞ pointed out that a correction is not needed if the diffusion con-
M0 0 0
stant is low enough, which is in fact the case for all simulations
⎜ M100 ⎟
⎜ ⎟ presented in this work.
⎜ M010 ⎟
⎜ ⎟
⎜ M001 ⎟ 3.2. Coupling the LB/AD model to the fluid flow simulation
⎜ ⎟
⎜6 − 7(M200 + M020 + M002 )⎟
⎜ ⎟ The previously introduced LB/AD model shall now be used to
⎝ 2M200 − M020 − M002 ⎠
simulate sediment transport in fluid flows around arbitrary objects
M020 − M002 on a sand bed. In principle, this involves running two simulations
⎛ ⎞⎛ ⎞ side-by-side which are coupled after every iteration step. As al-
1 1 1 1 1 1 1 g0
ready mentioned, only one-way coupling is considered here, where
⎜0 1 −1 0 0 0 0 ⎟⎜g1 ⎟
⎜0 −1 0⎟ ⎜ ⎟ the sediment velocity us is determined by the fluid velocity u and
⎜ 0 0 1 0 ⎟⎜g2 ⎟
=⎜
⎜0 0 0 0 0 1 −1⎟ ⎜ ⎟
⎟⎜g3 ⎟ (25) an added settling velocity ws :
⎜6 −1 −1 −1 −1 −1 −1⎟⎜g4 ⎟ us = u + ws ez , (29)
⎝0 2 2 −1 −1 −1 −1
⎠⎝g ⎠
5
where ez is the unit vector in z-direction and it is assumed that
0 0 0 1 1 −1 −1 g6
gravity acts in the negative z-direction. According to Soulsby [52],
This in turn results in the following representation of the distribu- The settling velocity is given by
tion functions gi : ν

⎧ ws = 10.362 + 1.049d∗3 − 10.36 (30)
M000 − M200 − M020 − M002 , ds



⎪ for cix = ciy = ciz = 0 where ds is the diameter of the considered sediment and d∗ is the



⎪ 1 dimensionless sediment diameter, given by

⎪ (cix M100 + M200 ),  1/3

⎪ 2

⎨ ( ρs − ρ ) g
for cix = 0, ciy = ciz = 0 d∗ = ds (31)
gi = 1   (26) ρν 2

⎪ ciy M010 + M020 ,
⎪2
⎪ with the sediment density ρ s and the gravitational acceleration g.

⎪ for ciy = 0, cix = ciz = 0

⎪ All other parameters are determined by the fluid.

⎪ 1
⎪ (ciz M001 + M002 ),

When using the velocity from the fluid flow simulation as the

⎩2 advection velocity though, the previously defined representation
for ciz = 0, cix = ciy = 0 for the distribution functions (Eqs. (26) and (27)) no longer suffices
to achieve numerically stable solutions. Instead, the part si , which
For the KBC model, this representation needs to be split into a part
is most significant for the KBC model (Eq. (7)), is defined according
ki which contains the conserved moments (which in the case of
to the D3Q27 representation, but using only those moments which
the LB/AD model only includes the 0th order moment), a part si
are available on the D3Q7 lattice:
which contains all other relevant moments for the model (in this ⎧
case the 1st order moment) and a part hi which contains the re- ⎪
⎪0, for cix = ciy = ciz = 0
maining higher order moments: ⎪
⎨ 1 (2M − M − M ),
6 200 020 002 for cix = 0, ciy = ciz = 0
si = 1 (32)
gi = ki (M000 ) + si (M100 , M010 , M001 ) ⎪ 6(
⎪ 2M020 − M200 − M002 ), for ciy = 0, cix = ciz = 0

⎩1
+ hi (M200 , M020 , M002 ) (27) ( 2M002 − M200 − M020 ), for ciz = 0, cix = ciy = 0
6
In order to test this model in combination with multi-domain grid si in Eq. (7) is thus given by si = si − seq and hi is determined
i
refinement, the advection and diffusion of a Gaussian hill is simu- eq
via hi =  fi − si = fi − fi − si . With this representation, we
lated, which is given by the following distribution:
were able to obtain satisfactory results when using the velocity
 
(x − x0 )2 from the fluid simulation as the advection velocity. The reason
ϕ = exp − , (28) behind having to use two different representations, depending on
2L
whether a constant advection velocity is used (Eqs. (26) and (27))
where L is the characteristic length of the domain and x0 is the or velocities from a fluid simulation (Eq. (32)), is most likely the
centre of the distribution. The simulated domain extends over fact that the velocities from the fluid flow simulation are them-
40L in each direction. A refinement box is included between selves part of a simulation based on the KBC model and would
15 ≤ x/L ≤ 25, 20 ≤ y/L ≤ 30 and 15 ≤ z/L ≤ 25. The resolution of the thus otherwise cause the sediment simulation to become unstable.
coarse domain is Nc = 2 cells per L and consequently N f = 4. Only by applying the same KBC scheme from the fluid simulation
Two Gaussian distributions are defined at an initial position of to the sediment simulation, it becomes possible to maintain the
x0,1 = (15L, 25L, 20L )T and x0,2 = (15L, 15L, 20L )T , respectively. The required numerical stability.
diffusion constant is arbitrarily set to D0 = 0.01 and the advec- Furthermore, the diffusion constant needs to be determined.
tion velocity is chosen to be u = (U, 0, 0 )T with U = 0.05, meaning This can be obtained via the Schmidt-number Sc = ν /D0 , which
that one Gaussian distribution crosses between the grids, while the couples the viscous diffusion rate of the fluid to the mass diffu-
other remains on the coarse grid. sivity of the sediment. In the following, this will be set to Sc = 1,
Fig. 6 shows the temporal evolution of the distributions. Both resulting in the same relaxation parameters for both the fluid and
distributions show the expected behaviour, with no apparent dif- the sediment phase.
ference between the distribution which crossed between the grids
and that which remained on the coarse grid. The presented LB/AD 3.3. Erosion and sedimentation
model thus works excellently with both the KBC collision model
and the multi-domain grid refinement. Furthermore, it is worth The processes of erosion and sedimentation are handled analo-
pointing out that no correction term was used. Although Chopard gously to Parmigiani et al. [16], where the processes are effectively
H.E. Morrison, A. Leder / Computers and Fluids 172 (2018) 340–351 347

Fig. 6. Results from an LBM simulation of the advection and diffusion of two Gaussian hills at t = 0 (left) and t = 147L/U (right).

controlled via the Shields parameter Sh: cell which is initialised with ρ0 = 1 and u = (0, 0, 0 )T in the fluid
τw phase and ϕ 0 in the sediment phase.
Sh = (33) Sedimentation on the other hand occurs when τ w ≤ τ w, c over
(ρs − ρ )gds
a given sedimentation time Ts and the sediment density exceeds a
This parameter essentially relates the wall shear stress τ w to the given critical value in the cell ϕ ≥ ϕ c . In this case, the respective
weight of the sediment. Once the critical Shields parameter Shc has fluid cell simply becomes a wall cell and no further treatment is
been reached, the sediment begins to move and is eroded. The crit- required.
ical Shields parameter itself depends on the considered sediment In the presented work, the erosion and sedimentation processes
and can be expressed in terms of the dimensionless sediment di- are thus fully characterised by the parameters of the erosion time
ameter [53]: Te , the sedimentation time Ts and the critical sediment density ϕ c .
   The time scales essentially act as a temporal averaging of the wall
0.23 d0.85
Shc = + 0.054 1 − exp − ∗ (34) shear stresses, but can further be used to control the time scales
d∗ 23 of the individual processes. For the following, the time scales are
This, in turn, can be transformed into a critical wall shear stress arbitrarily set to Te = Ts = 10tc , meaning that each individual ero-
with Eq. (33). Erosion and sedimentation thus strongly depend on sion or sedimentation process requires 10 iterations on the coarse
an accurate determination of the wall shear stress, given by the grid. Furthermore, the critical sediment density is arbitrarily set to
norm of the corresponding vector. Following Stahl et al. [54], this ϕc = ϕ0 = 4.
vector can be determined via the deviatoric stress tensor σ and the
wall normal n: 3.4. Scour and sedimentation around a horizontally bedded finite
cylinder
τw,α = σαβ nβ − (nβ σγ β nγ )nα (35)
Furthermore, σ itself can be determined locally and therefore does The presented models are finally all combined to simulate the
not require a finite difference method to determine the velocity sediment processes around a horizontally bedded finite cylinder.
gradient: Such a cylinder with an aspect ratio of L/D ≈ 3.3 has previously
1  1  been a topic of investigation within our group [56], where it was
σαβ ≈ − 1 neq = −1 ciα ciβ ( fi − fieq ) (36) placed on an initially level sand bed in a water channel and sub-
2τ αβ 2τ sequently subjected to a uniform flow. The resulting sand struc-
i
tures were then determined qualitatively. Fig. 8 shows the sand
The wall normal on the other hand also needs to be determined
bed around the cylinder after a quasi-equilibrium state has been
locally, as the erosion and sedimentation processes constantly
reached. Furthermore, Fig. 9 depicts the streamlines from an ini-
change the form of the sand bed. For this, a weighted method is
tial LBM simulation on a flat surface under similar conditions, but
chosen, which considers all those velocity vectors that point away
without sediment transport. From Fig. 8, it becomes evident that
from the wall, i.e. away from the sand bed (ci , i ∈ D̄ )[55]:
the sand bed upstream of the cylinder has been eroded. This ero-
1 sion coincides with the formation of a horseshoe vortex that also
n=  wi c i (37)
i∈D̄ wi
extends around the edges of the cylinder, as can be made out in
i∈D̄
Fig. 9. On the other hand, sediment is also deposited downstream
with the weights wi = (1 + i ) p being determined by the respec- of the cylinder, where a recirculation region can be made out from
tive distances to the wall i and a weighting factor, which in the Fig. 9. This suggests that the recirculation region acts as a sedi-
following is chosen to be p = 0.5. ment trap, where the settling velocity cannot be compensated by
If the computed wall shear stress in a cell thus exceeds the crit- the fluid flow.
ical wall shear stress τ w, c , the cell is initially ‘marked’. If it remains In order to reproduce the sediment transport in this case as
‘marked’ over a given erosion time Te , i.e. if τ w remains above τ w, c , well as possible, the simulation parameters were chosen appropri-
then the nearest wall cell along the wall normal is eroded. For the ately: the domain extends from −5 ≤ x/D ≤ 8, −6 ≤ y/D ≤ 6 and
initial simulation, this means that the entire cell becomes a fluid −0.2 ≤ z/D ≤ 2.24, with the center of the cylinder placed at x/D =
348 H.E. Morrison, A. Leder / Computers and Fluids 172 (2018) 340–351

Fig. 7. Multi-domain grid comprised of four refinement levels used for the LBM simulation of the flow and sedimentation around a horizontally bedded finite cylinder.
Approximately every 5th grid node is depicted.

explicitly modelled in the simulation, but approximated by a free-


slip boundary condition. Furthermore, the lateral walls are also in-
corporated as free-slip boundaries, as the actual water channel is
slightly wider. At the inlet at x/D = −5, a measured average veloc-
ity profile is inserted which can be approximated as follows:
 z 0.35
U = 8.51U∞ (38)
D
with U∞ = 0.293 m/s or U∞ = 0.05 in lattice units. The corre-
sponding Reynolds number is Re = U∞ D/ν = 1.7 × 104 . According
to the sediment in the water channel, which has a mean sedi-
ment diameter of ds = 0.2 mm and a density of ρs = 2600 kg/m3 ,
a critical Shields parameter of Shc = 0.054 was determined, cor-
responding to a critical wall shear stress of τw,c = 0.17 N/m or
2

Fig. 8. Photograph of the quasi-equilibrium state of the sand bed around a horizon-
τw,c = 4.97 × 10 in lattice units.
−6

tally bedded finite cylinder in a water channel. The cylinder was subjected to uni- In order to characterise only the erosion and sedimentation
directional flow. The photograph was taken after the sand bed in the direct vicinity processes due to the cylinder, no initial sediment density was in-
of the cylinder no longer exhibited further significant changes. troduced to the sediment phase. This means that the only sedi-
ment present in the simulation is that which is eroded from the
sand bed. In turn, this also means that the sedimentation processes
only become relevant when higher settling velocities are chosen
than would be expected from the mean sediment diameter. For
the following simulation, the settling velocity is thus chosen to
be ws = 0.2U∞ = 5.86 cm/s, which would normally correspond to
a sediment diameter of ds ≈ 0.4 mm.
Fig. 10 shows the result of the simulation. The fluid flow sim-
ulation was given t = 40 0 0tc initial runtime before the sediment
processes were activated. Evidently, the presented sediment trans-
port model is generally able to capture the main features which
determine the sand bed structure around a bedded cylinder: Com-
pared to Fig. 8, the erosion upstream of the cylinder occurs more
to the corners and edges of the cylinder, with the area more to the
center becoming only gradually eroded during the course of the
simulation. It is to be expected that adding avalanching effects to
the sediment transport model would gradually cause the sediment
directly upstream of the cylinder to fall into the eroded corners,
Fig. 9. Streamlines from an initial LBM flow simulation around a horizontally bed-
ded finite cylinder.
thus increasing the overall eroded area in front of the cylinder. In
general though, the overall erosion from the simulation seems to
coincide very well with the horseshoe vortex and thus strengthens
the hypothesis that this is the main driving factor behind the scour
0, y/D = 0 and z/D = 0.4. The chosen refinement boxes are de- around the cylinder.
picted in Fig. 7, with the sand bed completely incorporated in Further, Fig. 10 also shows a gradual deposition of sediment,
the finest grid. In the experiments, the water surface was approxi- mainly downstream the center of the cylinder in the recirculation
mately z = 0.13 m = 2.24D above the sand bed. This surface is not zone. This therefore strengthens the hypothesis that the recircula-
H.E. Morrison, A. Leder / Computers and Fluids 172 (2018) 340–351 349

Fig. 10. Temporal development of the erosion and sedimentation around a horizontally bedded finite cylinder as obtained from a combined fluid flow and sediment transport
simulation using LBM.

tion zone itself acts as a sediment trap, where the overall velocity Additional sedimentation is visible further downstream to the
of the fluid is not large enough to compensate the settling velocity sides of the cylinder. Here, the effect of the cylinder on the fluid
of the sediment. As the settling velocity increases with the sedi- flow becomes more and more negligible and the sediment is sim-
ment diameter, larger sediment particles are more likely to be de- ply deposited due to its dominant settling velocity.
posited in this area, while smaller particles would be transported The simulation was finally cut off after t = 5260tc , as the
further downstream. eroded sand bed had reached the edge of the simulation domain
350 H.E. Morrison, A. Leder / Computers and Fluids 172 (2018) 340–351

and the deposited sediment reached the top of the finest grid. Fur- [10] Bösch F, Chikatamarla SS, Karlin IV. Entropic multirelaxation lattice Boltz-
thermore, the model currently does not account for the fact that mann models for turbulent flows. Phys Rev E 2015;92(4):043309. doi:10.1103/
PhysRevE.92.043309.
the cylinder would at some point begin to roll into the eroded re- [11] Geier M, Schönherr M, Pasquali A, Krafczyk M. The cumulant lattice Boltz-
gion. mann equation in three dimensions: theory and validation. Comput Math Appl
2015;70(4):507–47. doi:10.1016/j.camwa.2015.05.001.
[12] Dorschner B, Bösch F, Chikatamarla S, Boulouchos K, Karlin I. Entropic multi-
4. Conclusion Relaxation time lattice Boltzmann model for complex flows. J Fluid Mech
2016;801:623–51. doi:10.1017/jfm.2016.448.
[13] Geier M, Pasquali A, Schönherr M. Parametrization of the cumulant lattice
The presented work introduced a novel sediment transport Boltzmann method for fourth order accurate diffusion part i: derivation and
model based on the lattice Boltzmann method that can also be validation. J Comput Phys 2017;348:862–88. doi:10.1016/j.jcp.2017.05.040.
used to simulate sediment in complex turbulent flows, even when [14] Masselot A, Chopard B. A lattice Boltzmann model for particle transport and
deposition. Europhys Lett 1998;42(3):259–64. doi:10.1209/epl/i1998- 00239- 3.
the simulation is locally under-resolved. The underlying model for [15] Dupuis A, Chopard B. Lattice gas modeling of scour formation under sub-
the fluid flow simulations relies on the KBC collision model, a com- marine pipelines. J Comput Phys 2002;178(1):161–74. doi:10.1006/jcph.2002.
bined BFL and TMS approach for off-lattice boundaries and multi- 7025.
[16] Parmigiani A, Latt J, Begacem MB, Chopard B. A lattice Boltzmann sim-
domain grid refinement. This combination has been shown to pro- ulation of the rhone river. Int J Mod Phys C 2013;24(12). doi:10.1142/
duce accurate simulation results even at high Reynolds numbers S012918311340 0 081.
and relatively low resolution. The presented sediment transport [17] Rettinger C, Godenschwager C, Eibl S, Preclik T, Schruff T, Frings R, et al. Fully
resolved simulations of dune formation in riverbeds. In: High Performance
model uses an LB/AD model which is based on a modified KBC Computing. In: Lecture Notes in Computer Science, 10266. Springer, Cham;
collision model for the D3Q7 lattice. This therefore enables a direct 2017. p. 3–21. doi:10.1007/978- 3- 319- 58667- 0_1. ISBN 978-3-319-58666-3.
coupling of the velocity obtained from the fluid flow simulation to [18] Palabos webpage. 2018. http://www.palabos.org.
[19] Bhatnagar PL, Gross EP, Krook M. A model for collision processes in gases.
the sediment transport simulation. It was also shown though that
i. small amplitude processes in charged and neutral one-component systems.
the KBC model for the D3Q7 lattice needs to be adjusted, depend- Phys Rev 1954;94(3):511–25. doi:10.1103/PhysRev.94.511.
ing on whether a constant external advection velocity is used or [20] Karlin IV, Ferrante A, Ottinger HC. Perfect entropy functions of the lat-
tice Boltzmann method. Europhys Lett 1999;47(2):182–8. doi:10.1209/epl/
a local advection velocity which is obtained from a corresponding
i1999- 00370- 1.
fluid flow simulation. [21] Chikatamarla SS, Ansumali S, Karlin IV. Entropic lattice Boltzmann models for
An initial simulation of the sediment transport and the result- hydrodynamics in three dimensions. Phys Rev Lett 2006;97(July):1–4. doi:10.
ing sand bed structure in the vicinity of a horizontally bedded fi- 1103/PhysRevLett.97.010201.
[22] D’Humières D. Generalized lattice-Boltzmann equations. In: Rarefied Gas Dy-
nite cylinder showed that the coupling of the aforementioned sed- namics: Theory and Simulations, 159. Washington DC: American Institute of
iment transport model to turbulent fluid flow simulations delivers Aeronautics and Astronautics; 1992. p. 450–8. doi:10.2514/5.9781600866319.
the expected results. In order to improve the accuracy of the sim- 0450.0458. ISBN 9781600866319.
[23] Lallemand P, Luo L-S. Theory of the lattice Boltzmann method: disper-
ulations, several improvements can be included, such as a locally sion, dissipation, isotropy, galilean invariance, and stability. Phys Rev E
increased resolution of the sand bed, a critical Shields parameter 20 0 0;61(6):6546–62. doi:10.1103/PhysRevE.61.6546.
which depends on the inclination of the sand bed, avalanching ef- [24] D’Humières D, Ginzburg I, Krafczyk M, Lallemand P, Luo L-S. Multiple-
relaxation-time lattice Boltzmann models in three dimensions. Philos Trans R
fects as well as a physically motivated choice of the erosion and Soc A Math Phys Eng Sci 2002;360(1792):437–51. doi:10.1098/rsta.2001.0955.
sedimentation times Te and Ts . Furthermore, the presented model [25] Bouzidi M, Firdaouss M, Lallemand P. Momentum transfer of a Boltzmann-
can easily be extended to include two-way coupling, e.g. by locally lattice fluid with boundaries. Phys Fluids 2001;13:3452–9. doi:10.1063/1.
1399290.
modifying the viscosity of the fluid depending on the local sedi-
[26] Chikatamarla SS, Karlin IV. Entropic lattice Boltzmann method for turbulent
ment concentration. flow simulations: boundary conditions. Physica A 2013;392(9):1925–30. doi:10.
1016/j.physa.2012.12.034.
[27] Morrison HE, Brede M, Dehnhardt G, Leder A. Simulating the flow and trail
Acknowledgements following capabilities of harbour seal vibrissae with the lattice Boltzmann
method. J Comput Sci 2016. doi:10.1016/j.jocs.2016.04.004.
[28] Ladd AJC. Numerical simulations of particulate suspensions via a dis-
This work was financed by the International Leibniz Graduate cretized Boltzmann equation. part 1. theoretical foundation. J Fluid Mech
School for Gravity Waves and Turbulence in the Atmosphere and 1994;271:285–309. doi:10.1017/S0 0221120940 01771.
Ocean (ILWAO). [29] Dorschner B, Chikatamarla S, Bösch F, Karlin I. Grad’S approximation for mov-
ing and stationary walls in entropic lattice Boltzmann simulations. J Comput
Phys 2015;295:340–54. doi:10.1016/j.jcp.2015.04.017.
References [30] Wieselsberger C. Neuere feststellungen über die gesetze des flüssigkeits- und
luftwiderstandes. Physikalische Zeitschrift 1921;22:321–8.
[1] Wilkens RH, Richardson MD. Mine burial prediction: A Short history and in- [31] Tritton DJ. Experiments on the flow past a circular cylinder at low Reynolds
troduction. IEEE J Ocean Eng 2007;32(1):3–9. doi:10.1109/JOE.2007.894331. numbers. J Fluid Mech 1959;6(1936):547–67. doi:10.1017/S0 0221120590 0 0829.
[2] Olsen NRB, Kjellesvig HM. Three-dimensional numerical flow modeling for es- [32] Lima E Silva A, Silveira-Neto A, Damasceno J. Numerical simulation of
timation of maximum local scour depth. J Hydraul Res 1998;36(4):579–90. two-dimensional flows over a circular cylinder using the immersed bound-
doi:10.1080/00221689809498610. ary method. J Comput Phys 2003;189(2):351–70. doi:10.1016/S0021-9991(03)
[3] Zhao M, Cheng L, Zang Z. Experimental and numerical investigation of local 00214-6.
scour around a submerged vertical circular cylinder in steady currents. Coast [33] Shu C, Liu N, Chew YT. A novel immersed boundary velocity correction-lattice
Eng 2010;57(8):709–21. doi:10.1016/j.coastaleng.2010.03.002. Boltzmann method and its application to simulate flow past a circular cylinder.
[4] Escauriaza C, Sotiropoulos F. Initial stages of erosion and bed form develop- J Comput Phys 2007;226(2):1607–22. doi:10.1016/j.jcp.20 07.06.0 02.
ment in a turbulent flow around a cylindrical pier. J Geophys Res Earth Surf [34] Lallemand P, Luo L-S. Lattice Boltzmann method for moving boundaries. J
2011;116(3):1–24. doi:10.1029/2010JF001749. Comput Phys 2003;184(2):406–21. doi:10.1016/S0021- 9991(02)00022- 0.
[5] Kim HS, Nabi M, Kimura I, Shimizu Y. Numerical investigation of local scour [35] Lagrava D, Malaspinas O, Latt J, Chopard B. Advances in multi-domain lattice
at two adjacent cylinders. Adv Water Resour 2014;70:131–47. doi:10.1016/j. Boltzmann grid refinement. J Comput Phys 2012;231(14):4808–22. doi:10.1016/
advwatres.2014.04.018. j.jcp.2012.03.015.
[6] Hatton KA, Foster DL, Traykovski P, Smith HD. Numerical simulations of the [36] Leder A. 3D-flow structures behind truncated circular cylinders. In: Proceed-
flow and sediment transport regimes surrounding a short cylinder. IEEE J ings of the ASME/JSME fourth joint fluids summer engineering conference,
Ocean Eng 2007;32(1):249–59. doi:10.1109/JOE.2007.890986. volume 2: symposia, parts A, B, and C. ASME; 2003. p. 825–31. doi:10.1115/
[7] Dixen M, Sumer BM, Fredsøe J. Numerical and experimental investigation of FEDSM2003-45083. ISBN 0-7918-3697-5.
flow and scour around a half-buried sphere. Coast Eng 2013;73(2005):84–105. [37] Richter F, Leder A. Dreidimensionale Strömungs-und Turbulenzstrukturen im
doi:10.1016/j.coastaleng.2012.10.006. Nachlauf eines Kreiszylinderstumpfes.. In: Proceedings of the Fachtagung
[8] Aidun CK, Clausen JR. Lattice-Boltzmann method for complex flows. Annu Rev Lasermethoden in der Strömungsmesstechnik. Universität Karlsruhe; 2004.
Fluid Mech 2010;42(1):439–72. doi:10.1146/annurev- fluid- 121108- 145519. [38] Richter F. Experimentelle Untersuchungen zur Charakterisierung der Strö-
[9] Karlin IV, Bösch F, Chikatamarla SS. Gibbs’ Principle for the lattice-kinetic the- mungs- und Turbulenzstrukturen im Nachlauf eines Kreiszylinderstumpfes
ory of fluid dynamics. Phys Rev E 2014;90(3):031302. doi:10.1103/PhysRevE.90. unter Berücksichtigung der Zentrifugalbeschleunigung. Universität Rostock;
031302. 2005. [Ph.D. thesis].
H.E. Morrison, A. Leder / Computers and Fluids 172 (2018) 340–351 351

[39] Jensch M, Brede M, Richter F, Leder A. Verwendung des Time-Resolved Stere- [47] Ginzburg I. Equilibrium-type and link-type lattice Boltzmann models for
o-PIV Messsystems zur Ermittlung zeitaufgelöster Geschwindigkeitsfelder im generic advection and anisotropic-dispersion equation. Adv Water Resour
Nachlauf eines Kreiszylinders. In: Proceedings of the Lasermethoden in der 2005;28(11):1171–95. doi:10.1016/j.advwatres.2005.03.004.
Strömungsmesstechnik - 14. Fachtagung der GALA e.V.. PTB Braunschweig; [48] Stiebler M, Tölke J, Krafczyk M. Advection-diffusion lattice boltzmann
2006. p. 39.1–39.8. scheme for hierarchical grids. Computers and Mathematics with Applications
[40] Jensch M, Hüttmann F, Brede M, Leder A. Optical measurements in the 2008;55(7):1576–84. doi:10.1016/j.camwa.2007.08.024.
wake of a circular cylinder of finite length at a high Reynolds number. [49] Lätt J. Hydrodynamic limit of lattice Boltzmann equations. Univ. Genève; 2007.
Notes Numer Fluid Mech Multidiscip Des 2009;106:185–95. doi:10.1007/ Dissertation. http://archive-ouverte.unige.ch/unige:464
978- 3- 642- 01106- 1_19. [50] Yoshida H, Nagaoka M. Multiple-relaxation-time lattice Boltzmann model
[41] Frederich O, Wassen E, Thiele F, Jensch M, Brede M, Hüttmann F, et al. Numer- for the convection and anisotropic diffusion equation. J Comput Phys
ical simulation of the flow around a finite cylinder with ground plate in com- 2010;229(20):7774–95. doi:10.1016/j.jcp.2010.06.037.
parison to experimental measurements. In: New Results in Numerical and Ex- [51] Chopard B, Falcone JL, Latt J. The lattice Boltzmann advection–diffusion
perimental Fluid Mechanics VI, 96. Berlin, Heidelberg: Springer Berlin Heidel- model revisited. Eur Phys J Spec Top 2009;171(1):245–9. doi:10.1140/epjst/
berg; 2007. p. 348–55. doi:10.1007/978- 3- 540- 74460- 3_43. ISBN 0179–9614. e2009- 01035- 5.
[42] Frederich O, Wassen E, Thiele F. Prediction of the flow around a short wal- [52] Soulsby R. Dynamics of marine sands. Thomas Telford Ltd; 1997. doi:10.1680/
l-mounted finite cylinder using LES and DES. J Numer Anal Ind Appl Math doms.25844. ISBN 978-0-7277-2584-4.
2008;3(3–4):231–47. [53] Guo J. Hunter rouse and shields diagram. Adv Hydraul Water Eng
[43] Frederich O, Scouten J, Luchtenburg DM, Thiele F. Numerical simulation and 2002;2:1096–8. doi:10.1142/9789812776969_0200.
analysis of the flow around a wall-mounted finite cylinder. In: Imaging Mea- [54] Stahl B, Chopard B, Latt J. Measurements of wall shear stress with the lattice
surement Methods for Flow Analysis, 106; 2009. p. 207–16. doi:10.1007/ Boltzmann method and staircase approximation of boundaries. Comput Fluids
978- 3- 642- 01106- 1_21. ISBN 1612–2909. 2010;39(9):1625–33. doi:10.1016/j.compfluid.2010.05.015.
[44] Frederich O. Numerische Simulation und Analyse turbulenter Strömungen am [55] Matyka M, Koza Z, Mirosław Ł. Wall orientation and shear stress in the lat-
Beispiel der Umströmung eines Zylinderstumpfes mit Endscheibe. Technische tice Boltzmann model. Comput Fluids 2013;73:115–23. doi:10.1016/j.compfluid.
Universität Berlin; 2010. Ph.D. thesis. 2012.12.018. 1203.3078.
[45] Chikatamarla SS, Ansumali S, Karlin IV. Grad’s approximation for missing data [56] Menzel P, Rückborn T, Leder A. Flow and scour around cylindrical objects in
in lattice Boltzmann simulations. Europhys Lett 2006;74(2):215–21. doi:10. laboratory experiments. 2013 MTS/IEEE OCEANS - Bergen 2013:1–8.
1209/epl/i2005- 10535- x.
[46] Flekkøy EG. Lattice Bhatnagar–Gross–Krook models for miscible fluids. Phys
Rev E 1993;47(6):4247–57. doi:10.1103/PhysRevE.47.4247.

Вам также может понравиться