SlideShare a Scribd company logo
A stochastic sharpening approach for the
pinning and facetting of sharp phase
boundaries in lattice Boltzmann simulations
T. Reis and P. J. Dellar
Department of Mathematical Sciences
University of Greenwich
Motivation
• Multiphase LBEs are prone to lattice pinning and facetting
(Latva-Kokko & Rothman (2005), Halliday et al. (2006)).
• Similar difficulties 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 fields, pinning and facetting
Two types of particles: red & blue.
Scalar field φ, the “colour”
φ ≈ 1 in red phase (oil)
φ ≈ 0 in blue phase (water)
Diffuse interfaces marked by
transitions from φ ≈ 1 to φ ≈ 0.
∂t φ + u · φ = 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 φ = 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) =
∆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 define
fi (x , t ) = fi (x , t ) +
∆t
2τ
fi (x , t) − f
(0)
i (x , t) −
∆t
2
Ri (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) +
τ∆t
τ + ∆t/2
Ri (x, t),
However, we need to find φ in order to compute f
(0)
i and Ri .
Reconstruction of φ
The source term does not conserve φ:
¯φ =
i
fi =
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(φ) − ¯φ
N (φ)
,
Note that N(φ) = φ + O(∆t/T).
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).
Excessive Sharpening: τ/T = 100
For large timescale ratios, the interface can become completely
pinned to the lattice . . .
Conservation Trouble
In the 2D case the circular region shrinks and eventually disappears:
This is due to the curvature of the interface:
We find φc that satisfies
M =
Ω
S(φ, φc)dΩ.
Facetting with a LeVeque 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
∂φ
∂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 φ (x, t) > 1/2,
0 if φ (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 φ (x, t) > φ
(n)
c ,
0 if φ (x, t) ≤ φ
(n)
c .
∂φ
∂t
+ u · φ = −
1
T
φ 1 − φ φ(n)
c − φ .
Comparison of Propagation Speed (1D)
The speed of the interface is dictated by the ratio of timescales, τ
T .
Facetting with a RPM D2Q9 Model
Propagating circular patch when τ/T = 10. The blob retains its initial
shape well . . .
. . . even when τ/T = 50:
Comparing the Radii of the Patches at t = 0.4
The Random Projection model preserves the circular shape at
τ/T = 10. . .
Comparing the Radii of the Patches at t = 0.4
. . . and is clearly superior to the LeVeque model when τ/T = 50
Conclusion
• We have studied the combination of advection and sharpening of
the phase field that commonly arises in lattice Boltzmann models
for multiphase flows.
• 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) and
delays the onset of facetting.
• This offers an explanation and improvement of the spurious
phenomena of pinning and facetting observed in multiphase
lattice Boltzmann simulations.

More Related Content

What's hot

Learning object 1
Learning object 1Learning object 1
Learning object 1Ina Na
 
Jere Koskela slides
Jere Koskela slidesJere Koskela slides
Jere Koskela slides
Christian Robert
 
Richard Everitt's slides
Richard Everitt's slidesRichard Everitt's slides
Richard Everitt's slides
Christian Robert
 
Chris Sherlock's slides
Chris Sherlock's slidesChris Sherlock's slides
Chris Sherlock's slides
Christian Robert
 
Fourier series
Fourier seriesFourier series
Fourier series
kishor pokar
 
Stochastic Assignment Help
Stochastic Assignment Help Stochastic Assignment Help
Stochastic Assignment Help
Statistics Assignment Help
 
Lesson 10: The Chain Rule (slides)
Lesson 10: The Chain Rule (slides)Lesson 10: The Chain Rule (slides)
Lesson 10: The Chain Rule (slides)
Matthew Leingang
 
application of partial differentiation
application of partial differentiationapplication of partial differentiation
application of partial differentiation
eteaching
 
Iterative procedure for uniform continuous mapping.
Iterative procedure for uniform continuous mapping.Iterative procedure for uniform continuous mapping.
Iterative procedure for uniform continuous mapping.
Alexander Decker
 
