SlideShare a Scribd company logo
The lattice Boltzmann equation: background,
boundary conditions, and Burnett-order
stress
Tim Reis
School of Computing and Mathematical Sciences
University of Greenwich
Imperial College
November 2019
Acknowledgments: Sam Bennett (formerly Cambridge), Paul
Dellar (Oxford), Andreas Hantsch (ILK Dresden), Rebecca
Allen (SINTEF), Seemaa Mohammed (Baghdad), Dave
Graham (Plymouth)
The standard (D2Q9) lattice Boltzmann equation
fi(x + ci∆t, t + ∆t) − fi(x, t) = −
∆t
τ + ∆t/2
fi(x, t) − f
(0)
i (x, t)
Standard boundary condition: fi(wall) = f−i(wall)
Lid-driven cavity flow: Re=7500
Flow in porous media
https://www.tytlabs.com/english/review/
rev381epdf/e381_017hayashi.pdf
Velocity profile: Poiseuille flow, Re = 100
Using bounce–back boundary conditions, we appear to get an
accurate solution at moderate Re numbers . . .
Velocity profile: Poiseuille flow
. . . but not at smaller Reynolds numbers
• Worrying for flows in porous media
• This is not Knudsen slip
• We should be able to get the exact solution
Overview
Derivation of the lattice Boltzmann equation
• From kinetic theory to hydrodynamics
• Matching moments: from continuous to discrete kinetic
theory
• From discrete Boltzmann to lattice Boltzmann
(PDEs to numerics)
Boundary conditions
• Exact solutions to the LBE in simple flows
• Numerical slip
• Moment-based boundary conditions
Applications (but not to porous media!)
Stress and analysis of the algorithm
The kinetic theory of gases
The Navier-Stokes equations for a Newtonian fluid can be
derived from Boltzmann’s equation for a monotomic gas
∂f
∂t
+ c · f = Ω(f)
where f = f(x, c, t) is the distribution function of particles at x
and t with velocity c:
(Image courtesy of Prof. Paul Dellar)
Hydrodynamics from moments
Hydrodynamic quantities are moments of the distribution
function f:
ρ(x, t) = f(x, c, t)dc,
u(x, t) =
1
ρ
cf(x, c, t)dc,
θ(x, t) =
1
3ρ
|c − u|2
f(x, c, t)dc.
The collision operator Ω(f) drives f back to the
Maxwell-Boltzmann distribution
f(0)
=
ρ
(2θπ)3/2
exp −
|c − u|2
2θ
.
From kinetic theory to fluid dynamics
Recall Boltzmann’s equation
∂f
∂t
+ c · f = Ω(f)
Assume f relaxes towards f(0) with a single relaxation time τ:
∂f
∂t
+ c · f = −
1
τ
f − f(0)
The zeroth and first moments of the Boltzmann equation give
exact conservation laws:
∂ρ
∂t
+ · (ρu) = 0,
∂ρu
∂t
+ · ΠΠΠ = 0
Evolution of the momentum flux
The momentum flux ΠΠΠ is given by another moment
ΠΠΠ = fccdc, and ΠΠΠ(0)
= f(0)
ccdc.
ΠΠΠ is not conserved by collisions. It evolves according to
∂ΠΠΠ
∂t
+ · QQQ = −
1
τ
ΠΠΠ − ΠΠΠ(0)
,
where
ΠΠΠ(0)
= ρuu + ρθI, and QQQ = fcccdc.
Hydrodynamics follow by exploiting τ T.
S. Chapman and T.G Cowling (1970) Thanks to Prof. Dellar
"Reading this book is like chewing glass [S. Chapman]"
Thanks to Prof. Dellar
Discrete kinetic theory
Look to simplify Boltzmann’s equation without losing the
properties needed to recover the Navier-Stokes equation.
Discetise the velocity space such that c is confined to a set
c0, c1, . . . , cN, e.g
The distribution function is f(x, c, t) is replaced by fi(x, t).
The discrete Boltzmann equation
The Boltzmann equation with discrete velocities is
∂fi
∂t
+ ci · fi = −
1
τ
fi − f
(0)
i
We now supply the equilibrium function, for example
f
(0)
i = Wiρ 1 +
1
θ
u · ci +
1
2θ2
(u · ci)2
−
1
2θ
|u|2
The previous integrals are now replaced by summations:
ρ =
i
fi =
i
f
(0)
i ,
ρu =
i
fici =
i
f
(0)
i ci
ΠΠΠ(0)
=
i
f
(0)
i cici = ρuu + θρI.
Moment equations
∂fi
∂t
+ ci · fi = −
1
τ
fi − f
(0)
i
Taking the zeroth, first, and second moments of the discrete
Boltzmann equation give
∂ρ
∂t
+ · (ρu) = 0
∂ρu
∂t
+ · ΠΠΠ = 0
∂ΠΠΠ
∂t
+ · QQQ = −
1
τ
ΠΠΠ − ΠΠΠ(0)
Note that we did exactly the same for the continuum Boltzmann
equation
Chapman-Enskog expansion
Hydrodynamics now follows from seeking solutions to
∂fi
∂t
+ ci · fi = −
1
τ
fi − f
(0)
i
that vary slowly compared with the timescale τ.
ΠΠΠ = ΠΠΠ(0)
+ τΠΠΠ(1)
+ τ2
ΠΠΠ(2)
. . . , QQQ = QQQ(0)
+ τQQQ(1)
+ τ2
QQQ(2)
. . .
Also expand the temporal derivative:
∂
∂t
=
∂
∂t0
+ τ
∂
∂t1
. . .
Hydrodynamics from moments
Substituting these expansions into the moment equations and
truncating at O(1) we obtain
∂ρ
∂t0
+ · (ρu) = 0,
∂ρu
∂t0
+ · ΠΠΠ(0)
= 0,
∂ΠΠΠ(0)
∂t0
+ · QQQ(0)
= −ΠΠΠ(1)
Calculating the viscous stress tensor
For the Navier-Stokes equation we need to compute the first
correction ΠΠΠ(1) to the momentum flux.
∂ΠΠΠ(0)
∂t0
+ · QQQ(0)
= −ΠΠΠ(1)
Given ΠΠΠ(0) = ρθI + ρuu we find that
∂t0
Π
(0)
βγ = −θδβγ∂α(ρuα) − θuβ∂γρ − θuγ∂βρ − ∂α(ρuαuβuγ),
∂αQ
(0)
αβγ = θδβγ∂α(ρuα) + θ∂β(ρuγ) + θ∂γ(ρuβ)
Assembling the Navier-Stokes equations
The viscous stress is then found to be
ΠΠΠ(1)
= −ρθ u + ( u)T
+ O(Ma3
)
We have obtained the (compressible) Navier-Stokes equations
∂t ρ + · (ρu) = 0, ∂t (ρu) + · ΠΠΠ(0)
+ τΠΠΠ(1)
= 0
where µ = τρθ
From discrete Boltzmann to lattice Boltzmann
Integrating the discrete Boltzmann equation
∂fi
∂t
+ ci · fi = Ωi(f)
along a characteristic for time ∆t gives
fi(x + ci∆t, t + ∆t) − fi(x, t) =
∆t
0
Ωi(x + cis, t + s) ds
Approximating the integral by the trapezium rule yields
fi(x +ci∆t, t+∆t)−fi(x, t) =
∆t
2
Ωi(x +ci∆t, t+∆t)
+ Ωi(x, t) +O ∆t3
where Ωi = − fi − f
(0)
i /τ
Change of Variables
To obtain a second order explicit LBE at time t + ∆t define
fi(x, t) = fi(x, t) +
∆t
2τ
fi(x, t) − f
(0)
i (x, t)
The new algorithm is
fi(x + ci∆t, t + ∆t) − fi(x, t) = −
∆t
τ + ∆t/2
fi(x, t) − f
(0)
i (x, t)
Roll-up of shear waves
Roll-up of shear layers in Minion & Brown [1997] test problem,
ux =
tanh(κ(y − 1/4)), y ≤ 1/2,
tanh(κ(3/4 − y)), y > 1/2,
uy = δ sin(2π(x + 1/4)).
Roll-up of Shear wave with LBE
Re = 30, 000, κ = 80 and δ = 0.05
Gridsize: 1282. On GPU: 600 MLUPS
Used in oil and automotive industry
Courtesy of Xflow [www.xflowcfd.com]
But remember. . .
Planar channel flow, bounce-back boundary
conditions, Re=1
Can we understand and eliminate this error?
Analytical solution of the LBE in Poiseuille flow
Consider flows satisfying
∂
∂x
=
∂
∂t
= 0, ρ = ρ0 (constant)
Walls located at j = 1 and j = n
In this case we can solve the LBE for the velocity field exactly
and find that. . .
. . . the LBE recurrence relation reduces to
uj+1vj+1 − uj−1vj−1
2
= ν uj+1 + uj−1 − 2uj + G,
where G is the constant pressure gradient
This is just a second order finite–difference form of the
incompressible Navier–Stokes equations with a constant body
force:
∂(uv)
∂y
= ν
∂2u
∂y2
+ G
Solution to the difference equation
We can show that vj = 0 and
uj =
4Uc
(n − 1)2
(j − 1)(n − j) + Us, j = 1, 2, . . . , n
where Uc = H2G/8ν is the center-line velocity and H = (n − 1)
is the channel height.
Thus we have the exact solution to Poiseuille flow but with the
parabola shifted by Us
Numerical slip for bounce–back
If we use bounce–back boundary conditions, we find the
numerical slip to be He et al. [1997]
Us =
48ν2 − 1
8ν
G
Moments at a wall
ρ = f0 + f1 + f2 + f3 + f4 + f5 + f6 + f7 + f8,
ρux = f1 − f3 + f5 − f6 − f7 + f8,
ρuy = f2 − f4 + f5 + f6 − f7 − f8.
Moment-based boundary conditions
THE PLAN:
Formulate the boundary conditions in the moment basis, and
then transform them into into boundary conditions for the
distribution functions Bennett [2010].
Moments Combination of unknowns
ρ, ρuy , Πyy f2 + f5 + f6
ρux , Πxy , Qxyy f5 − f6
Πxx , Qxxy , Rxxyy f5 + f6
We can pick one constraint from each group. A natural choice is
ρuy = 0,
ρux = ρuslip,
Πxx = θρ + ρu2
slip =⇒
∂uslip
∂x
= 0.
It really is quite simple
For no-slip, these conditions translate into
f2 = f1 + f3 + f4 + 2 f7 + f8 −
ρ
3
,
f5 = −f1 − f8 +
ρ
6
,
f6 = −f3 − f7 +
ρ
6
,
Lid-driven cavity flow: Re = 7500
Lid-driven cavity flow: the numbers
Primary
Re = 400
Present Λ = 1/4 0.1139 0.5547 0.6055
Ghia et al. 0.1139 0.5547 0.6055
Sahin and Owens 0.1139 0.5536 0.6075
Re = 1000
Present Λ = 1/4 0.1189 0.5313 0.5664
Ghia et al. 0.1179 0.5313 0.5625
Sahin and Owens 0.1188 0.5335 0.5639
Botella et al. 0.1189 0.4692 0.5652
Re = 7500
Present Λ = 1/4 0.1226 0.5117 0.5352
Ghia et al. 0.1200 0.5117 0.5322
Sahin and Owens 0.1223 0.5134 0.5376
Note: Second order convergence of L2 error norm for global
velocity and pressure fields
Dipole wall collision
With the following initial conditions, two counter–rotating
voticies are self–propelled to the right:
u0 = −
1
2
|ω| (y − y1) exp (−r1/r0)2
+
1
2
|ω| (y − y2) exp (−r2/r0)2
,
v0 =
1
2
|ω| (x − x1) exp (−r1/r0)2
−
1
2
|ω| (x − x2) exp (−r2/r0)2
.
Dipole wall collision: Re=2500
Extensively benchmarked and used to study this flow in new
parameter regimes [Mohammed, Graham, TR (2018)]
https://timreis.org/publications/
Dipole wall collision: Re=10000
Extensively benchmarked and used to study this flow in new
parameter regimes [Mohammed, Graham, TR (2018)]
https://timreis.org/publications/
Oblique dipole wall collision: Re=2500, θ = π/4
Extensively benchmarked and used to study this flow in new
parameter regimes [Mohammed, Graham, TR (2018)]
https://timreis.org/publications/
Vorticity snapshots at t = 1
(Left to right: Re=625, 1250, 2500, 5000)
Extensively benchmarked and used to study this flow in new
parameter regimes [Mohammed, Graham, TR (2018)]
https://timreis.org/publications/
The moment-based approach to boundary conditions
as presented is. . .
• accurate
• local
• quite general (been used for natural convection problems
[Allen, TR (2016)] and imposing contact angles [Hantsch,
TR (2015)]) https://timreis.org/publications/
• being extended to 3D
• pretty stable
• really hard to extend to complex geometries!
The last point means we cannot use it for flows in porous
media. However, it has other uses. . .
Flow in a microchannel
LBE is restricted to capturing the first few moments of the
Boltzmann equation.
In shear flow the LBE reduces to a linear second–order
recurrence relation =⇒ linear or parabolic profiles at all Kn.
Maxwell–Navier boundary condition
Wall boundary conditions:
uslip = σKnH∂y u|wall , σ = (2 − σa)/σa.
These can be expressed in terms of moments:
f2 = f1 + f3 + f4 + 2 f7 + f8 − P − ρu2
slip ,
f5 = −f1 − f8 + (P + ρu2
slip + ρuslip)/2,
f6 = −f3 − f7 + (P + ρu2
slip − ρuslip)/2,
and since Πxy |wall =
2τ ¯Πxy |wall
(2τ+∆t) = µ∂y u|wall,
uslip = −
6λ −f1 + f3 + 2f7 − 2f8
ρ(2τ + 1 + 6KnH)
.
Flow in a microchannel: asymptotic solution
We consider a viscous fluid in a channel with an aspect ratio
δ = L/H 1.
The relevant dimensionless numbers are
Re =
ρoUoH
µ
, Ma =
Uo
√
γRT
, Kn =
πγ
2
Ma
Re
An expansion in δ yields the leading–order solution
u(x, y) = −
Re
8Ma2
p 1 − 4y2
+ 4σ
Kn
p
v(x, y) =
2Re
8pMa2
1
2
(p2
) 1 −
4
3
y2
+ 4σKnp
P (x) = (6Kn)2
+ (1 + 12Kn)x + θ(θ + 12Kn)(1 − x) − 6Kn
Flow in a microchannel: Kn = 0.1
Convergence
[TR, Dellar (2012)]
https://timreis.org/publications/
The plot thickens
Consider again uni-directional, steady, flow in in infinite channel
Consider flows satisfying
∂
∂x
=
∂
∂t
= 0
Here, the tangential component of the stress should vanish,
Txx ∝ ∂u/∂x = 0.
However, with LBE. . .
Deviatoric stress in Poiseuille flow, Re = 100
For Newtonian fluids: Txx ∝ ∂u/∂x = 0
From Burnett: Txx = −2µτ(∂u/∂y)2
Analysis of the stress field
The Tj
xx are found to be
3 4τ2
− 1 Tj+1
xx − 2Tj
xx + Tj−1
xx − 12Tj
xx =
4τ2
ρ u2
j−1 − 2u2
j + u2
j+1 − 16τ3
ρG uj+1 + uj−1 − 2uj
+6τρG uj+1 + uj−1 + 2uj .
The homogenous solution is
Tj
xx = Amj
+ Bm−j
,
where A and B are constants and
m =
2τ + 1
2τ − 1
.
Deviatoric stress solution
The particular integral is
T
j(PI)
xx = −2µτ u
2
+ ρG2
(16τ2
− 1)
Recall the Navier–Stokes boundary condition
Πxx = Π
(0)
xx =⇒ Txx = 0
Hence
A =
mn−1 − 1
m m2n−2 − 1
TW
,
B =
mn mn−1 − 1
m2n−2 − 1
TW
,
where TW is the particular integral evaluated at the wall.
Inconsistency
Stress boundary conditions
A consistent boundary condition for the stress is [TR (2020)]
https://timreis.org/publications/
Πxx =
ρ
3
+
12τ
ρ (2τ + ∆t)
Π
2
xy
Finite difference interpretation
Solving the lattice Boltzmann recurrence equation
3 4τ2
− 1 Tj+1
xx − 2Tj
xx + Tj−1
xx − 12Tj
xx
= 4τ2
ρ u2
j−1 − 2u2
j + u2
j+1
− 16τ3
ρG uj+1 + uj−1 − 2uj
+ 6τρG uj+1 + uj−1 + 2uj
τ2 = 1/4 =⇒ no recurrence in non–conserved moments
τ2 = 1/6 =⇒ Lele’s compact finite difference scheme [Lele 92]
Two relaxation time LBE
Relax odd and even moments at different rates:
fi (x + ci, t + ∆t) = fi (x, t) −
1
τ+ + 1/2
1
2
fi + fk − f
(0+)
i
−
1
τ− + 1/2
1
2
fi − fk − f
(0−)
i
Solving the recurrence yields
3 (4Λ − 1) Tj+1
xx − 2Tj
xx + Tj−1
xx − 12Tj
xx
= 4Λρ u2
j−1 − 2u2
j + u2
j+1
− 16ΛτρG uj+1 + uj−1 − 2uj
+ 6τρG uj+1 + uj−1 + 2uj
where Λ = τ+τ−
TRT results, Λ = 1/4
Txx = 2τ+
µuu −
2Λ
3
uu + u
2
Summary
The kinetic formulation yields a linear, constant coefficient
hyperbolic system where all nonlinearities are confined to
algebraic source terms.
Nonlinearity is local, non-locality is linear Sauro Succi
The LBE in its standard form does NOT capture kinetic effects
in the velocity field but more subtle effects manifest themselves
in the stress at O(τ2)
Analytic solutions of the LBE for simple flows gives insight into
its numerical and physical characteristics
Formulating boundary conditions in term of moments allows us
to impose a variety of conditions exactly at grid points but, at
present, lacks geometric flexibility.
Acknowledgements
Many thanks to you for inviting me!
Many many thanks to Paul Dellar, Andreas Hantsch, Rebecca
Allen, Dave Graham, and Seemaa Mohammed
Natural Convection
Flow is driven by density variation
∂u
∂t
+ u · u = − P + Pr 2
u + RaPrg,
∂θ
∂t
+ u · θ = 2
θ,
Streamfunction and Temperature plots
Contours of flow fields for convection in a square cavity. From
left to right, Ra = 1000, Ra = 10000, Ra = 1000000 [Allen and
TR (2016)] https://timreis.org/publications/
Nusselt numbers
Ra Study Nu
103 Present 1.1178
de Vahl Davis 1.118
106
Present 8.8249
Le Quere 8.8252
de Vahl Davis 8.800
108
Present 30.23339
Le Quere 30.225
[Allen and TR (2016)]
https://timreis.org/publications/

