SlideShare ist ein Scribd-Unternehmen logo
1 von 20
Downloaden Sie, um offline zu lesen
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.

Weitere ähnliche Inhalte

Was ist angesagt?

Learning object 1
Learning object 1Learning object 1
Learning object 1Ina Na
 
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 differentiationeteaching
 
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
 
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 algorithmsChristian Robert
 
Optics Fourier Transform Ii
Optics Fourier Transform IiOptics Fourier Transform Ii
Optics Fourier Transform Iidiarmseven
 
Application of analytic function
Application of analytic functionApplication of analytic function
Application of analytic functionDr. Nirav Vyas
 
Fourier series example
Fourier series exampleFourier series example
Fourier series exampleAbi finni
 

Was ist angesagt? (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
 

Ähnlich wie Stochastic sharpening approach delays pinning and facetting in LB simulations

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 orderJuliho 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-scaleOctavianPostavaru
 
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 lPepa 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 MattersSean Meyn
 
IVR - Chapter 1 - Introduction
IVR - Chapter 1 - IntroductionIVR - Chapter 1 - Introduction
IVR - Chapter 1 - IntroductionCharles 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 examsA Jorge Garcia
 
Solutions modern particlephysics
Solutions modern particlephysicsSolutions modern particlephysics
Solutions modern particlephysicsitachikaleido
 
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
 
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 examplesEnrique Valderrama
 

Ähnlich wie Stochastic sharpening approach delays pinning and facetting in LB simulations (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 ...
 

Kürzlich hochgeladen

Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)PraveenaKalaiselvan1
 
Nanoparticles synthesis and characterization​ ​
Nanoparticles synthesis and characterization​  ​Nanoparticles synthesis and characterization​  ​
Nanoparticles synthesis and characterization​ ​kaibalyasahoo82800
 
All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...
All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...
All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...Sérgio Sacani
 
Botany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questionsBotany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questionsSumit Kumar yadav
 
Biological Classification BioHack (3).pdf
Biological Classification BioHack (3).pdfBiological Classification BioHack (3).pdf
Biological Classification BioHack (3).pdfmuntazimhurra
 
Presentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptxPresentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptxgindu3009
 
Hire 💕 9907093804 Hooghly Call Girls Service Call Girls Agency
Hire 💕 9907093804 Hooghly Call Girls Service Call Girls AgencyHire 💕 9907093804 Hooghly Call Girls Service Call Girls Agency
Hire 💕 9907093804 Hooghly Call Girls Service Call Girls AgencySheetal Arora
 
Hubble Asteroid Hunter III. Physical properties of newly found asteroids
Hubble Asteroid Hunter III. Physical properties of newly found asteroidsHubble Asteroid Hunter III. Physical properties of newly found asteroids
Hubble Asteroid Hunter III. Physical properties of newly found asteroidsSérgio Sacani
 
Broad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptxBroad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptxjana861314
 
Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...
Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...
Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...anilsa9823
 
DIFFERENCE IN BACK CROSS AND TEST CROSS
DIFFERENCE IN  BACK CROSS AND TEST CROSSDIFFERENCE IN  BACK CROSS AND TEST CROSS
DIFFERENCE IN BACK CROSS AND TEST CROSSLeenakshiTyagi
 
TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...
TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...
TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...ssifa0344
 
Spermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatidSpermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatidSarthak Sekhar Mondal
 
Zoology 4th semester series (krishna).pdf
Zoology 4th semester series (krishna).pdfZoology 4th semester series (krishna).pdf
Zoology 4th semester series (krishna).pdfSumit Kumar yadav
 
Pests of cotton_Borer_Pests_Binomics_Dr.UPR.pdf
Pests of cotton_Borer_Pests_Binomics_Dr.UPR.pdfPests of cotton_Borer_Pests_Binomics_Dr.UPR.pdf
Pests of cotton_Borer_Pests_Binomics_Dr.UPR.pdfPirithiRaju
 
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral AnalysisRaman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral AnalysisDiwakar Mishra
 
GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)Areesha Ahmad
 
Disentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOSTDisentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOSTSérgio Sacani
 

Kürzlich hochgeladen (20)

Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)
 
Nanoparticles synthesis and characterization​ ​
Nanoparticles synthesis and characterization​  ​Nanoparticles synthesis and characterization​  ​
Nanoparticles synthesis and characterization​ ​
 
All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...
All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...
All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...
 
CELL -Structural and Functional unit of life.pdf
CELL -Structural and Functional unit of life.pdfCELL -Structural and Functional unit of life.pdf
CELL -Structural and Functional unit of life.pdf
 
Botany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questionsBotany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questions
 
Biological Classification BioHack (3).pdf
Biological Classification BioHack (3).pdfBiological Classification BioHack (3).pdf
Biological Classification BioHack (3).pdf
 
Presentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptxPresentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptx
 
Hire 💕 9907093804 Hooghly Call Girls Service Call Girls Agency
Hire 💕 9907093804 Hooghly Call Girls Service Call Girls AgencyHire 💕 9907093804 Hooghly Call Girls Service Call Girls Agency
Hire 💕 9907093804 Hooghly Call Girls Service Call Girls Agency
 
Hubble Asteroid Hunter III. Physical properties of newly found asteroids
Hubble Asteroid Hunter III. Physical properties of newly found asteroidsHubble Asteroid Hunter III. Physical properties of newly found asteroids
Hubble Asteroid Hunter III. Physical properties of newly found asteroids
 
Broad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptxBroad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptx
 
Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...
Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...
Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...
 
DIFFERENCE IN BACK CROSS AND TEST CROSS
DIFFERENCE IN  BACK CROSS AND TEST CROSSDIFFERENCE IN  BACK CROSS AND TEST CROSS
DIFFERENCE IN BACK CROSS AND TEST CROSS
 
TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...
TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...
TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...
 
Spermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatidSpermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatid
 
Zoology 4th semester series (krishna).pdf
Zoology 4th semester series (krishna).pdfZoology 4th semester series (krishna).pdf
Zoology 4th semester series (krishna).pdf
 
The Philosophy of Science
The Philosophy of ScienceThe Philosophy of Science
The Philosophy of Science
 
Pests of cotton_Borer_Pests_Binomics_Dr.UPR.pdf
Pests of cotton_Borer_Pests_Binomics_Dr.UPR.pdfPests of cotton_Borer_Pests_Binomics_Dr.UPR.pdf
Pests of cotton_Borer_Pests_Binomics_Dr.UPR.pdf
 
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral AnalysisRaman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
 
GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)
 
Disentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOSTDisentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOST
 

Stochastic sharpening approach delays pinning and facetting in LB simulations

  • 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.