QMC: Operator Splitting Workshop, Proximal Algorithms in Probability Spaces -...
QMC: Operator Splitting Workshop, Proximal Algorithms in Probability Spaces -...QMC: Operator Splitting Workshop, Proximal Algorithms in Probability Spaces -...
QMC: Operator Splitting Workshop, Proximal Algorithms in Probability Spaces -...
The Statistical and Applied Mathematical Sciences Institute
 
periodic functions and Fourier series
periodic functions and Fourier seriesperiodic functions and Fourier series
periodic functions and Fourier seriesUmang Gupta
 
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.
Ilya Gikhman
 
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
Christian Robert
 
Optics Fourier Transform Ii
Optics Fourier Transform IiOptics Fourier Transform Ii
Optics Fourier Transform Iidiarmseven
 
AEM Fourier series
 AEM Fourier series AEM Fourier series
AEM Fourier series
Siddhi Viradiya
 
Application of analytic function
Application of analytic functionApplication of analytic function
Application of analytic function
Dr. Nirav Vyas
 
Fourier series
Fourier seriesFourier series
Fourier series
Faiza Saher
 
Fourier series example
Fourier series exampleFourier series example
Fourier series exampleAbi finni
 

What's hot (19)

Learning object 1
Learning object 1Learning object 1
Learning object 1
 
Jere Koskela slides
Jere Koskela slidesJere Koskela slides
Jere Koskela slides
 
Richard Everitt's slides
Richard Everitt's slidesRichard Everitt's slides
Richard Everitt's slides
 
Chris Sherlock's slides
Chris Sherlock's slidesChris Sherlock's slides
Chris Sherlock's slides
 
Fourier series
Fourier seriesFourier series
Fourier series
 
Fourier series
Fourier seriesFourier series
Fourier series
 
Stochastic Assignment Help
Stochastic Assignment Help Stochastic Assignment Help
Stochastic Assignment Help
 
Lesson 10: The Chain Rule (slides)
Lesson 10: The Chain Rule (slides)Lesson 10: The Chain Rule (slides)
Lesson 10: The Chain Rule (slides)
 
application of partial differentiation
application of partial differentiationapplication of partial differentiation
application of partial differentiation
 
Iterative procedure for uniform continuous mapping.
Iterative procedure for uniform continuous mapping.Iterative procedure for uniform continuous mapping.
Iterative procedure for uniform continuous mapping.
 
QMC: Operator Splitting Workshop, Proximal Algorithms in Probability Spaces -...
QMC: Operator Splitting Workshop, Proximal Algorithms in Probability Spaces -...QMC: Operator Splitting Workshop, Proximal Algorithms in Probability Spaces -...
QMC: Operator Splitting Workshop, Proximal Algorithms in Probability Spaces -...
 
periodic functions and Fourier series
periodic functions and Fourier seriesperiodic functions and Fourier series
periodic functions and Fourier series
 
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.
 
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
 
Optics Fourier Transform Ii
Optics Fourier Transform IiOptics Fourier Transform Ii
Optics Fourier Transform Ii
 
AEM Fourier series
 AEM Fourier series AEM Fourier series
AEM Fourier series
 
Application of analytic function
Application of analytic functionApplication of analytic function
Application of analytic function
 
Fourier series
Fourier seriesFourier series
Fourier series
 
Fourier series example
Fourier series exampleFourier series example
Fourier series example
 

Similar to Pinning and facetting in multiphase LBMs

Signal Processing Homework Help
Signal Processing Homework HelpSignal Processing Homework Help
Signal Processing Homework Help
Matlab Assignment Experts
 
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
 
A Fibonacci-like universe expansion on time-scale
A Fibonacci-like universe expansion on time-scaleA Fibonacci-like universe expansion on time-scale
A Fibonacci-like universe expansion on time-scale
OctavianPostavaru
 
mathstat.pdf
mathstat.pdfmathstat.pdf
mathstat.pdf
JuanRobinson3
 
Fourier series of odd functions with period 2 l
Fourier series of odd functions with period 2 lFourier series of odd functions with period 2 l
Fourier series of odd functions with period 2 l
Pepa Vidosa Serradilla
 