More Related Content

What's hot

Chem 2 - Chemical Kinetics VII - Analyzing Reaction Mechanisms
Chem 2 - Chemical Kinetics VII - Analyzing Reaction MechanismsChem 2 - Chemical Kinetics VII - Analyzing Reaction Mechanisms
Chem 2 - Chemical Kinetics VII - Analyzing Reaction Mechanisms
Lumen Learning
 
Lecture 14 maxwell-boltzmann distribution. heat capacities
Lecture 14   maxwell-boltzmann distribution. heat capacitiesLecture 14   maxwell-boltzmann distribution. heat capacities
Lecture 14 maxwell-boltzmann distribution. heat capacities
Albania Energy Association
 
Isotherms
IsothermsIsotherms
Isothermsasad3
 
Applications of Bessel's Function.
Applications of Bessel's Function.Applications of Bessel's Function.
Applications of Bessel's Function.
KubraGhaffar
 
Phase Equilibria .Manik
Phase Equilibria .ManikPhase Equilibria .Manik
Phase Equilibria .Manik
Imran Nur Manik
 

What's hot (6)

Chem 2 - Chemical Kinetics VII - Analyzing Reaction Mechanisms
Chem 2 - Chemical Kinetics VII - Analyzing Reaction MechanismsChem 2 - Chemical Kinetics VII - Analyzing Reaction Mechanisms
Chem 2 - Chemical Kinetics VII - Analyzing Reaction Mechanisms
 
