SlideShare a Scribd company logo
1 of 24
Download to read offline
Pinning and facetting in lattice Boltzmann
simulations
Tim Reis
Oxford Centre for Collaborative Applied Mathematics
Mathematical Institute
University of Oxford
OCCAM/ICFD Lattice Boltzmann Workshop, September
2010
Recolouring in multiphase lattice Boltzmann models
Lattice Boltzmann models for continuum multiphase ļ¬‚ows use a
ā€œcolour ļ¬eld" to represent different phases.
A recolouring algorithm is needed to encourage phase segregation
and maintain narrow boundaries between ļ¬‚uids.
Maximising the work done against the colour gradient predicts sharp
interfaces but causes spurious behaviour:
Other recolouring algorithms
Latva-Kokko and Rothman (2005) offer an alternative redistribution:
fk
i =
ā‡¢k
ā‡¢
f0
i Ā±
ā‡¢r
ā‡¢b
ā‡¢2
f
(0)
i cos ā†µ
See also Dā€™Ortona et al. (1995), Tƶlke et al. (2002)
Motivation
ā€¢ Multiphase LBEs are prone to lattice pinning and facetting
(Latva-Kokko & Rothman (2005), Halliday et al. (2006)).
ā€¢ Similar difļ¬culties arise in combustion (Colella (1986), Pember
(1993)).
ā€¢ Spurious phenomena associated with stiff source terms
investigated by LeVeque & Yee (1990).
ā€¢ Unphysical behaviour can be corrected with a random projection
method (Bao & Jin (2000)).
ā€¢ LB formulation of these models can shed light on pinning and
facetting.
Phase ļ¬elds, pinning and facetting
Two types of particles: red & blue.
Scalar ļ¬eld , the ā€œcolourā€
ā‡” 1 in red phase (oil)
ā‡” 0 in blue phase (water)
Diffuse interfaces marked by
transitions from ā‡” 1 to ā‡” 0.
@t + u Ā· r = S( ).
Model problem for propagating sharp interfaces
@
@t
+ u
@
@x
= S( ) =
1
T
1 1
2
TS( ) = 1 1
2
d
dt = S( )
ā€œ The numerical results presented above indicate a disturbing feature
of this problem ā€“ it is possible to compute perfectly reasonable results
that are stable and free from oscillations and yet are completely
incorrect. Needless to say, this can be misleading.ā€
LeVeque & Yee (1990)
Lattice Boltzmann Implementation
Suppose =
P
i fi and postulate the discrete Boltzmann equation:
@t fi + ci @x fi =
1
āŒ§
ā‡£
fi f
(0)
i
āŒ˜
+ Ri .
With the following equilibrium function and discrete source term :
f
(0)
i = Wi (1 + ci u),
Ri = 1
2 S( )(1 + ci u);
the Chapman-Enskog expansion yields the
advection-reaction-diffusion equation:
@
@t
+ u
@
@x
= S( ) + āŒ§(1 u2
)
@2
@x2
.
Reduction to Fully Discrete Form
The previous discrete Boltzmann equation can be written as
@t fi + ci @x fi = āŒ¦i
Integrate along a characteristic for time t:
fi (x + ci t, t + t) fi (x, t) =
Z t
0
āŒ¦i (x + ci s, t + s) ds,
and approximate the integral by the trapezium rule:
fi (x +ci t, t+ t) fi (x, t) =
t
2
ā‡£
āŒ¦i (x +ci t, t+ t)
+ āŒ¦i (x, t)
āŒ˜
+O t3
.
This is an implicit system.
Change of Variables
To obtain a second order explicit LBE at time t + t deļ¬ne
fi (x0
, t0
) = fi (x0
, t0
)
t
2āŒ§
ā‡£
fi (x0
, t) f
(0)
i (x0
, t)
āŒ˜ t
2
Ri (x0
, 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)
āŒ˜
+
āŒ§ t
āŒ§ + t/2
Ri (x, t),
However, we need to ļ¬nd in order to compute f
(0)
i and Ri .
Reconstruction of
The source term does not conserve :
ĀÆ =
X
i
fi =
X
i
ļ£æ
fi
t
2āŒ§
ā‡£
fi f
(0)
i
āŒ˜ t
2
Ri
= +
t
2T
1 1
2 = N( ).
We can reconstruct by solving the nonlinear equation N( ) = ĀÆ
using Newtonā€™s method:
!
N( ) ĀÆ
N0( )
,
Note that N( ) = + O( t/T).
Lengthscale of Transition
The diffusive extension of LeVeque and Yeeā€™s model is
@
@t
+ u
@
@x
= S( ) + ļ£æ
@2
@x2
Solving the ODE
0 = S( ) + ļ£æ
@2
@x2
gives us the interface proļ¬le
(x) = (1 + exp x/L)
1
,
where L =
p
2āŒ§T x is the lengthscale of transition
Sharpening without Advection
Initial condition: = sin2
(ā‡”x)
T = āŒ§ = 0.01
Pinning as a result of sharpening
Numerical solutions for āŒ§/T = 1 (left) and āŒ§/T = 50 (right).
Conservation Trouble
In the 2D case the circular region shrinks and eventually disappears:
This is due to the curvature of the interface:
We ļ¬nd c that satisļ¬es
M =
Z
āŒ¦
S( , c)dāŒ¦.
Facetting with a D2Q9 Model
Propagating circular patch when āŒ§/T = 10. Notice the beginnings of
a facet on the leading edge . . .
When āŒ§/T = 50 the facetting is severe . . .
Recap: Model problem for propagating sharp
interfaces (LeVeque & Yee 1990)
@
@t
+ u
@
@x
= S( ) =
1
T
1 1
2
Usually implemented as separate advection and sharpening steps.
@
@t + u @
@x = 0
@
@t
= S( )
The Random Projection Method
The LeVeque & Yee source term is effectively the deterministic
projection
SD( ) : (x, t + t) =
(
1 if 0
(x, t) > 1/2,
0 if 0
(x, t) ļ£æ 1/2.
Bao & Jin (2000) replace the critical c = 1/2 with a uniformly
distributed random variable
(n)
c :
SR( ) : (x, t + t) =
(
1 if 0
(x, t) >
(n)
c ,
0 if 0
(x, t) ļ£æ
(n)
c .
@
@t
+ u Ā· r =
1
T
1 (n)
c .
Comparison of Propagation Speed (1D)
The speed of the interface is dictated by the ratio of timescales, āŒ§
T .
Comparing the Radii of the Patches at t = 0.4
The Random Projection model preserves the circular shape at
āŒ§/T = 10
and is clearly superior to the LeVeque model when āŒ§/T = 30
A non-smooth problem: āŒ§
T = 30
An initial square patch fails to collapse to a circle when using a
deterministice volume preserving threshold . . .
. . . but behaves correctly when we introduce the van der Corput
sequence:
Topological changes: āŒ§
T = 30
An initial square patch fails to collapse to a circle when using a
deterministice volume preserving threshold . . .
. . . but behaves correctly when we introduce the van der Corput
sequence:
A conservative scheme
If we assume L =
p
2āŒ§T x then
@
@n
= r Ā· n = |r | =
(1 )
L
,
@2
@n2
=
(r Ā· r)|r |
|r |
=
(1 )(1
2 )
L2
.
We can now show that a DBE of the form
@fi
@t
+ ci
@fi
@x
=
1
āŒ§
ā‡£
fi f
(0)
i
āŒ˜
+ Wi
(1 )
L
ci Ā· n
furnishes
@
@t
+ u
@
@x
= āŒ§(1 u2
)r2
+ āŒ§r2 (1 )(1
2 )
T
in the macroscopic limit.
Some preliminary results
First in one dimension. . .
. . . and also in two dimensions. . .
Conclusion
ā€¢ We have studied the combination of advection and sharpening of
the phase ļ¬eld that commonly arises in lattice Boltzmann models
for multiphase ļ¬‚ows.
ā€¢ Overly sharp phase boundaries can become pinned to the
lattice. This has been shown to be a purely kinematic effect.
ā€¢ Replacing the threshold with a uniformly distributed
pseudo-random variable allows us to predict the correct
propagation speed at very sharp boundaries (āŒ§/T > 100).
ā€¢ The onset of facetting is signifļ¬canly delayed if we introduce a
random term into the volume-preserving multi-dimensional
extension.

More Related Content

What's hot

Ps02 cmth03 unit 1
Ps02 cmth03 unit 1Ps02 cmth03 unit 1
Ps02 cmth03 unit 1
Prakash Dabhi
Ā 
Fourier series
Fourier seriesFourier series
Fourier series
Naveen Sihag
Ā 
periodic functions and Fourier series
periodic functions and Fourier seriesperiodic functions and Fourier series
periodic functions and Fourier series
Umang Gupta
Ā 
Learning object 1
Learning object 1Learning object 1
Learning object 1
Ina Na
Ā 
Fourier series
Fourier seriesFourier series
Fourier series
Tarun Gehlot
Ā 
tensor-decomposition
tensor-decompositiontensor-decomposition
tensor-decomposition
Kenta Oono
Ā 
Analysis and algebra on differentiable manifolds
Analysis and algebra on differentiable manifoldsAnalysis and algebra on differentiable manifolds
Analysis and algebra on differentiable manifolds
Springer
Ā 
FDTD Presentation
FDTD PresentationFDTD Presentation
FDTD Presentation
Reece Boston
Ā 
Optics Fourier Transform Ii
Optics Fourier Transform IiOptics Fourier Transform Ii
Optics Fourier Transform Ii
diarmseven
Ā 

What's hot (20)

Ps02 cmth03 unit 1
Ps02 cmth03 unit 1Ps02 cmth03 unit 1
Ps02 cmth03 unit 1
Ā 
A short remark on Fellerā€™s square root condition.
A short remark on Fellerā€™s square root condition.A short remark on Fellerā€™s square root condition.
A short remark on Fellerā€™s square root condition.
Ā 
Fourier series
Fourier seriesFourier series
Fourier series
Ā 
8 fixed point theorem in complete fuzzy metric space 8 megha shrivastava
8 fixed point theorem in complete fuzzy metric space 8 megha shrivastava8 fixed point theorem in complete fuzzy metric space 8 megha shrivastava
8 fixed point theorem in complete fuzzy metric space 8 megha shrivastava
Ā 
Lesson 10: The Chain Rule (slides)
Lesson 10: The Chain Rule (slides)Lesson 10: The Chain Rule (slides)
Lesson 10: The Chain Rule (slides)
Ā 
periodic functions and Fourier series
periodic functions and Fourier seriesperiodic functions and Fourier series
periodic functions and Fourier series
Ā 
Learning object 1
Learning object 1Learning object 1
Learning object 1
Ā 
Stochastic Schrƶdinger equations
Stochastic Schrƶdinger equationsStochastic Schrƶdinger equations
Stochastic Schrƶdinger equations
Ā 
Application of analytic function
Application of analytic functionApplication of analytic function
Application of analytic function
Ā 
Using blurred images to assess damage in bridge structures?
Using blurred images to assess damage in bridge structures?Using blurred images to assess damage in bridge structures?
Using blurred images to assess damage in bridge structures?
Ā 
Rao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithms
Rao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithmsRao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithms
Rao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithms
Ā 
Fourier series
Fourier seriesFourier series
Fourier series
Ā 
tensor-decomposition
tensor-decompositiontensor-decomposition
tensor-decomposition
Ā 
Analysis and algebra on differentiable manifolds
Analysis and algebra on differentiable manifoldsAnalysis and algebra on differentiable manifolds
Analysis and algebra on differentiable manifolds
Ā 
Solucionario serway cap 3
Solucionario serway cap 3Solucionario serway cap 3
Solucionario serway cap 3
Ā 
Hermite integrators and Riordan arrays
Hermite integrators and Riordan arraysHermite integrators and Riordan arrays
Hermite integrators and Riordan arrays
Ā 
FDTD Presentation
FDTD PresentationFDTD Presentation
FDTD Presentation
Ā 
Spectral sum rules for conformal field theories
Spectral sum rules for conformal field theoriesSpectral sum rules for conformal field theories
Spectral sum rules for conformal field theories
Ā 
Fourier series pgbi
Fourier series pgbiFourier series pgbi
Fourier series pgbi
Ā 
Optics Fourier Transform Ii
Optics Fourier Transform IiOptics Fourier Transform Ii
Optics Fourier Transform Ii
Ā 

Similar to Workshop presentations l_bworkshop_reis

Laplace transform
Laplace transformLaplace transform
Laplace transform
Naveen Sihag
Ā 
Laplace transform
Laplace transformLaplace transform
Laplace transform
Naveen Sihag
Ā 
presentation_laplace_transform_1553598871_41306.pptx
presentation_laplace_transform_1553598871_41306.pptxpresentation_laplace_transform_1553598871_41306.pptx
presentation_laplace_transform_1553598871_41306.pptx
AmmarShr1
Ā 
fouriertransform.pdf
fouriertransform.pdffouriertransform.pdf
fouriertransform.pdf
ssuser4dafea
Ā 
Problem Solving by Computer Finite Element Method
Problem Solving by Computer Finite Element MethodProblem Solving by Computer Finite Element Method
Problem Solving by Computer Finite Element Method
Peter Herbert
Ā 
A current perspectives of corrected operator splitting (os) for systems
A current perspectives of corrected operator splitting (os) for systemsA current perspectives of corrected operator splitting (os) for systems
A current perspectives of corrected operator splitting (os) for systems
Alexander Decker
Ā 
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
Ā 

Similar to Workshop presentations l_bworkshop_reis (20)

Laplace
LaplaceLaplace
Laplace
Ā 
Laplace transform
Laplace transformLaplace transform
Laplace transform
Ā 
Laplace transform
Laplace transformLaplace transform
Laplace transform
Ā 
Laplace transform
Laplace transformLaplace transform
Laplace transform
Ā 
02_AJMS_297_21.pdf
02_AJMS_297_21.pdf02_AJMS_297_21.pdf
02_AJMS_297_21.pdf
Ā 
presentation_laplace_transform_1553598871_41306.pptx
presentation_laplace_transform_1553598871_41306.pptxpresentation_laplace_transform_1553598871_41306.pptx
presentation_laplace_transform_1553598871_41306.pptx
Ā 
fouriertransform.pdf
fouriertransform.pdffouriertransform.pdf
fouriertransform.pdf
Ā 
19 4
19 419 4
19 4
Ā 
A Numerical Method For Friction Problems With Multiple Contacts
A Numerical Method For Friction Problems With Multiple ContactsA Numerical Method For Friction Problems With Multiple Contacts
A Numerical Method For Friction Problems With Multiple Contacts
Ā 
Laplace
LaplaceLaplace
Laplace
Ā 
Online Signals and Systems Assignment Help
Online Signals and Systems Assignment HelpOnline Signals and Systems Assignment Help
Online Signals and Systems Assignment Help
Ā 
Problem Solving by Computer Finite Element Method
Problem Solving by Computer Finite Element MethodProblem Solving by Computer Finite Element Method
Problem Solving by Computer Finite Element Method
Ā 
A current perspectives of corrected operator splitting (os) for systems
A current perspectives of corrected operator splitting (os) for systemsA current perspectives of corrected operator splitting (os) for systems
A current perspectives of corrected operator splitting (os) for systems
Ā 
Laplace Transformation.ppt
Laplace Transformation.pptLaplace Transformation.ppt
Laplace Transformation.ppt
Ā 
Laplace_Transform.ppt
Laplace_Transform.pptLaplace_Transform.ppt
Laplace_Transform.ppt
Ā 
Laplace_Transform.ppt
Laplace_Transform.pptLaplace_Transform.ppt
Laplace_Transform.ppt
Ā 
Signal Processing Homework Help
Signal Processing Homework HelpSignal Processing Homework Help
Signal Processing Homework Help
Ā 
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...
Ā 
Week 7
Week 7Week 7
Week 7
Ā 
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
Ā 

Recently uploaded

Jet reorientation in central galaxies of clusters and groups: insights from V...
Jet reorientation in central galaxies of clusters and groups: insights from V...Jet reorientation in central galaxies of clusters and groups: insights from V...
Jet reorientation in central galaxies of clusters and groups: insights from V...
SĆ©rgio Sacani
Ā 
Pests of sugarcane_Binomics_IPM_Dr.UPR.pdf
Pests of sugarcane_Binomics_IPM_Dr.UPR.pdfPests of sugarcane_Binomics_IPM_Dr.UPR.pdf
Pests of sugarcane_Binomics_IPM_Dr.UPR.pdf
PirithiRaju
Ā 
Tuberculosis (TB)-Notes.pdf microbiology notes
Tuberculosis (TB)-Notes.pdf microbiology notesTuberculosis (TB)-Notes.pdf microbiology notes
Tuberculosis (TB)-Notes.pdf microbiology notes
jyothisaisri
Ā 
Pests of Green Manures_Bionomics_IPM_Dr.UPR.pdf
Pests of Green Manures_Bionomics_IPM_Dr.UPR.pdfPests of Green Manures_Bionomics_IPM_Dr.UPR.pdf
Pests of Green Manures_Bionomics_IPM_Dr.UPR.pdf
PirithiRaju
Ā 
Detectability of Solar Panels as a Technosignature
Detectability of Solar Panels as a TechnosignatureDetectability of Solar Panels as a Technosignature
Detectability of Solar Panels as a Technosignature
SĆ©rgio Sacani
Ā 
The importance of continents, oceans and plate tectonics for the evolution of...
The importance of continents, oceans and plate tectonics for the evolution of...The importance of continents, oceans and plate tectonics for the evolution of...
The importance of continents, oceans and plate tectonics for the evolution of...
SĆ©rgio Sacani
Ā 
Exomoons & Exorings with the Habitable Worlds Observatory I: On the Detection...
Exomoons & Exorings with the Habitable Worlds Observatory I: On the Detection...Exomoons & Exorings with the Habitable Worlds Observatory I: On the Detection...
Exomoons & Exorings with the Habitable Worlds Observatory I: On the Detection...
SĆ©rgio Sacani
Ā 
Isolation of AMF by wet sieving and decantation method pptx
Isolation of AMF by wet sieving and decantation method pptxIsolation of AMF by wet sieving and decantation method pptx
Isolation of AMF by wet sieving and decantation method pptx
GOWTHAMIM22
Ā 

Recently uploaded (20)

Jet reorientation in central galaxies of clusters and groups: insights from V...
Jet reorientation in central galaxies of clusters and groups: insights from V...Jet reorientation in central galaxies of clusters and groups: insights from V...
Jet reorientation in central galaxies of clusters and groups: insights from V...
Ā 
Pests of sugarcane_Binomics_IPM_Dr.UPR.pdf
Pests of sugarcane_Binomics_IPM_Dr.UPR.pdfPests of sugarcane_Binomics_IPM_Dr.UPR.pdf
Pests of sugarcane_Binomics_IPM_Dr.UPR.pdf
Ā 
Hemoglobin metabolism: C Kalyan & E. Muralinath
Hemoglobin metabolism: C Kalyan & E. MuralinathHemoglobin metabolism: C Kalyan & E. Muralinath
Hemoglobin metabolism: C Kalyan & E. Muralinath
Ā 
Tuberculosis (TB)-Notes.pdf microbiology notes
Tuberculosis (TB)-Notes.pdf microbiology notesTuberculosis (TB)-Notes.pdf microbiology notes
Tuberculosis (TB)-Notes.pdf microbiology notes
Ā 
Land use land cover change analysis and detection of its drivers using geospa...
Land use land cover change analysis and detection of its drivers using geospa...Land use land cover change analysis and detection of its drivers using geospa...
Land use land cover change analysis and detection of its drivers using geospa...
Ā 
GBSN - Microbiology (Unit 7) Microbiology in Everyday Life
GBSN - Microbiology (Unit 7) Microbiology in Everyday LifeGBSN - Microbiology (Unit 7) Microbiology in Everyday Life
GBSN - Microbiology (Unit 7) Microbiology in Everyday Life
Ā 
GBSN - Microbiology (Unit 6) Human and Microbial interaction
GBSN - Microbiology (Unit 6) Human and Microbial interactionGBSN - Microbiology (Unit 6) Human and Microbial interaction
GBSN - Microbiology (Unit 6) Human and Microbial interaction
Ā 
Pests of Green Manures_Bionomics_IPM_Dr.UPR.pdf
Pests of Green Manures_Bionomics_IPM_Dr.UPR.pdfPests of Green Manures_Bionomics_IPM_Dr.UPR.pdf
Pests of Green Manures_Bionomics_IPM_Dr.UPR.pdf
Ā 
Detectability of Solar Panels as a Technosignature
Detectability of Solar Panels as a TechnosignatureDetectability of Solar Panels as a Technosignature
Detectability of Solar Panels as a Technosignature
Ā 
Alternative method of dissolution in-vitro in-vivo correlation and dissolutio...
Alternative method of dissolution in-vitro in-vivo correlation and dissolutio...Alternative method of dissolution in-vitro in-vivo correlation and dissolutio...
Alternative method of dissolution in-vitro in-vivo correlation and dissolutio...
Ā 
SCHISTOSOMA HEAMATOBIUM life cycle .pdf
SCHISTOSOMA HEAMATOBIUM life cycle  .pdfSCHISTOSOMA HEAMATOBIUM life cycle  .pdf
SCHISTOSOMA HEAMATOBIUM life cycle .pdf
Ā 
mixotrophy in cyanobacteria: a dual nutritional strategy
mixotrophy in cyanobacteria: a dual nutritional strategymixotrophy in cyanobacteria: a dual nutritional strategy
mixotrophy in cyanobacteria: a dual nutritional strategy
Ā 
Extensive Pollution of Uranus and Neptuneā€™s Atmospheres by Upsweep of Icy Mat...
Extensive Pollution of Uranus and Neptuneā€™s Atmospheres by Upsweep of Icy Mat...Extensive Pollution of Uranus and Neptuneā€™s Atmospheres by Upsweep of Icy Mat...
Extensive Pollution of Uranus and Neptuneā€™s Atmospheres by Upsweep of Icy Mat...
Ā 
family therapy psychotherapy types .pdf
family therapy psychotherapy types  .pdffamily therapy psychotherapy types  .pdf
family therapy psychotherapy types .pdf
Ā 
GBSN - Biochemistry (Unit 4) Chemistry of Carbohydrates
GBSN - Biochemistry (Unit 4) Chemistry of CarbohydratesGBSN - Biochemistry (Unit 4) Chemistry of Carbohydrates
GBSN - Biochemistry (Unit 4) Chemistry of Carbohydrates
Ā 
Microbial bio Synthesis of nanoparticles.pptx
Microbial bio Synthesis of nanoparticles.pptxMicrobial bio Synthesis of nanoparticles.pptx
Microbial bio Synthesis of nanoparticles.pptx
Ā 
MODERN PHYSICS_REPORTING_QUANTA_.....pdf
MODERN PHYSICS_REPORTING_QUANTA_.....pdfMODERN PHYSICS_REPORTING_QUANTA_.....pdf
MODERN PHYSICS_REPORTING_QUANTA_.....pdf
Ā 
The importance of continents, oceans and plate tectonics for the evolution of...
The importance of continents, oceans and plate tectonics for the evolution of...The importance of continents, oceans and plate tectonics for the evolution of...
The importance of continents, oceans and plate tectonics for the evolution of...
Ā 
Exomoons & Exorings with the Habitable Worlds Observatory I: On the Detection...
Exomoons & Exorings with the Habitable Worlds Observatory I: On the Detection...Exomoons & Exorings with the Habitable Worlds Observatory I: On the Detection...
Exomoons & Exorings with the Habitable Worlds Observatory I: On the Detection...
Ā 
Isolation of AMF by wet sieving and decantation method pptx
Isolation of AMF by wet sieving and decantation method pptxIsolation of AMF by wet sieving and decantation method pptx
Isolation of AMF by wet sieving and decantation method pptx
Ā 

Workshop presentations l_bworkshop_reis

  • 1. Pinning and facetting in lattice Boltzmann simulations Tim Reis Oxford Centre for Collaborative Applied Mathematics Mathematical Institute University of Oxford OCCAM/ICFD Lattice Boltzmann Workshop, September 2010
  • 2. Recolouring in multiphase lattice Boltzmann models Lattice Boltzmann models for continuum multiphase ļ¬‚ows use a ā€œcolour ļ¬eld" to represent different phases. A recolouring algorithm is needed to encourage phase segregation and maintain narrow boundaries between ļ¬‚uids. Maximising the work done against the colour gradient predicts sharp interfaces but causes spurious behaviour:
  • 3. Other recolouring algorithms Latva-Kokko and Rothman (2005) offer an alternative redistribution: fk i = ā‡¢k ā‡¢ f0 i Ā± ā‡¢r ā‡¢b ā‡¢2 f (0) i cos ā†µ See also Dā€™Ortona et al. (1995), Tƶlke et al. (2002)
  • 4. Motivation ā€¢ Multiphase LBEs are prone to lattice pinning and facetting (Latva-Kokko & Rothman (2005), Halliday et al. (2006)). ā€¢ Similar difļ¬culties arise in combustion (Colella (1986), Pember (1993)). ā€¢ Spurious phenomena associated with stiff source terms investigated by LeVeque & Yee (1990). ā€¢ Unphysical behaviour can be corrected with a random projection method (Bao & Jin (2000)). ā€¢ LB formulation of these models can shed light on pinning and facetting.
  • 5. Phase ļ¬elds, pinning and facetting Two types of particles: red & blue. Scalar ļ¬eld , the ā€œcolourā€ ā‡” 1 in red phase (oil) ā‡” 0 in blue phase (water) Diffuse interfaces marked by transitions from ā‡” 1 to ā‡” 0. @t + u Ā· r = S( ).
  • 6. Model problem for propagating sharp interfaces @ @t + u @ @x = S( ) = 1 T 1 1 2 TS( ) = 1 1 2 d dt = S( ) ā€œ The numerical results presented above indicate a disturbing feature of this problem ā€“ it is possible to compute perfectly reasonable results that are stable and free from oscillations and yet are completely incorrect. Needless to say, this can be misleading.ā€ LeVeque & Yee (1990)
  • 7. Lattice Boltzmann Implementation Suppose = P i fi and postulate the discrete Boltzmann equation: @t fi + ci @x fi = 1 āŒ§ ā‡£ fi f (0) i āŒ˜ + Ri . With the following equilibrium function and discrete source term : f (0) i = Wi (1 + ci u), Ri = 1 2 S( )(1 + ci u); the Chapman-Enskog expansion yields the advection-reaction-diffusion equation: @ @t + u @ @x = S( ) + āŒ§(1 u2 ) @2 @x2 .
  • 8. Reduction to Fully Discrete Form The previous discrete Boltzmann equation can be written as @t fi + ci @x fi = āŒ¦i Integrate along a characteristic for time t: fi (x + ci t, t + t) fi (x, t) = Z t 0 āŒ¦i (x + ci s, t + s) ds, and approximate the integral by the trapezium rule: fi (x +ci t, t+ t) fi (x, t) = t 2 ā‡£ āŒ¦i (x +ci t, t+ t) + āŒ¦i (x, t) āŒ˜ +O t3 . This is an implicit system.
  • 9. Change of Variables To obtain a second order explicit LBE at time t + t deļ¬ne fi (x0 , t0 ) = fi (x0 , t0 ) t 2āŒ§ ā‡£ fi (x0 , t) f (0) i (x0 , t) āŒ˜ t 2 Ri (x0 , 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) āŒ˜ + āŒ§ t āŒ§ + t/2 Ri (x, t), However, we need to ļ¬nd in order to compute f (0) i and Ri .
  • 10. Reconstruction of The source term does not conserve : ĀÆ = X i fi = X i ļ£æ fi t 2āŒ§ ā‡£ fi f (0) i āŒ˜ t 2 Ri = + t 2T 1 1 2 = N( ). We can reconstruct by solving the nonlinear equation N( ) = ĀÆ using Newtonā€™s method: ! N( ) ĀÆ N0( ) , Note that N( ) = + O( t/T).
  • 11. Lengthscale of Transition The diffusive extension of LeVeque and Yeeā€™s model is @ @t + u @ @x = S( ) + ļ£æ @2 @x2 Solving the ODE 0 = S( ) + ļ£æ @2 @x2 gives us the interface proļ¬le (x) = (1 + exp x/L) 1 , where L = p 2āŒ§T x is the lengthscale of transition
  • 12. Sharpening without Advection Initial condition: = sin2 (ā‡”x) T = āŒ§ = 0.01
  • 13. Pinning as a result of sharpening Numerical solutions for āŒ§/T = 1 (left) and āŒ§/T = 50 (right).
  • 14. Conservation Trouble In the 2D case the circular region shrinks and eventually disappears: This is due to the curvature of the interface: We ļ¬nd c that satisļ¬es M = Z āŒ¦ S( , c)dāŒ¦.
  • 15. Facetting with a D2Q9 Model Propagating circular patch when āŒ§/T = 10. Notice the beginnings of a facet on the leading edge . . . When āŒ§/T = 50 the facetting is severe . . .
  • 16. Recap: Model problem for propagating sharp interfaces (LeVeque & Yee 1990) @ @t + u @ @x = S( ) = 1 T 1 1 2 Usually implemented as separate advection and sharpening steps. @ @t + u @ @x = 0 @ @t = S( )
  • 17. The Random Projection Method The LeVeque & Yee source term is effectively the deterministic projection SD( ) : (x, t + t) = ( 1 if 0 (x, t) > 1/2, 0 if 0 (x, t) ļ£æ 1/2. Bao & Jin (2000) replace the critical c = 1/2 with a uniformly distributed random variable (n) c : SR( ) : (x, t + t) = ( 1 if 0 (x, t) > (n) c , 0 if 0 (x, t) ļ£æ (n) c . @ @t + u Ā· r = 1 T 1 (n) c .
  • 18. Comparison of Propagation Speed (1D) The speed of the interface is dictated by the ratio of timescales, āŒ§ T .
  • 19. Comparing the Radii of the Patches at t = 0.4 The Random Projection model preserves the circular shape at āŒ§/T = 10 and is clearly superior to the LeVeque model when āŒ§/T = 30
  • 20. A non-smooth problem: āŒ§ T = 30 An initial square patch fails to collapse to a circle when using a deterministice volume preserving threshold . . . . . . but behaves correctly when we introduce the van der Corput sequence:
  • 21. Topological changes: āŒ§ T = 30 An initial square patch fails to collapse to a circle when using a deterministice volume preserving threshold . . . . . . but behaves correctly when we introduce the van der Corput sequence:
  • 22. A conservative scheme If we assume L = p 2āŒ§T x then @ @n = r Ā· n = |r | = (1 ) L , @2 @n2 = (r Ā· r)|r | |r | = (1 )(1 2 ) L2 . We can now show that a DBE of the form @fi @t + ci @fi @x = 1 āŒ§ ā‡£ fi f (0) i āŒ˜ + Wi (1 ) L ci Ā· n furnishes @ @t + u @ @x = āŒ§(1 u2 )r2 + āŒ§r2 (1 )(1 2 ) T in the macroscopic limit.
  • 23. Some preliminary results First in one dimension. . . . . . and also in two dimensions. . .
  • 24. Conclusion ā€¢ We have studied the combination of advection and sharpening of the phase ļ¬eld that commonly arises in lattice Boltzmann models for multiphase ļ¬‚ows. ā€¢ Overly sharp phase boundaries can become pinned to the lattice. This has been shown to be a purely kinematic effect. ā€¢ Replacing the threshold with a uniformly distributed pseudo-random variable allows us to predict the correct propagation speed at very sharp boundaries (āŒ§/T > 100). ā€¢ The onset of facetting is signifļ¬canly delayed if we introduce a random term into the volume-preserving multi-dimensional extension.