Natalini nse slide_giu2013
Natalini nse slide_giu2013Natalini nse slide_giu2013
Natalini nse slide_giu2013Madd Maths
 
DeepLearn2022 2. Variance Matters
DeepLearn2022  2. Variance MattersDeepLearn2022  2. Variance Matters
DeepLearn2022 2. Variance Matters
Sean Meyn
 
IVR - Chapter 1 - Introduction
IVR - Chapter 1 - IntroductionIVR - Chapter 1 - Introduction
IVR - Chapter 1 - Introduction
Charles Deledalle
 
Low rank tensor approximation of probability density and characteristic funct...
Low rank tensor approximation of probability density and characteristic funct...Low rank tensor approximation of probability density and characteristic funct...
Low rank tensor approximation of probability density and characteristic funct...
Alexander Litvinenko
 
Crib Sheet AP Calculus AB and BC exams
Crib Sheet AP Calculus AB and BC examsCrib Sheet AP Calculus AB and BC exams
Crib Sheet AP Calculus AB and BC exams
A Jorge Garcia
 
Solutions modern particlephysics
Solutions modern particlephysicsSolutions modern particlephysics
Solutions modern particlephysics
itachikaleido
 
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
 
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
 
Kanal wireless dan propagasi
Kanal wireless dan propagasiKanal wireless dan propagasi
Kanal wireless dan propagasi
Mochamad Guntur Hady Putra
 
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 MethodPeter Herbert
 
Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...
Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...
Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...
Alexander Litvinenko
 
Partial Differential Equations, 3 simple examples
Partial Differential Equations, 3 simple examplesPartial Differential Equations, 3 simple examples
Partial Differential Equations, 3 simple examples
Enrique Valderrama
 
Wave diffraction
Wave diffractionWave diffraction
Wave diffraction
eli priyatna laidan
 
QMC: Operator Splitting Workshop, Thresholdings, Robustness, and Generalized ...
QMC: Operator Splitting Workshop, Thresholdings, Robustness, and Generalized ...QMC: Operator Splitting Workshop, Thresholdings, Robustness, and Generalized ...
QMC: Operator Splitting Workshop, Thresholdings, Robustness, and Generalized ...
The Statistical and Applied Mathematical Sciences Institute
 

Similar to Pinning and facetting in multiphase LBMs (20)

Signal Processing Homework Help
Signal Processing Homework HelpSignal Processing Homework Help
Signal Processing Homework Help
 
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
 
A Fibonacci-like universe expansion on time-scale
A Fibonacci-like universe expansion on time-scaleA Fibonacci-like universe expansion on time-scale
A Fibonacci-like universe expansion on time-scale
 
mathstat.pdf
mathstat.pdfmathstat.pdf
mathstat.pdf
 
Fourier series of odd functions with period 2 l
Fourier series of odd functions with period 2 lFourier series of odd functions with period 2 l
Fourier series of odd functions with period 2 l
 
Natalini nse slide_giu2013
Natalini nse slide_giu2013Natalini nse slide_giu2013
Natalini nse slide_giu2013
 
DeepLearn2022 2. Variance Matters
DeepLearn2022  2. Variance MattersDeepLearn2022  2. Variance Matters
DeepLearn2022 2. Variance Matters
 
IVR - Chapter 1 - Introduction
IVR - Chapter 1 - IntroductionIVR - Chapter 1 - Introduction
IVR - Chapter 1 - Introduction
 
Low rank tensor approximation of probability density and characteristic funct...
Low rank tensor approximation of probability density and characteristic funct...Low rank tensor approximation of probability density and characteristic funct...
Low rank tensor approximation of probability density and characteristic funct...
 
Crib Sheet AP Calculus AB and BC exams
Crib Sheet AP Calculus AB and BC examsCrib Sheet AP Calculus AB and BC exams
Crib Sheet AP Calculus AB and BC exams
 
Solutions modern particlephysics
Solutions modern particlephysicsSolutions modern particlephysics
Solutions modern particlephysics
 
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
 
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...
 
Kanal wireless dan propagasi
Kanal wireless dan propagasiKanal wireless dan propagasi
Kanal wireless dan propagasi
 
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
 
Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...
Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...
Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...
 