Lecture 14 maxwell-boltzmann distribution. heat capacities
Lecture 14   maxwell-boltzmann distribution. heat capacitiesLecture 14   maxwell-boltzmann distribution. heat capacities
Lecture 14 maxwell-boltzmann distribution. heat capacities
 
Enthalpy Hess's Law
Enthalpy Hess's LawEnthalpy Hess's Law
Enthalpy Hess's Law
 
Isotherms
IsothermsIsotherms
Isotherms
 
Applications of Bessel's Function.
Applications of Bessel's Function.Applications of Bessel's Function.
Applications of Bessel's Function.
 
Phase Equilibria .Manik
Phase Equilibria .ManikPhase Equilibria .Manik
Phase Equilibria .Manik
 

Similar to The lattice Boltzmann equation: background, boundary conditions, and Burnett-order stress

The lattice Boltzmann equation: background and boundary conditions
The lattice Boltzmann equation: background and boundary conditionsThe lattice Boltzmann equation: background and boundary conditions
The lattice Boltzmann equation: background and boundary conditions
Tim Reis
 
Understanding lattice Boltzmann boundary conditions through moments
Understanding lattice Boltzmann boundary conditions through momentsUnderstanding lattice Boltzmann boundary conditions through moments
Understanding lattice Boltzmann boundary conditions through moments
Tim Reis
 
Pinning and facetting in multiphase LBMs
Pinning and facetting in multiphase LBMsPinning and facetting in multiphase LBMs
Pinning and facetting in multiphase LBMs
Tim Reis
 
Natalini nse slide_giu2013
Natalini nse slide_giu2013Natalini nse slide_giu2013
Natalini nse slide_giu2013Madd Maths
 
Geometric and viscosity solutions for the Cauchy problem of first order
Geometric and viscosity solutions for the Cauchy problem of first orderGeometric and viscosity solutions for the Cauchy problem of first order
Geometric and viscosity solutions for the Cauchy problem of first order
Juliho Castillo
 
Linear response theory and TDDFT
Linear response theory and TDDFT Linear response theory and TDDFT
Linear response theory and TDDFT
Claudio Attaccalite
 
A multiphase lattice Boltzmann model with sharp interfaces
A multiphase lattice Boltzmann model with sharp interfacesA multiphase lattice Boltzmann model with sharp interfaces
A multiphase lattice Boltzmann model with sharp interfaces
Tim Reis
 
Statistics Homework Help
Statistics Homework HelpStatistics Homework Help
Statistics Homework Help
Statistics Homework Helper
 
Multiple Linear Regression Homework Help
Multiple Linear Regression Homework HelpMultiple Linear Regression Homework Help
Multiple Linear Regression Homework Help
Statistics Homework Helper
 
Decrease hysteresis for Shape Memory Alloys
Decrease hysteresis for Shape Memory AlloysDecrease hysteresis for Shape Memory Alloys
Decrease hysteresis for Shape Memory Alloys
hongcai20072008
 
dhirota_hone_corrected
dhirota_hone_correcteddhirota_hone_corrected
dhirota_hone_correctedAndy Hone
 
lecture-2-not.pdf
lecture-2-not.pdflecture-2-not.pdf
lecture-2-not.pdf
M.R POURMAND
 
Trilinear embedding for divergence-form operators
Trilinear embedding for divergence-form operatorsTrilinear embedding for divergence-form operators
Trilinear embedding for divergence-form operators
VjekoslavKovac1
 
Ultrasound lecture 1 post
Ultrasound lecture 1 postUltrasound lecture 1 post
Ultrasound lecture 1 post
lucky shumail
 
QMC: Operator Splitting Workshop, A New (More Intuitive?) Interpretation of I...
QMC: Operator Splitting Workshop, A New (More Intuitive?) Interpretation of I...QMC: Operator Splitting Workshop, A New (More Intuitive?) Interpretation of I...
QMC: Operator Splitting Workshop, A New (More Intuitive?) Interpretation of I...
The Statistical and Applied Mathematical Sciences Institute
 
Hierarchical matrices for approximating large covariance matries and computin...
Hierarchical matrices for approximating large covariance matries and computin...Hierarchical matrices for approximating large covariance matries and computin...
Hierarchical matrices for approximating large covariance matries and computin...
Alexander Litvinenko
 
Adaptive Restore algorithm & importance Monte Carlo
Adaptive Restore algorithm & importance Monte CarloAdaptive Restore algorithm & importance Monte Carlo
Adaptive Restore algorithm & importance Monte Carlo
Christian Robert
 
Dynamic response of oscillators to general excitations
Dynamic response of oscillators to general excitationsDynamic response of oscillators to general excitations
Dynamic response of oscillators to general excitationsUniversity of Glasgow
 
Recursive Compressed Sensing
Recursive Compressed SensingRecursive Compressed Sensing
Recursive Compressed Sensing
Pantelis Sopasakis
 

Similar to The lattice Boltzmann equation: background, boundary conditions, and Burnett-order stress (20)

The lattice Boltzmann equation: background and boundary conditions
The lattice Boltzmann equation: background and boundary conditionsThe lattice Boltzmann equation: background and boundary conditions
The lattice Boltzmann equation: background and boundary conditions
 
Understanding lattice Boltzmann boundary conditions through moments
Understanding lattice Boltzmann boundary conditions through momentsUnderstanding lattice Boltzmann boundary conditions through moments
Understanding lattice Boltzmann boundary conditions through moments
 
Pinning and facetting in multiphase LBMs
Pinning and facetting in multiphase LBMsPinning and facetting in multiphase LBMs
Pinning and facetting in multiphase LBMs
 
Natalini nse slide_giu2013
Natalini nse slide_giu2013Natalini nse slide_giu2013
Natalini nse slide_giu2013
 
Geometric and viscosity solutions for the Cauchy problem of first order
Geometric and viscosity solutions for the Cauchy problem of first orderGeometric and viscosity solutions for the Cauchy problem of first order
Geometric and viscosity solutions for the Cauchy problem of first order
 
Linear response theory and TDDFT
Linear response theory and TDDFT Linear response theory and TDDFT
Linear response theory and TDDFT
 
A multiphase lattice Boltzmann model with sharp interfaces
A multiphase lattice Boltzmann model with sharp interfacesA multiphase lattice Boltzmann model with sharp interfaces
A multiphase lattice Boltzmann model with sharp interfaces
 
Statistics Homework Help
Statistics Homework HelpStatistics Homework Help
Statistics Homework Help
 
Multiple Linear Regression Homework Help
Multiple Linear Regression Homework HelpMultiple Linear Regression Homework Help
Multiple Linear Regression Homework Help
 
Decrease hysteresis for Shape Memory Alloys
Decrease hysteresis for Shape Memory AlloysDecrease hysteresis for Shape Memory Alloys
Decrease hysteresis for Shape Memory Alloys
 
dhirota_hone_corrected
dhirota_hone_correcteddhirota_hone_corrected
dhirota_hone_corrected
 
lecture-2-not.pdf
lecture-2-not.pdflecture-2-not.pdf
lecture-2-not.pdf
 
Trilinear embedding for divergence-form operators
Trilinear embedding for divergence-form operatorsTrilinear embedding for divergence-form operators
Trilinear embedding for divergence-form operators
 
wave_equation
wave_equationwave_equation
wave_equation
 
Ultrasound lecture 1 post
Ultrasound lecture 1 postUltrasound lecture 1 post
Ultrasound lecture 1 post
 
QMC: Operator Splitting Workshop, A New (More Intuitive?) Interpretation of I...
QMC: Operator Splitting Workshop, A New (More Intuitive?) Interpretation of I...QMC: Operator Splitting Workshop, A New (More Intuitive?) Interpretation of I...
QMC: Operator Splitting Workshop, A New (More Intuitive?) Interpretation of I...
 