Partial Differential Equations, 3 simple examples
Partial Differential Equations, 3 simple examplesPartial Differential Equations, 3 simple examples
Partial Differential Equations, 3 simple examples
 
Wave diffraction
Wave diffractionWave diffraction
Wave diffraction
 
QMC: Operator Splitting Workshop, Thresholdings, Robustness, and Generalized ...
QMC: Operator Splitting Workshop, Thresholdings, Robustness, and Generalized ...QMC: Operator Splitting Workshop, Thresholdings, Robustness, and Generalized ...
QMC: Operator Splitting Workshop, Thresholdings, Robustness, and Generalized ...
 

Recently uploaded

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
 
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
 
Nucleic Acid-its structural and functional complexity.
Nucleic Acid-its structural and functional complexity.Nucleic Acid-its structural and functional complexity.
Nucleic Acid-its structural and functional complexity.
Nistarini College, Purulia (W.B) India
 
Hemostasis_importance& clinical significance.pptx
Hemostasis_importance& clinical significance.pptxHemostasis_importance& clinical significance.pptx
Hemostasis_importance& clinical significance.pptx
muralinath2
 
extra-chromosomal-inheritance[1].pptx.pdfpdf
extra-chromosomal-inheritance[1].pptx.pdfpdfextra-chromosomal-inheritance[1].pptx.pdfpdf
extra-chromosomal-inheritance[1].pptx.pdfpdf
DiyaBiswas10
 
RNA INTERFERENCE: UNRAVELING GENETIC SILENCING
RNA INTERFERENCE: UNRAVELING GENETIC SILENCINGRNA INTERFERENCE: UNRAVELING GENETIC SILENCING
RNA INTERFERENCE: UNRAVELING GENETIC SILENCING
AADYARAJPANDEY1
 
platelets- lifespan -Clot retraction-disorders.pptx
platelets- lifespan -Clot retraction-disorders.pptxplatelets- lifespan -Clot retraction-disorders.pptx
platelets- lifespan -Clot retraction-disorders.pptx
muralinath2
 
platelets_clotting_biogenesis.clot retractionpptx
platelets_clotting_biogenesis.clot retractionpptxplatelets_clotting_biogenesis.clot retractionpptx
platelets_clotting_biogenesis.clot retractionpptx
muralinath2
 
PRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATION
PRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATIONPRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATION
PRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATION
ChetanK57
 
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
 
Unveiling the Energy Potential of Marshmallow Deposits.pdf
Unveiling the Energy Potential of Marshmallow Deposits.pdfUnveiling the Energy Potential of Marshmallow Deposits.pdf
Unveiling the Energy Potential of Marshmallow Deposits.pdf
Erdal Coalmaker
 
Seminar of U.V. Spectroscopy by SAMIR PANDA
 Seminar of U.V. Spectroscopy by SAMIR PANDA Seminar of U.V. Spectroscopy by SAMIR PANDA
Seminar of U.V. Spectroscopy by SAMIR PANDA
SAMIR PANDA
 
Lab report on liquid viscosity of glycerin
Lab report on liquid viscosity of glycerinLab report on liquid viscosity of glycerin
Lab report on liquid viscosity of glycerin
ossaicprecious19
 
in vitro propagation of plants lecture note.pptx
in vitro propagation of plants lecture note.pptxin vitro propagation of plants lecture note.pptx
in vitro propagation of plants lecture note.pptx
yusufzako14
 
Lateral Ventricles.pdf very easy good diagrams comprehensive
Lateral Ventricles.pdf very easy good diagrams comprehensiveLateral Ventricles.pdf very easy good diagrams comprehensive
Lateral Ventricles.pdf very easy good diagrams comprehensive
silvermistyshot
 
Leaf Initiation, Growth and Differentiation.pdf
Leaf Initiation, Growth and Differentiation.pdfLeaf Initiation, Growth and Differentiation.pdf
Leaf Initiation, Growth and Differentiation.pdf
RenuJangid3
 
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
 
GBSN- Microbiology (Lab 3) Gram Staining
GBSN- Microbiology (Lab 3) Gram StainingGBSN- Microbiology (Lab 3) Gram Staining
GBSN- Microbiology (Lab 3) Gram Staining
Areesha Ahmad
 