Hierarchical matrices for approximating large covariance matries and computin...
Hierarchical matrices for approximating large covariance matries and computin...Hierarchical matrices for approximating large covariance matries and computin...
Hierarchical matrices for approximating large covariance matries and computin...
 
Adaptive Restore algorithm & importance Monte Carlo
Adaptive Restore algorithm & importance Monte CarloAdaptive Restore algorithm & importance Monte Carlo
Adaptive Restore algorithm & importance Monte Carlo
 
Dynamic response of oscillators to general excitations
Dynamic response of oscillators to general excitationsDynamic response of oscillators to general excitations
Dynamic response of oscillators to general excitations
 
Recursive Compressed Sensing
Recursive Compressed SensingRecursive Compressed Sensing
Recursive Compressed Sensing
 

Recently uploaded

erythropoiesis-I_mechanism& clinical significance.pptx
erythropoiesis-I_mechanism& clinical significance.pptxerythropoiesis-I_mechanism& clinical significance.pptx
erythropoiesis-I_mechanism& clinical significance.pptx
muralinath2
 
Cancer cell metabolism: special Reference to Lactate Pathway
Cancer cell metabolism: special Reference to Lactate PathwayCancer cell metabolism: special Reference to Lactate Pathway
Cancer cell metabolism: special Reference to Lactate Pathway
AADYARAJPANDEY1
 
PRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATION
PRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATIONPRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATION
PRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATION
ChetanK57
 
EY - Supply Chain Services 2018_template.pptx
EY - Supply Chain Services 2018_template.pptxEY - Supply Chain Services 2018_template.pptx
EY - Supply Chain Services 2018_template.pptx
AlguinaldoKong
 
platelets_clotting_biogenesis.clot retractionpptx
platelets_clotting_biogenesis.clot retractionpptxplatelets_clotting_biogenesis.clot retractionpptx
platelets_clotting_biogenesis.clot retractionpptx
muralinath2
 
Anemia_ different types_causes_ conditions
Anemia_ different types_causes_ conditionsAnemia_ different types_causes_ conditions
Anemia_ different types_causes_ conditions
muralinath2
 
ESR_factors_affect-clinic significance-Pathysiology.pptx
ESR_factors_affect-clinic significance-Pathysiology.pptxESR_factors_affect-clinic significance-Pathysiology.pptx
ESR_factors_affect-clinic significance-Pathysiology.pptx
muralinath2
 
SCHIZOPHRENIA Disorder/ Brain Disorder.pdf
SCHIZOPHRENIA Disorder/ Brain Disorder.pdfSCHIZOPHRENIA Disorder/ Brain Disorder.pdf
SCHIZOPHRENIA Disorder/ Brain Disorder.pdf
SELF-EXPLANATORY
 
Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...
Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...
Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...
muralinath2
 
THE IMPORTANCE OF MARTIAN ATMOSPHERE SAMPLE RETURN.
THE IMPORTANCE OF MARTIAN ATMOSPHERE SAMPLE RETURN.THE IMPORTANCE OF MARTIAN ATMOSPHERE SAMPLE RETURN.
THE IMPORTANCE OF MARTIAN ATMOSPHERE SAMPLE RETURN.
Sérgio Sacani
 
Nutraceutical market, scope and growth: Herbal drug technology
Nutraceutical market, scope and growth: Herbal drug technologyNutraceutical market, scope and growth: Herbal drug technology
Nutraceutical market, scope and growth: Herbal drug technology
Lokesh Patil
 
Richard's entangled aventures in wonderland
Richard's entangled aventures in wonderlandRichard's entangled aventures in wonderland
Richard's entangled aventures in wonderland
Richard Gill
 
The ASGCT Annual Meeting was packed with exciting progress in the field advan...
The ASGCT Annual Meeting was packed with exciting progress in the field advan...The ASGCT Annual Meeting was packed with exciting progress in the field advan...
The ASGCT Annual Meeting was packed with exciting progress in the field advan...
Health Advances
 
RNA INTERFERENCE: UNRAVELING GENETIC SILENCING
RNA INTERFERENCE: UNRAVELING GENETIC SILENCINGRNA INTERFERENCE: UNRAVELING GENETIC SILENCING
RNA INTERFERENCE: UNRAVELING GENETIC SILENCING
AADYARAJPANDEY1
 
insect morphology and physiology of insect
insect morphology and physiology of insectinsect morphology and physiology of insect
insect morphology and physiology of insect
anitaento25
 
Orion Air Quality Monitoring Systems - CWS
Orion Air Quality Monitoring Systems - CWSOrion Air Quality Monitoring Systems - CWS
Orion Air Quality Monitoring Systems - CWS
Columbia Weather Systems
 
Predicting property prices with machine learning algorithms.pdf
Predicting property prices with machine learning algorithms.pdfPredicting property prices with machine learning algorithms.pdf
Predicting property prices with machine learning algorithms.pdf
binhminhvu04
 
NuGOweek 2024 Ghent - programme - final version
NuGOweek 2024 Ghent - programme - final versionNuGOweek 2024 Ghent - programme - final version
NuGOweek 2024 Ghent - programme - final version
pablovgd
 
justice-and-fairness-ethics with example
justice-and-fairness-ethics with examplejustice-and-fairness-ethics with example
justice-and-fairness-ethics with example
azzyixes
 
Structures and textures of metamorphic rocks
Structures and textures of metamorphic rocksStructures and textures of metamorphic rocks
Structures and textures of metamorphic rocks
kumarmathi863
 

Recently uploaded (20)

erythropoiesis-I_mechanism& clinical significance.pptx
erythropoiesis-I_mechanism& clinical significance.pptxerythropoiesis-I_mechanism& clinical significance.pptx
erythropoiesis-I_mechanism& clinical significance.pptx
 
Cancer cell metabolism: special Reference to Lactate Pathway
Cancer cell metabolism: special Reference to Lactate PathwayCancer cell metabolism: special Reference to Lactate Pathway
Cancer cell metabolism: special Reference to Lactate Pathway
 
PRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATION
PRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATIONPRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATION
PRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATION
 
EY - Supply Chain Services 2018_template.pptx
EY - Supply Chain Services 2018_template.pptxEY - Supply Chain Services 2018_template.pptx
EY - Supply Chain Services 2018_template.pptx
 
platelets_clotting_biogenesis.clot retractionpptx
platelets_clotting_biogenesis.clot retractionpptxplatelets_clotting_biogenesis.clot retractionpptx
platelets_clotting_biogenesis.clot retractionpptx
 
Anemia_ different types_causes_ conditions
Anemia_ different types_causes_ conditionsAnemia_ different types_causes_ conditions
Anemia_ different types_causes_ conditions
 
ESR_factors_affect-clinic significance-Pathysiology.pptx
ESR_factors_affect-clinic significance-Pathysiology.pptxESR_factors_affect-clinic significance-Pathysiology.pptx
ESR_factors_affect-clinic significance-Pathysiology.pptx
 
SCHIZOPHRENIA Disorder/ Brain Disorder.pdf
SCHIZOPHRENIA Disorder/ Brain Disorder.pdfSCHIZOPHRENIA Disorder/ Brain Disorder.pdf
SCHIZOPHRENIA Disorder/ Brain Disorder.pdf
 
Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...
Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...
Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...
 
THE IMPORTANCE OF MARTIAN ATMOSPHERE SAMPLE RETURN.
THE IMPORTANCE OF MARTIAN ATMOSPHERE SAMPLE RETURN.THE IMPORTANCE OF MARTIAN ATMOSPHERE SAMPLE RETURN.
THE IMPORTANCE OF MARTIAN ATMOSPHERE SAMPLE RETURN.
 
Nutraceutical market, scope and growth: Herbal drug technology
Nutraceutical market, scope and growth: Herbal drug technologyNutraceutical market, scope and growth: Herbal drug technology
Nutraceutical market, scope and growth: Herbal drug technology
 
Richard's entangled aventures in wonderland
Richard's entangled aventures in wonderlandRichard's entangled aventures in wonderland
Richard's entangled aventures in wonderland
 
The ASGCT Annual Meeting was packed with exciting progress in the field advan...
The ASGCT Annual Meeting was packed with exciting progress in the field advan...The ASGCT Annual Meeting was packed with exciting progress in the field advan...
The ASGCT Annual Meeting was packed with exciting progress in the field advan...
 
RNA INTERFERENCE: UNRAVELING GENETIC SILENCING
RNA INTERFERENCE: UNRAVELING GENETIC SILENCINGRNA INTERFERENCE: UNRAVELING GENETIC SILENCING
RNA INTERFERENCE: UNRAVELING GENETIC SILENCING
 
insect morphology and physiology of insect
insect morphology and physiology of insectinsect morphology and physiology of insect
insect morphology and physiology of insect
 
Orion Air Quality Monitoring Systems - CWS
Orion Air Quality Monitoring Systems - CWSOrion Air Quality Monitoring Systems - CWS
Orion Air Quality Monitoring Systems - CWS
 
Predicting property prices with machine learning algorithms.pdf
Predicting property prices with machine learning algorithms.pdfPredicting property prices with machine learning algorithms.pdf
Predicting property prices with machine learning algorithms.pdf
 
NuGOweek 2024 Ghent - programme - final version
NuGOweek 2024 Ghent - programme - final versionNuGOweek 2024 Ghent - programme - final version
NuGOweek 2024 Ghent - programme - final version
 
justice-and-fairness-ethics with example
justice-and-fairness-ethics with examplejustice-and-fairness-ethics with example
justice-and-fairness-ethics with example
 
Structures and textures of metamorphic rocks
Structures and textures of metamorphic rocksStructures and textures of metamorphic rocks
Structures and textures of metamorphic rocks
 