Earliest Galaxies in the JADES Origins Field: Luminosity Function and Cosmic ...
Earliest Galaxies in the JADES Origins Field: Luminosity Function and Cosmic ...Earliest Galaxies in the JADES Origins Field: Luminosity Function and Cosmic ...
Earliest Galaxies in the JADES Origins Field: Luminosity Function and Cosmic ...
Sérgio Sacani
 
Richard's aventures in two entangled wonderlands
Richard's aventures in two entangled wonderlandsRichard's aventures in two entangled wonderlands
Richard's aventures in two entangled wonderlands
Richard Gill
 

Recently uploaded (20)

Orion Air Quality Monitoring Systems - CWS
Orion Air Quality Monitoring Systems - CWSOrion Air Quality Monitoring Systems - CWS
Orion Air Quality Monitoring Systems - CWS
 
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
 
Nucleic Acid-its structural and functional complexity.
Nucleic Acid-its structural and functional complexity.Nucleic Acid-its structural and functional complexity.
Nucleic Acid-its structural and functional complexity.
 
Hemostasis_importance& clinical significance.pptx
Hemostasis_importance& clinical significance.pptxHemostasis_importance& clinical significance.pptx
Hemostasis_importance& clinical significance.pptx
 
extra-chromosomal-inheritance[1].pptx.pdfpdf
extra-chromosomal-inheritance[1].pptx.pdfpdfextra-chromosomal-inheritance[1].pptx.pdfpdf
extra-chromosomal-inheritance[1].pptx.pdfpdf
 
RNA INTERFERENCE: UNRAVELING GENETIC SILENCING
RNA INTERFERENCE: UNRAVELING GENETIC SILENCINGRNA INTERFERENCE: UNRAVELING GENETIC SILENCING
RNA INTERFERENCE: UNRAVELING GENETIC SILENCING
 
platelets- lifespan -Clot retraction-disorders.pptx
platelets- lifespan -Clot retraction-disorders.pptxplatelets- lifespan -Clot retraction-disorders.pptx
platelets- lifespan -Clot retraction-disorders.pptx
 
platelets_clotting_biogenesis.clot retractionpptx
platelets_clotting_biogenesis.clot retractionpptxplatelets_clotting_biogenesis.clot retractionpptx
platelets_clotting_biogenesis.clot retractionpptx
 
PRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATION
PRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATIONPRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATION
PRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATION
 
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...
 
Unveiling the Energy Potential of Marshmallow Deposits.pdf
Unveiling the Energy Potential of Marshmallow Deposits.pdfUnveiling the Energy Potential of Marshmallow Deposits.pdf
Unveiling the Energy Potential of Marshmallow Deposits.pdf
 
Seminar of U.V. Spectroscopy by SAMIR PANDA
 Seminar of U.V. Spectroscopy by SAMIR PANDA Seminar of U.V. Spectroscopy by SAMIR PANDA
Seminar of U.V. Spectroscopy by SAMIR PANDA
 
Lab report on liquid viscosity of glycerin
Lab report on liquid viscosity of glycerinLab report on liquid viscosity of glycerin
Lab report on liquid viscosity of glycerin
 
in vitro propagation of plants lecture note.pptx
in vitro propagation of plants lecture note.pptxin vitro propagation of plants lecture note.pptx
in vitro propagation of plants lecture note.pptx
 
Lateral Ventricles.pdf very easy good diagrams comprehensive
Lateral Ventricles.pdf very easy good diagrams comprehensiveLateral Ventricles.pdf very easy good diagrams comprehensive
Lateral Ventricles.pdf very easy good diagrams comprehensive
 
Leaf Initiation, Growth and Differentiation.pdf
Leaf Initiation, Growth and Differentiation.pdfLeaf Initiation, Growth and Differentiation.pdf
Leaf Initiation, Growth and Differentiation.pdf
 
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
 
GBSN- Microbiology (Lab 3) Gram Staining
GBSN- Microbiology (Lab 3) Gram StainingGBSN- Microbiology (Lab 3) Gram Staining
GBSN- Microbiology (Lab 3) Gram Staining
 