The lattice Boltzmann equation: background, boundary conditions, and Burnett-order stress

  • 1. The lattice Boltzmann equation: background, boundary conditions, and Burnett-order stress Tim Reis School of Computing and Mathematical Sciences University of Greenwich Imperial College November 2019 Acknowledgments: Sam Bennett (formerly Cambridge), Paul Dellar (Oxford), Andreas Hantsch (ILK Dresden), Rebecca Allen (SINTEF), Seemaa Mohammed (Baghdad), Dave Graham (Plymouth)
  • 2. The standard (D2Q9) lattice Boltzmann equation fi(x + ci∆t, t + ∆t) − fi(x, t) = − ∆t τ + ∆t/2 fi(x, t) − f (0) i (x, t) Standard boundary condition: fi(wall) = f−i(wall)
  • 4. Flow in porous media https://www.tytlabs.com/english/review/ rev381epdf/e381_017hayashi.pdf
  • 5. Velocity profile: Poiseuille flow, Re = 100 Using bounce–back boundary conditions, we appear to get an accurate solution at moderate Re numbers . . .
  • 6. Velocity profile: Poiseuille flow . . . but not at smaller Reynolds numbers • Worrying for flows in porous media • This is not Knudsen slip • We should be able to get the exact solution
  • 7. Overview Derivation of the lattice Boltzmann equation • From kinetic theory to hydrodynamics • Matching moments: from continuous to discrete kinetic theory • From discrete Boltzmann to lattice Boltzmann (PDEs to numerics) Boundary conditions • Exact solutions to the LBE in simple flows • Numerical slip • Moment-based boundary conditions Applications (but not to porous media!) Stress and analysis of the algorithm
  • 8. The kinetic theory of gases The Navier-Stokes equations for a Newtonian fluid can be derived from Boltzmann’s equation for a monotomic gas ∂f ∂t + c · f = Ω(f) where f = f(x, c, t) is the distribution function of particles at x and t with velocity c: (Image courtesy of Prof. Paul Dellar)
  • 9. Hydrodynamics from moments Hydrodynamic quantities are moments of the distribution function f: ρ(x, t) = f(x, c, t)dc, u(x, t) = 1 ρ cf(x, c, t)dc, θ(x, t) = 1 3ρ |c − u|2 f(x, c, t)dc. The collision operator Ω(f) drives f back to the Maxwell-Boltzmann distribution f(0) = ρ (2θπ)3/2 exp − |c − u|2 2θ .
  • 10. From kinetic theory to fluid dynamics Recall Boltzmann’s equation ∂f ∂t + c · f = Ω(f) Assume f relaxes towards f(0) with a single relaxation time τ: ∂f ∂t + c · f = − 1 τ f − f(0) The zeroth and first moments of the Boltzmann equation give exact conservation laws: ∂ρ ∂t + · (ρu) = 0, ∂ρu ∂t + · ΠΠΠ = 0
  • 11. Evolution of the momentum flux The momentum flux ΠΠΠ is given by another moment ΠΠΠ = fccdc, and ΠΠΠ(0) = f(0) ccdc. ΠΠΠ is not conserved by collisions. It evolves according to ∂ΠΠΠ ∂t + · QQQ = − 1 τ ΠΠΠ − ΠΠΠ(0) , where ΠΠΠ(0) = ρuu + ρθI, and QQQ = fcccdc. Hydrodynamics follow by exploiting τ T.
  • 12. S. Chapman and T.G Cowling (1970) Thanks to Prof. Dellar
  • 13. "Reading this book is like chewing glass [S. Chapman]" Thanks to Prof. Dellar
  • 14. Discrete kinetic theory Look to simplify Boltzmann’s equation without losing the properties needed to recover the Navier-Stokes equation. Discetise the velocity space such that c is confined to a set c0, c1, . . . , cN, e.g The distribution function is f(x, c, t) is replaced by fi(x, t).
  • 15. The discrete Boltzmann equation The Boltzmann equation with discrete velocities is ∂fi ∂t + ci · fi = − 1 τ fi − f (0) i We now supply the equilibrium function, for example f (0) i = Wiρ 1 + 1 θ u · ci + 1 2θ2 (u · ci)2 − 1 2θ |u|2 The previous integrals are now replaced by summations: ρ = i fi = i f (0) i , ρu = i fici = i f (0) i ci ΠΠΠ(0) = i f (0) i cici = ρuu + θρI.
  • 16. Moment equations ∂fi ∂t + ci · fi = − 1 τ fi − f (0) i Taking the zeroth, first, and second moments of the discrete Boltzmann equation give ∂ρ ∂t + · (ρu) = 0 ∂ρu ∂t + · ΠΠΠ = 0 ∂ΠΠΠ ∂t + · QQQ = − 1 τ ΠΠΠ − ΠΠΠ(0) Note that we did exactly the same for the continuum Boltzmann equation
  • 17. Chapman-Enskog expansion Hydrodynamics now follows from seeking solutions to ∂fi ∂t + ci · fi = − 1 τ fi − f (0) i that vary slowly compared with the timescale τ. ΠΠΠ = ΠΠΠ(0) + τΠΠΠ(1) + τ2 ΠΠΠ(2) . . . , QQQ = QQQ(0) + τQQQ(1) + τ2 QQQ(2) . . . Also expand the temporal derivative: ∂ ∂t = ∂ ∂t0 + τ ∂ ∂t1 . . .
  • 18. Hydrodynamics from moments Substituting these expansions into the moment equations and truncating at O(1) we obtain ∂ρ ∂t0 + · (ρu) = 0, ∂ρu ∂t0 + · ΠΠΠ(0) = 0, ∂ΠΠΠ(0) ∂t0 + · QQQ(0) = −ΠΠΠ(1)
  • 19. Calculating the viscous stress tensor For the Navier-Stokes equation we need to compute the first correction ΠΠΠ(1) to the momentum flux. ∂ΠΠΠ(0) ∂t0 + · QQQ(0) = −ΠΠΠ(1) Given ΠΠΠ(0) = ρθI + ρuu we find that ∂t0 Π (0) βγ = −θδβγ∂α(ρuα) − θuβ∂γρ − θuγ∂βρ − ∂α(ρuαuβuγ), ∂αQ (0) αβγ = θδβγ∂α(ρuα) + θ∂β(ρuγ) + θ∂γ(ρuβ)
  • 20. Assembling the Navier-Stokes equations The viscous stress is then found to be ΠΠΠ(1) = −ρθ u + ( u)T + O(Ma3 ) We have obtained the (compressible) Navier-Stokes equations ∂t ρ + · (ρu) = 0, ∂t (ρu) + · ΠΠΠ(0) + τΠΠΠ(1) = 0 where µ = τρθ
  • 21. From discrete Boltzmann to lattice Boltzmann Integrating the discrete Boltzmann equation ∂fi ∂t + ci · fi = Ωi(f) along a characteristic for time ∆t gives fi(x + ci∆t, t + ∆t) − fi(x, t) = ∆t 0 Ωi(x + cis, t + s) ds Approximating the integral by the trapezium rule yields fi(x +ci∆t, t+∆t)−fi(x, t) = ∆t 2 Ωi(x +ci∆t, t+∆t) + Ωi(x, t) +O ∆t3 where Ωi = − fi − f (0) i /τ
  • 22. Change of Variables To obtain a second order explicit LBE at time t + ∆t define fi(x, t) = fi(x, t) + ∆t 2τ fi(x, t) − f (0) i (x, t) The new algorithm is fi(x + ci∆t, t + ∆t) − fi(x, t) = − ∆t τ + ∆t/2 fi(x, t) − f (0) i (x, t)
  • 23. Roll-up of shear waves Roll-up of shear layers in Minion & Brown [1997] test problem, ux = tanh(κ(y − 1/4)), y ≤ 1/2, tanh(κ(3/4 − y)), y > 1/2, uy = δ sin(2π(x + 1/4)).
  • 24. Roll-up of Shear wave with LBE Re = 30, 000, κ = 80 and δ = 0.05 Gridsize: 1282. On GPU: 600 MLUPS
  • 25. Used in oil and automotive industry Courtesy of Xflow [www.xflowcfd.com] But remember. . .
  • 26. Planar channel flow, bounce-back boundary conditions, Re=1 Can we understand and eliminate this error?
  • 27. Analytical solution of the LBE in Poiseuille flow Consider flows satisfying ∂ ∂x = ∂ ∂t = 0, ρ = ρ0 (constant) Walls located at j = 1 and j = n In this case we can solve the LBE for the velocity field exactly and find that. . .
  • 28. . . . the LBE recurrence relation reduces to uj+1vj+1 − uj−1vj−1 2 = ν uj+1 + uj−1 − 2uj + G, where G is the constant pressure gradient This is just a second order finite–difference form of the incompressible Navier–Stokes equations with a constant body force: ∂(uv) ∂y = ν ∂2u ∂y2 + G
  • 29. Solution to the difference equation We can show that vj = 0 and uj = 4Uc (n − 1)2 (j − 1)(n − j) + Us, j = 1, 2, . . . , n where Uc = H2G/8ν is the center-line velocity and H = (n − 1) is the channel height. Thus we have the exact solution to Poiseuille flow but with the parabola shifted by Us
  • 30. Numerical slip for bounce–back If we use bounce–back boundary conditions, we find the numerical slip to be He et al. [1997] Us = 48ν2 − 1 8ν G
  • 31. Moments at a wall ρ = f0 + f1 + f2 + f3 + f4 + f5 + f6 + f7 + f8, ρux = f1 − f3 + f5 − f6 − f7 + f8, ρuy = f2 − f4 + f5 + f6 − f7 − f8.
  • 32. Moment-based boundary conditions THE PLAN: Formulate the boundary conditions in the moment basis, and then transform them into into boundary conditions for the distribution functions Bennett [2010]. Moments Combination of unknowns ρ, ρuy , Πyy f2 + f5 + f6 ρux , Πxy , Qxyy f5 − f6 Πxx , Qxxy , Rxxyy f5 + f6 We can pick one constraint from each group. A natural choice is ρuy = 0, ρux = ρuslip, Πxx = θρ + ρu2 slip =⇒ ∂uslip ∂x = 0.
  • 33. It really is quite simple For no-slip, these conditions translate into f2 = f1 + f3 + f4 + 2 f7 + f8 − ρ 3 , f5 = −f1 − f8 + ρ 6 , f6 = −f3 − f7 + ρ 6 ,
  • 35. Lid-driven cavity flow: the numbers Primary Re = 400 Present Λ = 1/4 0.1139 0.5547 0.6055 Ghia et al. 0.1139 0.5547 0.6055 Sahin and Owens 0.1139 0.5536 0.6075 Re = 1000 Present Λ = 1/4 0.1189 0.5313 0.5664 Ghia et al. 0.1179 0.5313 0.5625 Sahin and Owens 0.1188 0.5335 0.5639 Botella et al. 0.1189 0.4692 0.5652 Re = 7500 Present Λ = 1/4 0.1226 0.5117 0.5352 Ghia et al. 0.1200 0.5117 0.5322 Sahin and Owens 0.1223 0.5134 0.5376 Note: Second order convergence of L2 error norm for global velocity and pressure fields
  • 36. Dipole wall collision With the following initial conditions, two counter–rotating voticies are self–propelled to the right: u0 = − 1 2 |ω| (y − y1) exp (−r1/r0)2 + 1 2 |ω| (y − y2) exp (−r2/r0)2 , v0 = 1 2 |ω| (x − x1) exp (−r1/r0)2 − 1 2 |ω| (x − x2) exp (−r2/r0)2 .
  • 37. Dipole wall collision: Re=2500 Extensively benchmarked and used to study this flow in new parameter regimes [Mohammed, Graham, TR (2018)] https://timreis.org/publications/
  • 38. Dipole wall collision: Re=10000 Extensively benchmarked and used to study this flow in new parameter regimes [Mohammed, Graham, TR (2018)] https://timreis.org/publications/
  • 39. Oblique dipole wall collision: Re=2500, θ = π/4 Extensively benchmarked and used to study this flow in new parameter regimes [Mohammed, Graham, TR (2018)] https://timreis.org/publications/
  • 40. Vorticity snapshots at t = 1 (Left to right: Re=625, 1250, 2500, 5000) Extensively benchmarked and used to study this flow in new parameter regimes [Mohammed, Graham, TR (2018)] https://timreis.org/publications/
  • 41. The moment-based approach to boundary conditions as presented is. . . • accurate • local • quite general (been used for natural convection problems [Allen, TR (2016)] and imposing contact angles [Hantsch, TR (2015)]) https://timreis.org/publications/ • being extended to 3D • pretty stable • really hard to extend to complex geometries! The last point means we cannot use it for flows in porous media. However, it has other uses. . .
  • 42. Flow in a microchannel LBE is restricted to capturing the first few moments of the Boltzmann equation. In shear flow the LBE reduces to a linear second–order recurrence relation =⇒ linear or parabolic profiles at all Kn.
  • 43. Maxwell–Navier boundary condition Wall boundary conditions: uslip = σKnH∂y u|wall , σ = (2 − σa)/σa. These can be expressed in terms of moments: f2 = f1 + f3 + f4 + 2 f7 + f8 − P − ρu2 slip , f5 = −f1 − f8 + (P + ρu2 slip + ρuslip)/2, f6 = −f3 − f7 + (P + ρu2 slip − ρuslip)/2, and since Πxy |wall = 2τ ¯Πxy |wall (2τ+∆t) = µ∂y u|wall, uslip = − 6λ −f1 + f3 + 2f7 − 2f8 ρ(2τ + 1 + 6KnH) .
  • 44. Flow in a microchannel: asymptotic solution We consider a viscous fluid in a channel with an aspect ratio δ = L/H 1. The relevant dimensionless numbers are Re = ρoUoH µ , Ma = Uo √ γRT , Kn = πγ 2 Ma Re An expansion in δ yields the leading–order solution u(x, y) = − Re 8Ma2 p 1 − 4y2 + 4σ Kn p v(x, y) = 2Re 8pMa2 1 2 (p2 ) 1 − 4 3 y2 + 4σKnp P (x) = (6Kn)2 + (1 + 12Kn)x + θ(θ + 12Kn)(1 − x) − 6Kn
  • 45. Flow in a microchannel: Kn = 0.1
  • 47. The plot thickens Consider again uni-directional, steady, flow in in infinite channel Consider flows satisfying ∂ ∂x = ∂ ∂t = 0 Here, the tangential component of the stress should vanish, Txx ∝ ∂u/∂x = 0. However, with LBE. . .
  • 48. Deviatoric stress in Poiseuille flow, Re = 100 For Newtonian fluids: Txx ∝ ∂u/∂x = 0 From Burnett: Txx = −2µτ(∂u/∂y)2
  • 49. Analysis of the stress field The Tj xx are found to be 3 4τ2 − 1 Tj+1 xx − 2Tj xx + Tj−1 xx − 12Tj xx = 4τ2 ρ u2 j−1 − 2u2 j + u2 j+1 − 16τ3 ρG uj+1 + uj−1 − 2uj +6τρG uj+1 + uj−1 + 2uj . The homogenous solution is Tj xx = Amj + Bm−j , where A and B are constants and m = 2τ + 1 2τ − 1 .
  • 50. Deviatoric stress solution The particular integral is T j(PI) xx = −2µτ u 2 + ρG2 (16τ2 − 1) Recall the Navier–Stokes boundary condition Πxx = Π (0) xx =⇒ Txx = 0 Hence A = mn−1 − 1 m m2n−2 − 1 TW , B = mn mn−1 − 1 m2n−2 − 1 TW , where TW is the particular integral evaluated at the wall.
  • 52. Stress boundary conditions A consistent boundary condition for the stress is [TR (2020)] https://timreis.org/publications/ Πxx = ρ 3 + 12τ ρ (2τ + ∆t) Π 2 xy
  • 53. Finite difference interpretation Solving the lattice Boltzmann recurrence equation 3 4τ2 − 1 Tj+1 xx − 2Tj xx + Tj−1 xx − 12Tj xx = 4τ2 ρ u2 j−1 − 2u2 j + u2 j+1 − 16τ3 ρG uj+1 + uj−1 − 2uj + 6τρG uj+1 + uj−1 + 2uj τ2 = 1/4 =⇒ no recurrence in non–conserved moments τ2 = 1/6 =⇒ Lele’s compact finite difference scheme [Lele 92]
  • 54. Two relaxation time LBE Relax odd and even moments at different rates: fi (x + ci, t + ∆t) = fi (x, t) − 1 τ+ + 1/2 1 2 fi + fk − f (0+) i − 1 τ− + 1/2 1 2 fi − fk − f (0−) i Solving the recurrence yields 3 (4Λ − 1) Tj+1 xx − 2Tj xx + Tj−1 xx − 12Tj xx = 4Λρ u2 j−1 − 2u2 j + u2 j+1 − 16ΛτρG uj+1 + uj−1 − 2uj + 6τρG uj+1 + uj−1 + 2uj where Λ = τ+τ−
  • 55. TRT results, Λ = 1/4 Txx = 2τ+ µuu − 2Λ 3 uu + u 2
  • 56. Summary The kinetic formulation yields a linear, constant coefficient hyperbolic system where all nonlinearities are confined to algebraic source terms. Nonlinearity is local, non-locality is linear Sauro Succi The LBE in its standard form does NOT capture kinetic effects in the velocity field but more subtle effects manifest themselves in the stress at O(τ2) Analytic solutions of the LBE for simple flows gives insight into its numerical and physical characteristics Formulating boundary conditions in term of moments allows us to impose a variety of conditions exactly at grid points but, at present, lacks geometric flexibility.
  • 57. Acknowledgements Many thanks to you for inviting me! Many many thanks to Paul Dellar, Andreas Hantsch, Rebecca Allen, Dave Graham, and Seemaa Mohammed
  • 58. Natural Convection Flow is driven by density variation ∂u ∂t + u · u = − P + Pr 2 u + RaPrg, ∂θ ∂t + u · θ = 2 θ,
  • 59. Streamfunction and Temperature plots Contours of flow fields for convection in a square cavity. From left to right, Ra = 1000, Ra = 10000, Ra = 1000000 [Allen and TR (2016)] https://timreis.org/publications/
  • 60. Nusselt numbers Ra Study Nu 103 Present 1.1178 de Vahl Davis 1.118 106 Present 8.8249 Le Quere 8.8252 de Vahl Davis 8.800 108 Present 30.23339 Le Quere 30.225 [Allen and TR (2016)] https://timreis.org/publications/