Earliest Galaxies in the JADES Origins Field: Luminosity Function and Cosmic ...
Earliest Galaxies in the JADES Origins Field: Luminosity Function and Cosmic ...Earliest Galaxies in the JADES Origins Field: Luminosity Function and Cosmic ...
Earliest Galaxies in the JADES Origins Field: Luminosity Function and Cosmic ...
 
Richard's aventures in two entangled wonderlands
Richard's aventures in two entangled wonderlandsRichard's aventures in two entangled wonderlands
Richard's aventures in two entangled wonderlands
 

Pinning and facetting in multiphase LBMs

  • 1. A stochastic sharpening approach for the pinning and facetting of sharp phase boundaries in lattice Boltzmann simulations T. Reis and P. J. Dellar Department of Mathematical Sciences University of Greenwich
  • 2. Motivation • Multiphase LBEs are prone to lattice pinning and facetting (Latva-Kokko & Rothman (2005), Halliday et al. (2006)). • Similar difficulties 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.
  • 3. Phase fields, pinning and facetting Two types of particles: red & blue. Scalar field φ, the “colour” φ ≈ 1 in red phase (oil) φ ≈ 0 in blue phase (water) Diffuse interfaces marked by transitions from φ ≈ 1 to φ ≈ 0. ∂t φ + u · φ = S(φ).
  • 4. 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)
  • 5. Lattice Boltzmann Implementation Suppose φ = 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 .
  • 6. 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) = ∆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.
  • 7. 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) − ∆t 2 Ri (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) + τ∆t τ + ∆t/2 Ri (x, t), However, we need to find φ in order to compute f (0) i and Ri .
  • 8. Reconstruction of φ The source term does not conserve φ: ¯φ = i fi = 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(φ) − ¯φ N (φ) , Note that N(φ) = φ + O(∆t/T).
  • 9. Sharpening without Advection Initial condition: φ = sin2 (πx) T = τ = 0.01
  • 10. Pinning as a result of sharpening Numerical solutions for τ/T = 1 (left) and τ/T = 50 (right).
  • 11. Excessive Sharpening: τ/T = 100 For large timescale ratios, the interface can become completely pinned to the lattice . . .
  • 12. Conservation Trouble In the 2D case the circular region shrinks and eventually disappears: This is due to the curvature of the interface: We find φc that satisfies M = Ω S(φ, φc)dΩ.
  • 13. Facetting with a LeVeque 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 . . .
  • 14. Recap: Model problem for propagating sharp interfaces ∂φ ∂t + u ∂φ ∂x = S(φ) = − 1 T φ 1 − φ 1 2 − φ Usually implemented as separate advection and sharpening steps. ∂φ ∂t + u ∂φ ∂x = 0 ∂φ ∂t = S(φ)
  • 15. The Random Projection Method The LeVeque & Yee source term is effectively the deterministic projection SD(φ) : φ(x, t + ∆t) = 1 if φ (x, t) > 1/2, 0 if φ (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 φ (x, t) > φ (n) c , 0 if φ (x, t) ≤ φ (n) c . ∂φ ∂t + u · φ = − 1 T φ 1 − φ φ(n) c − φ .
  • 16. Comparison of Propagation Speed (1D) The speed of the interface is dictated by the ratio of timescales, τ T .
  • 17. Facetting with a RPM D2Q9 Model Propagating circular patch when τ/T = 10. The blob retains its initial shape well . . . . . . even when τ/T = 50:
  • 18. Comparing the Radii of the Patches at t = 0.4 The Random Projection model preserves the circular shape at τ/T = 10. . .
  • 19. Comparing the Radii of the Patches at t = 0.4 . . . and is clearly superior to the LeVeque model when τ/T = 50
  • 20. Conclusion • We have studied the combination of advection and sharpening of the phase field that commonly arises in lattice Boltzmann models for multiphase flows. • 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) and delays the onset of facetting. • This offers an explanation and improvement of the spurious phenomena of pinning and facetting observed in multiphase lattice Boltzmann simulations.