0% found this document useful (0 votes)
19 views11 pages

Fast Multiple-Fluid Simulation

Uploaded by

ryq200404
Copyright
© © All Rights Reserved
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as PDF, TXT or read online on Scribd
0% found this document useful (0 votes)
19 views11 pages

Fast Multiple-Fluid Simulation

Uploaded by

ryq200404
Copyright
© © All Rights Reserved
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as PDF, TXT or read online on Scribd
You are on page 1/ 11

Fast Multiple-fluid Simulation Using Helmholtz Free Energy

Tao Yang1 , Jian Chang2 , Bo Ren3 , Ming C. Lin1,4 , Jian Jun Zhang2 , and Shi-Min Hu1
1
Tsinghua University 2 Bournemouth University 3 Nankai University 4 University of North Carolina at Chapel Hill

Figure 1: Egg Mixture. In simulating the stirring of 3 eggs by a blender, the resulting simulation presents visually plausible mixing results.
This mixing effect is achieved using our novel “extended mobility” formulation of the Navier-Stokes-Cahn-Hilliard Model.

Abstract 1 Introduction

Multiple-fluid simulation has received increased attention from the


Multiple-fluid interaction is an interesting and common visual phe- graphics community in the past few years. Multiple-phase or
nomenon we often observe. In this paper, we present an energy- multiple-component fluid simulations are crucial to reproduce re-
based Lagrangian method that expands the capability of exist- alistic visual effects from a wide range of real-world phenomena,
ing multiple-fluid methods to handle various phenomena, such as which are not adequately modeled by single-phase approaches. Pre-
extraction, partial dissolution, etc. Based on our user-adjusted vious works on multiple-fluid simulation can be divided into two
Helmholtz free energy functions, the simulated fluid evolves from main categories focusing on either immiscible fluids or on miscible
high-energy states to low-energy states, allowing flexible capture of or dispersed fluids. In the former category, clear interfaces exist
various mixing and unmixing processes. We also extend the orig- between different phases, and many works (e.g., [Hong and Kim
inal Cahn-Hilliard equation to be better able to simulate complex 2005; Losasso et al. 2006; Kim 2010; Boyd and Bridson 2012;
fluid-fluid interaction and rich visual phenomena such as motion- Misztal et al. 2012; Da et al. 2014]) have obtained visually plau-
related mixing and position based pattern. Our approach is easily sible results by tracking the interfaces. However, in the latter cat-
integrated with existing state-of-the-art smooth particle hydrody- egory, there are no clear interfaces between different phases, and
namic (SPH) solvers and can be further implemented on top of the the volume fraction method [Müller et al. 2005] has been widely
position based dynamics (PBD) method, improving the stability and adopted.
incompressibility of the fluid during Lagrangian simulation under
large time steps. Performance analysis shows that our method is at Grid-based methods (e.g., level-sets, volume-of-fluid, etc.) [Hong
least 4 times faster than the state-of-the-art multiple-fluid method. and Kim 2005; Losasso et al. 2006; Kim 2010; Boyd and Brid-
Examples are provided to demonstrate the new capability and ef- son 2012; Misztal et al. 2012; Bao et al. 2010; Kang et al. 2010]
fectiveness of our approach. assume incompressibility with the divergence-free condition and
work well on topological transitions, thus achieving plausible re-
sults. Previously, the smoothed particle hydrodynamics (SPH)
CR Categories: I.3.7 [Computer Graphics]: Three-Dimensional method [Monaghan 1992; Monaghan 1994] gained popularity as
Graphics and Realism—Animation; I.6.8 [Simulation and Model- a particle based method among the graphics community due to it-
ing]: Types of Simulation—Animation; s properties of mass-conservation and easy-to-handle Lagrangian
discretization. However, its performance and results are sensitive
to particle under-sampling and fluid compressibility, which are the
Keywords: Position based dynamics, Helmholtz free energy, main subjects of more recent investigations [Becker and Teschner
Multiple-fluid, Navier-Stokes-Cahn-Hilliard model 2007; Solenthaler and Pajarola 2009; Ihmsen et al. 2013; Cornelis
et al. 2014; Schechter and Bridson 2012; Akinci et al. 2012]. The
position based dynamics method [Müller et al. 2007] provides an
alternative approach and has shown its potential for various types
of physically based simulations.
ACM Reference Format
Yang, T., Chang, J., Ren, B., Lin, M., Zhang, J., Hu, S. 2015. Fast Multiple-fluid Simulation Using Helmholtz Previous grid and particle based methods for miscible multiple-fluid
Free Energy. ACM Trans. Graph. 34, 6, Article 201 (November 2015), 11 pages.
DOI = 10.1145/2816795.2818117 http://doi.acm.org/10.1145/2816795.2818117.
simulation mixed phases or components mainly in terms of either
concentration differences [Kang et al. 2010; Bao et al. 2010; Li-
Copyright Notice
Permission to make digital or hard copies of all or part of this work for personal or classroom use is granted u et al. 2011] or drift velocities [Ren et al. 2014]. These models
without fee provided that copies are not made or distributed for profit or commercial advantage and that
copies bear this notice and the full citation on the first page. Copyrights for components of this work owned
achieve rich visual results. However, none of these works takes en-
by others than ACM must be honored. Abstracting with credit is permitted. To copy otherwise, or republish, ergy (which is essential to many real-world phenomena) into con-
to post on servers or to redistribute to lists, requires prior specific permission and/or a fee. Request permis-
sions from permissions@acm.org. sideration. Physically, materials evolve from high-energy levels to
SIGGRAPH Asia ‘15 Technical Paper, November 02 – 05, 2015, Kobe, Japan.
Copyright 2015 ACM 978-1-4503-3931-5/15/11 ... $15.00.
low-energy levels. Non-energy based models cannot easily or intu-
DOI: http://doi.acm.org/10.1145/2816795.2818117 itively capture the evolution of phenomena (e.g., the extraction phe-
ACM Transactions on Graphics, Vol. 34, No. 6, Article 201, Publication Date: November 2015
201:2 • T. Yang et al.

nomenon commonly observed in industrial environments, partial it less effective for real-time simulations. Unlike previous work-
dissolution due to saturation and (oil spill) cleaning) based on this s, we adopt an energy-based method that is both computationally
principle. In contrast to previous works, we adopt an energy-based efficient and easy to integrate with the PBD method, which more
model and integrate the Cahn-Hilliard equation into the multiple- effectively brings incompressibility into the simulation.
fluid simulation. Our method can be potentially used to simulate
a wide range of common daily phenomena related to mixing and Park et al. [2008] also adopted the Cahn-Hilliard equation to sim-
unmixing, such as the mixture of oil and water. From an energy ulate multiple fluids using the Lattice Boltzmann method (LBM).
point of view, this work provides an alternative approach that ex- They provide a unified approach to handle both immiscible and mis-
pands the capability of multiple-fluid simulation and is flexible and cible fluids and show its feasibility with various examples. Howev-
stable. We further extend the original Cahn-Hilliard equation rather er, their method simply follows the original Cahn-Hilliard equation
than just follow it [Park et al. 2008] to make it capable of simulating without any modification. They simply set the bulk energy, i.e., the
more complex and richer visual phenomena such as egg-mixture Helmholtz free energy as the sum of the pair-wise fluid miscibility
and gray/colored patterns. which can be a convex function or zero. This formulation substan-
tially limits the targets of multi-fluid simulation to only basic misci-
The main contributions of our work are summarized below: ble and immiscible fluids. The LBM they adopted incurs significant
memory cost and is difficult to modify for simulating phenomena
• An energy-based approach to multiple-fluid simulation, ex- such as chemical reactions. Our work expands the capability of the
tending the capability of multiple-fluid simulation to create original model to handle a much wider field of multiple-fluid phe-
new effects such as extraction and partial dissolution. nomena and is based on the popular particle frameworks, SPH and
• An expanded view of the Cahn-Hilliard equation for phase PBD.
separation, making it possible to simulate complex fluid-fluid
interaction and rich visual phenomena by generalizing the for- In fluid simulation, enforcing incompressibility has always been a
mulation and introducing innovative applications of the ex- crucial problem. Standard SPH uses a stiff equation, originating
tended model. in ideal gas theory. Compared to the standard approach, weak-
ly compressible SPH (WCSPH) [Becker and Teschner 2007] pro-
• Practical integrations of the multiple-fluid method into both vides a more precise pressure estimate. Both methods require lim-
traditional SPH and PBD frameworks, achieving real-time ited time steps. Using an iterative Jacobi-style method to accu-
multiple-fluid simulation, at least 4 times faster than the state- mulate pressure changes, predictive-corrective incompressible SPH
of-the-art multiple-fluid simulation method. (PCISPH) [Solenthaler and Pajarola 2009] achieves good incom-
pressibility with large time steps. Local poisson SPH (LPSPH) [He
Our paper is organized as follows. First we review related works et al. 2012] accumulates position and velocity instead of pressure.
in Section 2. We then introduce the models and theories in Section Ihmsen et al. [2013] introduce the implicit incompressible SPH (I-
3 and 4. Details of implementation can be found in Section 5. We ISPH) to overcome the incapability of imcompressible SPH (ISPH)
illustrate our work with examples in Section 6. Finally, limitations (e.g., [Commins and Rudman 1999; Shao and Lo 2003]) in large-
and future works are discussed in Section 7. scale scenarios. Hybrid methods, like fluid implicit-particle (FLIP)
[Brackbill and Ruppel 1986] combine the advantages of grid and
2 Related Work particle based methods by using a grid for pressure and particles
for advection. Zhu et al. [2005] extend FLIP to simulate incom-
pressible fluids and Raveendran et al. [2011] solve an approximate-
Multiple-fluid simulation has been extensively investigated during
ly divergence-free velocity field using a coarse grid. Cornelis et al.
the last decade. To simulate immiscible fluids, Premǒze et al.
[2014] combined IISPH and FLIP to inherit from their advantages.
[2003] adopted the moving-particle semi-implicit (MPS) approach.
Solenthaler and Pajarola [2008] improved the standard SPH method The position based dynamics framework was first introduced to
to deal with density contrast more precisely. Amongst Eulerian ap- computer graphics by Müller in [2007]. This method operates on
proaches, the level-set method, the volume-of-fluid (VOF) method, vertices or particles’ positions directly via constraints. It accumu-
and the finite element method are widely used for interface tracking lates position changes via a Gauss-Seidel iteration to ensure its sta-
between phases or components [Hong and Kim 2005; Losasso et al. bility. Macklin and Müller [2013] have shown that PBD can be used
2006; Kim 2010; Boyd and Bridson 2012; Misztal et al. 2012]. to simulate fluids. Borrowing the idea of a density estimator from
As for miscible fluids, Müller et al. [2005] introduced the concept SPH ([Monaghan 1992; Monaghan 1994]), fluid incompressibility
of volume fraction to represent the spatial distribution of different is enforced with a density constraint [Bodin et al. 2012]. Position
phases or components. Kang et al. [2010] and Bao et al. [2010] based fluids (PBF) provides another choice for fluid simulation via
applied volume fractions to a grid-based solver to achieve desired a particle system. Compared to plain SPH, it enforces incompress-
mixing effects. Liu et al. [2011] and Ren et al. [2014] proved ibility achieving similar performances of modern SPH solvers e.g.,
that the concept of volume fraction can be integrated into an SPH PCISPH, IISPH. Most recently, Macklin et al. [2014] established a
solver. Nielsen and Østerby [2013] borrowed the concept of vol- unified dynamic framework, which can be used to simulate a wide
ume fraction to simulate spray in the Eulerian domain. Kang et al. range of physical phenomena, including immiscible multi-fluids, in
[2010], Bao et al. [2010] and Liu et al. [2011] took cells or particles a universal manner. However, their methods cannot be directly ap-
composed of different phases or components as a whole mixture plied to miscible fluid simulations.
moving at the same bulk velocity, and therefore mixing due to con-
centration differences only. To capture the underlying interactions 3 Particle Based Solvers
between phases due to flow motions and force distributions, Ren
et al. [2014] took the drift velocity of different phases or compo-
nents into consideration. This approach captures a wider range of 3.1 The Smoothed Particle Hydrodynamics Method
multiple-fluid phenomena and can be easily set up. However, their
method is not energy-driven and cannot handle many real-world SPH is an interpolation method which is widely used in particle
phenomena as illustrated in our work. They also use WCSPH, and systems. According to standard SPH, a scalar quantity Ai of i-th
minimizing compressibility will in turn limit the time-steps, making particle at position ri is interpolated by the weighted sum of known
ACM Transactions on Graphics, Vol. 34, No. 6, Article 201, Publication Date: November 2015
Fast Multiple-Fluid Simulation Using Helmholtz Free Energy • 201:3

quantities from neighboring particles: Table 1: Definition of symbols


X mj Symbol Meaning
Ai = Aj W (rij , h), (1)
ρj i, j particle index
j
k, l phase index
where mj , ρj are mass and density of particle j respectively, rij = x, y component of vector
ri − rj , h is the smooth radius, and W is a kernel function. We n, N number of phases, particles
will use Wij = W (rij , h) in the rest of this paper. In basic SPH, to ε(c) Ginzburg-Laudau free energy
simulate fluid with particles, the density ρi of i-th particle is given: F, F (c), F (c) Helmholtz free energy
G Gibbs n-simplex
X Ci density constrain of particle i
ρi = mj Wij . (2)
∆ri position change of particle i
j
ck , c l mass ratio of phase k, l
As in the work by Müller et al. [2003], the Poly6 kernel is used M mass matrix
for density estimation and the Spiky kernel for gradient calculation. Mi mobility of particle i
In our implementation, we use the pressure force and viscous force SF reactive stress
presented by Monaghan [1992] and Morris et al. [1997]. As for ci mass fraction of particle i
pressure, standard SPH uses a stiff equation: sk target mass ratio
sg gray value
pi = κ(ρi − ρ0 ), (3) R, G, B RGB color value
µk chemical potential of phase k
where ρ0 is the rest density, κ is stiffness constant. Becker and µi chemical potential vector of particle i
Teschner [2007] instead adopted the Tait equation to achieve better β(c) Laplacian multiplier
performance: ui bulk velocity of particle i
κρ0  ρi γ 
νk viscosity of phase k
pi = −1 , (4)
γ ρ0 V BNk viscosity blending number of phase k
ri , rj position of particle i, j
where γ is set to 7. WCSPH can achieve desired results, but small mi , ρ i mass, density of particle i
time steps are required for stiffer fluids, which increase the compu- γ̇ strain rate magnitude
tation cost tremendously. PCISPH, LPSPH and IISPH, etc. instead
D̃ rate-of-deformation tensor
enforce incompressibility under large time steps with an iterative or
ρ̃i adapted density of particle i
implicit approach.
, α, ξ user-defined coefficients
3.2 Position Based Fluids

The PBD method has been adopted in many simulation fields since To overcome particle under-sampling, which is a common problem
the work by Müller et al. [2007]. Maclin and Müller [2013] extend- in SPH simulation, an artificial pressure term [Monaghan 2000] is
ed this method to fluid simulation. Following the work by Bodin et introduced. This additional term improves the simulation perfor-
al. [2012], the density constraint on the i-th particle is defined as mance while not being purely physical. Undesired damping can
follows: also be introduced to the PBD framework too. To deal with this
ρi problem, the vorticity confinement method introduced by Fedkiw
Ci = − 1. (5)
ρ0 et al. [2001] and extended by Hong et al. [2008] and Lentine et al.
The position of the i-th particle is iteratively adjusted to satisfy the [2011] is adopted. The XSPH method [Monaghan 1989; Schechter
density constraint. The i-th particle’s position change in one iter- and Bridson 2012] is also adopted to provide better particle distribu-
ation ∆ri lies along the direction of constraint gradient, and the tions in the simulation. We refer readers to the literature [Macklin
position change follows: and Müller 2013] for more information on position based fluids.

∆ri = ∇Ci λ, (6)


4 Navier-Stokes-Cahn-Hilliard Model
where λi is determined from the constraint values of neighborhood
particles. If all particles have the same mass, λi is given by The Cahn-Hilliard equation [Cahn and Hilliard 1958] comes from
mathematical physics and aims to describe the process of phase
Ci separation. It has been adopted to model many physical multiple-
λi = − P . (7)
j |∇C i|
2 fluid phenomena (e.g., [Jacqmin 1999]). The Navier-Stokes-Cahn-
Hilliard (NSCH) model combines the Cahn-Hilliard equation with
the Navier-Stokes equation for fluid simulation problems. It was
Macklin et al. [2014] note that it is crucial to take mass into con- originally used for two-phase systems and was later extended to
sideration when dealing with different phases or fluid-solid cou- ternary or multiple-phase systems. We first briefly describe the
pling. Then, weighted by the inverse of the mass matrix M = NSCH model, then demonstrate how it can be used to enhance
diag(m1 , .., mN ), the position change is updated by the following: multiple-fluid simulation from an energy point of view.

∆ri = M−1 ∇Ci λ, (8)


4.1 Governing Equations
and the updated λi is:
Real-world phenomena tend to evolve from high-energy states to
Ci low-energy states. In the Cahn-Hilliard equation, the energy law
λi = − . (9) serves as the key source of components’ fraction changes. For a
∇Ci M−1 ∇CiT
ACM Transactions on Graphics, Vol. 34, No. 6, Article 201, Publication Date: November 2015
201:4 • T. Yang et al.

certain phase, it gives:

∂c
+ ∇ · (cu) = ∇ · (M ∇µ), (10)
∂t
where c is the order parameter that represents the relative concen-
tration of one of the phases or components. We take this to be the
mass ratio of one of the phases or components in a heterogeneous
mixture. M is the degenerate mobility, which can be constant or
may vary according to the value of c. In our implementation, we
define M in a way that does not rely on c. µ is the chemical poten-
tial. In the case of two-phase flows, it can be calculated as:

∂ε(c) Figure 2: The effect of surface tension force. The surface tension
µ= , (11) coefficient is set to be a large value in order to obtain notable re-
∂c
sults. Left: initial state; Right: final state after driven by SF .
where ε(c) is the so-called Ginzburg-Landau free energy density:
The β(c) term can be taken according to Garcke et al. [1998] as:
2 2
ε(c) := F (c) + ∇c , (12)
2 1 X ∂F
β(c) = − . (19)
n ∂ck
k
where Ω is the domain occupied by the system. F (c) is the
Helmholtz free energy. The form of F (c) plays a key role in simula-
As M does not rely on c, it is not difficult to verify that the ex-
tions of various multiple-fluid phenomena, which we will discuss in
istence of β(c) makes the summed change of ck zero, ensuring
detail in §4.2.  is associated with diffuse-interfaces and can be van-
physical meaningfulness during the fraction change process. How-
ishingly small describing immiscible fluids. The Ginzburg-Landau
ever, in our experiments, Eqn (18) cannot always be satisfied due to
free energy is the sum of two distinct parts: bulk part, which is inde-
numerical errors and discretization. We adopt a correction process
pendent of the spatial derivatives of phase quantities; and interfacial
according to the work by Ren et al. [2014].
part, which depends on the spatial gradient of the phase variable. In
L2 space, combining Eqn (11) and Eqn (12), the formulation of The reactive stress term can be set according to Kim [2009] as:
chemical potential can be expressed as: X σk,l  
SF = sf (ck ) + sf (cl ) χ(ck , cl ), (20)
dF (c) 2
µ= − 2 ∇2 c. (13) k,l(l>k)
dc
where σk,l is the
√ surface tension  coefficient between phase k and l.
∇ck
Cahn-Hilliard equation is well-known for its properties of energy sf (ck ) = −6 2∇ · |∇c k |
|∇ck |∇ck and χ(ck , cl ) = 5ck cl .
dissipation and mass conservation when the natural no-flux bound- Eqn (20) is known as the generalized continuous surface tension
ary conditions are used. force proposed to avoid the solvability problem imposed by the
over-determined system [Boyer and Lapuerta 2006]. The effect of
According to Badalassi et al. [2003], Jacqmin [2000], and Kim this surface tension term is illustrated in Fig.2, where the tension
[2005; 2007; 2012], the equations of NSCH for an n-phase fluid force minimizes the surface areas and slows the diffusion between
are: phases (resulting sharper interfaces).

4.2 Helmholtz Free Energy and Gibbs Triangle


Du 1
= − ∇p + g + ∇ · (ν∇u) + SF , (14)
Dt ρ According to Eqn (10), the state of a multiple-phase fluid will e-
∇ · u = 0, (15) volve in the direction of decreasing total chemical potential, which
in turn relies on the Helmholtz free energy. The Helmholtz free en-
Dck ergy is an internal energy of the material that determines the final
= ∇ · (M ∇µk ), (16)
Dt stable state. By properly setting different forms of Helmholtz free
∂F energy equations, the NSCH model can produce various energy-
µk = − 2 ∇2 ck + β(c), (17)
∂ck driven visual effects. For cases containing less than 3 phases, prop-
er energy functions can be designed with the help of energy plots or
where ρ is the aggregate density, ν is the aggregate viscosity, and u the so-called Gibbs triangle. We will demonstrate such designation
is the bulk velocity. SF is a reactive stress term that captures the method in this section.
interaction forces between different phases. ck , µk are respectively We first begin with two-phase fluids. In this case the energy plot can
the k-th phase’s mass ratio and chemical potential. For a consistent be represented by an energy-curve plot relying on the mass fraction
labeling convention, we use subscripts k, l to represent phases and of one of the two phases, which is between 0 and 1. To capture
i, j for particles. c is a vector that represents the mass fraction of a rich visual results in a two-phase system, we use the following free
single particle. D/Dt is the substantial derivative used to replace energy equation unless explicitly mentioned:
the Eulerian expression ∂/∂t+u·∇. Admissible states will belong
to the Gibbs n-simplex: F (c) = α(c1 − s1 )2 (c2 − s2 )2 , (21)
( n
)
where α is a user-defined diffusional coefficient. s1 , s2 ∈ [0, 1].
n
X
G := c ∈ R ci = 1, ci ∈ [0, 1] . (18)
i=1
Generally, there are two minima i.e., (s1 , 1 − s1 ), (1 − s2 , s2 ) in
ACM Transactions on Graphics, Vol. 34, No. 6, Article 201, Publication Date: November 2015
Fast Multiple-Fluid Simulation Using Helmholtz Free Energy • 201:5

ing the Helmholtz free energy function remains unchanged. For


example, we can use a Gibbs tetrahedron instead of a Gibbs trian-
gle when there are 4 phases. When there are many phases of the
simulation, it can be beneficial to adopt the phase labeling method
(PLM) originated from the traditional particle labeling method, sep-
arating the phases into several “interacting groups”. The number of
concerned phases in a single group can be much smaller, making
the energy functions easier to set up.

5 Implementation
We introduced the ideas of particle based simulations (SPH and
PBF) and NSCH respectively in Sections 3 and 4. In this sec-
tion, we provide practical integration implementations. Inspired by
Macklin and Müller [2013] and Ren et al. [2014], we update every
particle’s mass ratio first in each time step and then apply the effects
Figure 3: Contour plot of the Helmholtz free energy on the Gibbs
of the extra reactive stress along with the viscosity. Our PBD based
triangle. Each point in this triangle relates to a state in which the
algorithm is outlined in Algorithm 1.
local fluid contains the corresponding fraction of each of the three
phases. Values of Helmholtz free energy in each state are color-
plotted (red for high energy and blue for low). The two minima in Algorithm 1 Simulation Loop
this plot correspond to the final stable states. 1: for all particles i do
2: apply external forces to predict position
3: end for
this energy plot. By setting s1 , s2 to different values, this energy 4: for all particles i do
function can be adopted to simulate different two-phase phenome- 5: find neighboring particles
na. For example, to generate the process of phase separation, s1 , s2 6: end for
are set to 0, while they are set to 0.5 in order to capture the opposite 7: for all fluid particles i do
phenomenon of complete dissolution. The liquid partial dissolu- 8: for each phase k do
tion (Fig.7) happens when two miscible fluids cannot be arbitrari- 9: apply Cahn-Hilliard equation
ly mixed and have fully-saturated fraction limits within each oth- 10: end for
er. This will lead to the formation of two separated fully-saturated 11: end for
mixtures with different phases as solvent. In our experiments, this 12: while iter<solverIterations do
phenomenon can be captured by placing two local minima in the 13: accumulate position changes via density constraint
energy plot at the corresponding saturation points, i.e., simply set- 14: end while
ting s1 = s2 = 0.4 in our example. 15: for all particles i do
16: update velocity
For three-phase fluids the energy plot becomes a Gibbs triangle. 17: apply vorticity confinement, viscosity and reactive stress
In Fig.3, each vertex represents the state in which the local fluid 18: update position
contains only a single phase, and each point in the triangle repre- 19: end for
sents a mixed state with corresponding fractions of each of the three
phases. The Helmholtz energy function defined on this triangle is
Most of our implementations are based on Algorithm 1 in order
color-plotted. In this case we use an energy equation describing
to take advantage of enforcing incompressibility and stability with
chemical extraction phenomena as follows:
large time steps. The accuracy of Algorithm 1 will be discussed in
  §5.1.
F (c) = α c21 (c1 −0.3)2 +(c2 −0.7)2 (c2 −0.5)2 +c23 (c3 −0.5)2 .
(22) The NSCH model can also be readily integrated with standard SPH
solvers. In our experiments, we take this energy-driven Cahn-
The two minima of F (c) are (0.3, 0.7, 0), (0, 0.5, 0.5). As can be Hilliard equation as a phase diffusion process and apply it before
observed in Fig.3, the state with phase A dissolved in phase C has the main process of SPH in every time step. Ren et al. [2014] add
a lower energy minimum than the state with phase A dissolved in a pressure correction step after the update of volume fraction. It
phase B, so when C is added to the mixture of A and B, it will brings more physical basis during the volume fraction change pro-
extract A from B, resulting in a mixture of A and C separated from cess and can potentially provide better incompressibility. Since we
a nearly-pure phase B. do not consider phase-related drift velocity and pressure, and as a
result Eqn (15) can be applied to handle incompressibility, it is not
Some important principles should be followed when designing en- necessary to include such a correction step for achieving plausible
ergy functions: (1) The partial derivative of the chemical potential visual simulation.
with respect to a certain phase should be related to the mass ratio of
this phase only, otherwise mass conservation can be broken and un-
expected phases would appear at undesired places. (2) The minima 5.1 SPH Formulation
of energy functions should locate within the area of Gibbs triangle
to ensure the stability of the final states. Eqn (2) is commonly used in particle systems for density calcula-
tion of particles. Solenthaler and Pajarola [2008] provided a mod-
By placing minima at different positions in the Gibbs triangle and ification to simulate immiscible multiple-fluids with high density
adjusting their energy values, the interactive behavior of the three ratio. Their method uses the adapted density:
phases can be intuitively designed for flexible simulation. X
ρ̃i = mi Wij . (23)
For cases containing more than 4 phases, the basic idea of design- j

ACM Transactions on Graphics, Vol. 34, No. 6, Article 201, Publication Date: November 2015
201:6 • T. Yang et al.

Either equation can be used to estimate density. In our experiments,


Eqn (23) gives better results, because of its ability for per-particle
self-adaptation, especially in the case of high density ratios.
The gradient or Laplacian of a function defined on particles is cal-
culated according to Monaghan [1992], Morris et al. [1997], Müller
et al. [2003], and Ihmsen et al. [2014]. For stability, we always use
symmetric formulations. For each particle:
µ µj 
i
X
∇µi = ρi mj 2 + 2 ∇Wij , (24)
j
ρi ρj Figure 4: Position based patterns. We extend the free energy func-
X mj rij · ∇Wij tions to be associated with position, achieving various interesting
∇ · (Mi ∇µi ) = (Mi + Mj )µij 2 , (25) patterns with our multiple-fluid solver. Left: gray image; Right:
ρ j rij + η 2
j colored image.
X mj rij · ∇Wij
∇2 ci = 2 cij 2 , (26)
j
ρ j rij + η 2
5.3 Extended Mobility
where µi , ci are n-component vectors for the i-th particle for an
n-phase fluid system. µij = µi − µj . cij = ci − cj . Mi is the In the original NSCH model, degenerate mobility is only associ-
mobility of i-th particle. η is a small positive scalar and is set to ated with mass fraction and in most cases is constant. We extend
0.1h (e.g., [Ihmsen et al. 2014]). Other spatial derivatives in NSCH this mobility to expand the simulation range of NSCH models to
equations can be found in a similar way to the equations above. capture more complex fluid-fluid interaction, such as handling cer-
tain motion-related mixing phenomena. Such phenomena usually
There exists a fourth-order spatial derivative in Cahn-Hilliard equa-
involve several phases, which stay separated at rest, but become
tion. Due to the sensitivity of high order derivatives, stable simula-
mixed under kinetic interaction. A commonly observed case is
tion cannot be achieved if using the fourth-order derivative directly,
whisking eggs in a bowl. To capture these phenomena, extended
especially with kernel function in particle systems. We approxi-
mobility is a feasible approach.
mate this fourth-order derivative with a bi-Laplacian formulation
as in previous works. The accuracy of this formulation in SPH has Since more obvious mixing phenomena are observed with larger
been well explored (e.g., [Hirschler et al. 2014]). kinetic differences, we define the extended mobility in a continuous
way:
This fourth-order derivative in space also introduces a time step re- 1
striction for stability because of the large difference stencils. How- M= , (31)
ever, in our experiments, even large time steps under PBD frame- 1 + e−ξ(γ̇−γ̇0 )
work are proper. PBD uses a small number of iterations to accu- where γ̇ is the strain rate magnitude. γ̇0 indicates the threshold. ξ
mulate position changes and is unlikely to converge in every single relates to the steepness of M .
step. This property slows the diffusion process. External forces
such as shaking the bottles are adopted to increase the probability The strain rate magnitude is defined as:
of particle collision for the purpose of diffusing concentrations. p
γ̇ = 2D̃ : D̃, (32)
5.2 Variable Density and Viscosity
where D̃ is the rate-of-deformation tensor, which is defined below:
We use the harmonic average for the aggregate density as follows:
 X c −1 1 n ∂ux ∂uy o
ρ=
k
, (27) D̃ = + , (33)
ρk 2 ∂ry ∂rx
k

where k indexes the set of phases. It is not difficult to verify that where x, y indicate the components of vector. Following the work
the above average using mass fraction values is equivalent to linear by Monaghan [1992], the (x, y)’s component of D̃ of i-th parti-
average using the volume fraction values. cle can be computed in particle systems using standard SPH style
estimator:
The aggregate viscosity can be handled in a similar way as in the
original NSCH model. However, in our experiments, this method is
a simple but imperfect choice. To estimate the viscosity of a mix-
ture more precisely, we choose the Refutas method [Maples 2000] 1 X mj  
(D̃x,y )i = (uij )x ∇y Wij + (uij )y ∇x Wij , (34)
which has been commonly used in engineering calculations instead. 2 j ρj
To calculate the viscosity of a mixture, a viscosity blending number
(VBN) of each phase should first be calculated as follows:
 where (uij )x , ∇x Wij are the x’s components of uij and ∇Wij .
V BNk = 14.534 × log log(νk + 0.8) + 10.975, (28)
The extended mobility in Eqn (31) is related to the shear rate which
then the VBN of the mixture is: is rotationally invariant. In practice, we set the threshold in Eqn (31)
X
V BN = ck V BNk , (29) to a sufficiently large value, minimizing the value of mobility when
k
the magnitude of strain rate is (close to) zero to prevent unexpected
mixing under slight disturbance. There also exists a numerical up-
finally, the viscosity of the mixture is estimated below: per bound in Eqn (31), which is critical to ensure numerical stability
 V BN − 10.975  especially when the shear rate is too high. Desired visual results are
ν = exp exp( ) − 0.8. (30) achieved when simulating motion-related mixing phenomena such
14.534
as egg-mixing shown in Fig.1.
ACM Transactions on Graphics, Vol. 34, No. 6, Article 201, Publication Date: November 2015
Fast Multiple-Fluid Simulation Using Helmholtz Free Energy • 201:7

5.4 Position Based Pattern

Using our energy driven multiple-fluid solver, the final stable states
can be intuitively designed by placing local minima of free ener-
gy functions at different positions in the energy plot or the Gibbs
triangle for two- or three-phase fluids respectively, as discussed in
§4.2. Helmhotz free energy functions are typically designed with
pre-settled final states which are user-defined constants. We extend
this design formulation to generate interesting visual patterns.

The key is to extend the traditional Helmholtz free energy to be


associated with position-controlled potential energy. In this way,
any desired patterns can be achieved. For example, gray images
can be straightforwardly considered to be mixtures of two phases
which are pure black and pure white. To simplify the numerical
analysis, we change Eqn (21) as follows:

F (c) = α (c1 − s1 )2 + (c2 − s2 )2 .



(35)

To generate a gray image pattern as shown in Fig.4 using the


multiple-fluid system, particles play the role of sampling points and
their stable states vary in space. For instance, in 2D, the stable state
of a particle at the position of (rx , ry ) should relate to the gray val-
ue (sg , sg ∈ [0, 1]) at the mapping coordinate (Rx , Ry ) in the gray
image. We set s1 = sg , s2 = 1 − sg .

Since the stable states vary in space, this would bring some nu-
merical effects to the NSCH equations. Substituting Eqn (35) to Figure 5: Performance Comparison. From left to right, two liquids
Eqn (17), then Eqn (16) gives: (Red and Blue) mix and then unmix in a hourglass. All three im-
plements achieve similar results. Top: PBD based NSCH; Middle:
Dck WCSPH based NSCH; Bottom: [Ren et al. 2014].
= ∇ · (M ∇µ̃k ) − 2α∇ · (M ∇sk ), k ∈ {1, 2}, (36)
Dt

where µ̃k = 2αck −2 ∇2 ck +β(c), which is irrelevant to sk . If sk 5.5 Chemical Reaction
is constant, the second term of the right side of Eqn (36) vanishes.
If sk varies in space as discussed above, this term matters. The Visualization of a chemical reaction can also be a practical exten-
effect of this non-vanishing term in this section depends on how sk sion of our method. Owing to the convenience of the mass fraction
is set in space and it can accelerate or slow P the diffusion process representation, this phenomenon can be simply handled by adding
compared to previous vanishing cases. Since k sk = 1, this non- an in-particle re-balance step in every time step [Ren et al. 2014].
vanishing term accelerates the diffusion of some phases but slows Since Helmholtz free energy is associated with phase variables, it
that of others. All in all, it steers phases to the final result resting in matters how we label the newly generated phases. In our experi-
desired patterns. ments, phases that take part in a chemical reaction as reactants are
considered to be within the same group, and each newly generated
As shown in Fig.4, our extended method can also be used to ob-
phase is considered to be within a separate group. This labeling
tain colored patterns rather than just gray ones. To obtain colored
simplifies the designing work for energy functions and prevents the
patterns, we assume there exist 4 different phases. The RGB color
unexpected diffusions between reactants and products.
(R, G, B) of each pixel in the image is used to represent the target
mass fraction:
5.6 Boundary Condition
R G B R+G+B
s1 = , s 2 = , s 3 = , s 4 = 1 − , (37)
3 3 3 3 We use particles to represent anomalous boundaries. Thus, it is crit-
ical to prevent fluid particles penetrating and clustering. Akinci et
al. [2012] provided a versatile rigid-fluid coupling approach using
where R, G, B ∈ [0, 1]. With a generalization of Eqn (35), the per-particle correction. We adopt this method in our SPH based im-
energy function can be chosen as: plementation. However, as discussed in the work by Macklin et al.
X [2014], there are no explicit pressure forces existing in the original
F (c) = α (ck − sk )2 , k ∈ {1, 2, 3}. (38) PBF. To solve this problem, we treat the boundary-fluid pressure
k and friction forces computed according to Akinci et al. [2012] as
part of external forces in our implementations. Typical penetrat-
ing and clustering problems can be avoided in our experiments as
We only use c1 , c2 , c3 to represent colors. The numerical effects shown in all examples.
are just the same as discussed previously.
Boundary particles do not take part in the phase diffusion process.
Position based patterns are commonly observed phenomena e.g., No boundary particles are considered in line 9 of Alg.1 where E-
water eutrophication and electrolyte solution. We provide a flexible qn.(16) is applied. This no-flux boundary conserves both the total
and reasonable approach to artistically control their behaviors. and phases’ masses.
ACM Transactions on Graphics, Vol. 34, No. 6, Article 201, Publication Date: November 2015
201:8 • T. Yang et al.

6 Performance and Results Table 2: Performance on Benchmark Examples

Example solver phases particles steps/frame msec/frame


6.1 Performance Analysis
Extraction PBD 3 110k 4 92.5
Partial PBD 2 112k/131k/181k 4 78.4/88.9/114.2
We compare our results mainly to the state-of-the-art work [Ren Egg PBD 2 75k 3 69.3
et al. 2014], which takes drift velocity of different phases or com- Bunny PBD 7 260k 3 115.4
ponents into account and achieves various real-world multiple-fluid Lena PBD 2 177k 4 66.7
phenomena. Mona Lisa PBD 4 309k 4 120.9

Implementation & Visual Comparison: Our method can be im- Hourglass PBD 2 134k 4 68.9

plemented with both SPH and PBD frameworks. Although the WCSPH 2 134k 16 133.3

work by Ren et al. [2014] can also be readily integrated into SPH [Ren et al. 2014] 2 132k 16 566.8

framework, we found the integration of their method with PBD


rather complex and not straight-forward. To ensure the fairness of
comparison, we set up similar mixing/unmixing simulations and into several “interacting groups”. From left to right, the first and
then simulate them using the WCSPH based method by Ren et al. second dambreaks contain 3 phases which consist of same phase
[2014] and our WCSPH and PBD based approaches respectively. group and present the process of extraction as shown in Example
The simulation results can be found in Fig.5. All these imple- 1 (Fig.6). The middle two simulations of dambreaks preform the
mentations achieve similar results. The PBD-based implementation phenomena of chemical reactions (i.e., the reaction is A + B = 2C),
presents its abilities on stability and enforcing impressibility under producing a new green phase. The two reactants are in the same
large time steps. group while the product is in another group. The last simulation of
Speed Comparison: We implement our algorithm with CUDA and dambreak is immiscible with the other 6 phases, in another single
run on an NVIDIA GeForce GTX 980 GPU. Performance for these group.
examples can be found in Table 2. The particle numbers given in- There exist some user-specified parameters (i.e., , α, ξ, γ̇0 ) that
clude both fluid and boundary particles. Overall, for a simulation provide more flexibility for artistic design. ξ and γ̇0 are only used
with an equal number of particles and phases, we observe about in Example 3 (Fig.1), and we set  = 0.01 in all our examples. The
one order of magnitude performance improvement over the work simulation can remain stable even if these parameters vary, due to
by Ren et al. [2014] with PBD framework and 4 times speed-up the unconditional stability of PBD.
with SPH framework.

6.2 Results 7 Conclusion and Discussion

Fluid Extraction: Example 1 (Fig.6) shows that our model can In this paper, we have presented an energy based method to simu-
be used to simulate the energy-driven process of extraction. The late multiple-fluid phenomena. The results show that our method
energy function is set to Eqn (22). In the beginning, a blue liquid produces visually plausible results while expanding the capability
and a mixture of red and green liquids (shown as a yellow liquid) of existing models. Examples like fluid extraction and particle dis-
are initialized in a separating funnel. The green liquid has greater solution are beyond the capability of previous methods that we are
solubility in the blue liquid than in the red one. Thus, after vigorous aware of. Real-world phenomena like modeling and simulation of
mixing, the blue liquid extracts the green liquid out of the red liquid, mixtures of water and oil, visual simulation of mud sliding, sed-
resulting in a layer of red liquid on top of a cyan mixture. imentation processes, and avalanches due to natural disasters are
highly correlated with energy. These are real-world scenarios in
Partial Dissolution: Example 2 (Fig.7) is an example of partial which our work could be useful, offering several further possible
dissolution from chemistry. The energy function is set to Eqn (21) extensions. Our method can be readily integrated with state-of-
where s1 = s2 = 0.4. From left to right, the same volume of blue the-art SPH solvers, showing its potential for various applications.
liquid is used for each of the 3 cases while the volume of red liquid Offering practical integration with PBD framework, this approach
doubles each time. The results show that when the volume of one is more flexible and stable with larger time steps than traditional
of the liquids, either red or blue, is greater than the other, the two SPH-based methods.
liquids generate a homogeneous one-phase mixture at the end. If
both liquids are saturated with the other, they generate two separate As discussed in §5.1, our method suffers from slow convergence,
fully-saturated mixtures. which is the result of the bi-Laplacian formulation, discretization,
and PBD. Although our method can ensure stable simulations with
Egg Mixture: Example 3 (Fig.1) demonstrates that the capability large time steps, special attention is required to avoid the occur-
of the NSCH model can be expanded via extended mobility using rence of negative values of c as much as possible, i.e., the time
an everyday example of mixing egg white and egg yolk. Unlike steps and the Helmhotz free energy should be chosen in a way to
other examples where the mobilities are constant, we use the ex- ensure that the changes of c during a single step do not exceed the
tended mobility discussed in §5.3. And the energy function is set values of c. In our experiments, negative values of c do exist due
to Eqn (21) where s1 = s2 = 0.5. The mixture of egg white and to discretization, numerical errors, and casually chosen parameters.
egg yolk at any mass fraction remains stable when it is still. When The simulations can stay stable with our correction process as men-
slightly shaking or rotating the bowl as a whole, there is no obvious tioned in §4.1, althrough they will lose the capability of conserving
mixing. However, when stirring the mixture with a whisk, the local the masses of phases.
shear rate becomes significant, resulting in strong mixing.
Ignoring the drift velocity simplifies the implementation, analysis,
Multiple Liquids & Chemical Reaction: Example 4 (Fig.8) and control, enabling better performance, e.g., incompressibility as
demonstrates the ability of our approach to deal with simulations discussed in §5. However, without the drift velocity, our method
with more than 3 phases as well as to simulate the phenomena of inevitably loses some capabilities. For instance, in the process of
chemical reactions. There are 5 dambreaks at the beginning and 7 unmixing, different phases separate at every corner of the simula-
phases in total. We adopt the phase labeling method to divide them tion domain simultaneously and then form layers driven by gravity
ACM Transactions on Graphics, Vol. 34, No. 6, Article 201, Publication Date: November 2015
Fast Multiple-Fluid Simulation Using Helmholtz Free Energy • 201:9

Figure 6: Fluid extraction. From left to right,(a) At the beginning, the blue liquid and yellow mixture are put in a separating funnel. (b) The
funnel is inverted. (c) Shaking vigorously mixes the fluids. (d) Turning the funnel upright results in a clear interface between a red liquid and
a cyan mixture. Due to greater solubility of the green liquid within the blue liquid, the blue liquid extracts the green liquid from the red liquid.
The whole process is driven by Helmholtz free energy and conserves volume.

Figure 7: Partial dissolution. From top to bottom, three different cases are initialized with the same volume of green liquid and different
volumes of red liquid. From left to right, all three cases illustrate the process of dambreak and mixing with a yellow stick. The final states
in the three cases are very different because of fully-saturated fraction limits. In the first case, there is more blue liquid, and the red liquid
dissolves into the blue liquid completely. In the second case, both the red and blue liquids are comparable in volume, and each partially
dissolves in the other. In the third case, there is more red liquid, and the blue liquid completely dissolves in the red liquid. Both first and third
cases result in homogeneous mixtures while the second produces two fully saturated mixtures.

Figure 8: Multiple-fluid simulation. Our model can easily be adopted to simulate fluids with an arbitrary number of phases as well as handle
phenomena of chemical reactions. From left to right in the first image: The first and second simulations of dambreaks with 3 phases are in
a group and present the process of extraction, the middle two simulations of dambreaks achieve the visual effects of chemical reaction and
generate a new green phase, and the last dambreak is independent with other phases.

ACM Transactions on Graphics, Vol. 34, No. 6, Article 201, Publication Date: November 2015
201:10 • T. Yang et al.

and buoyancy with our method. This whole process differs from B OYD , L., AND B RIDSON , R. 2012. MultiFLIP for Energetic
real-world layering, e.g., sedimentation. Furthermore, with the drift Two-Phase Fluid Simulation. ACM Transactions on Graphics
velocity, different phases move at different velocities in the mixture. (Proceedings of SIGGRAPH 2012) 31, 2 (Apr.), 16:1–16:12.
These discrepant motions play a key role in the process of motion-
induced mixing, resulting in relative mass migration. However, this B OYER , F., AND L APUERTA , C. 2006. Study of a three component
motion-induced mixing cannot be well addressed without the drift Cahn-Hilliard flow model. ESAIM:M2AN 40, 4, 653–687.
velocity, and this points out the essential reason for the slow diffu- B RACKBILL , J. U., AND RUPPEL , H. M. 1986. FLIP: A method
sion with our method apart from the slow convergence as mentioned for adaptively zoned, particle-in-cell calculations of fluid flows
above. We hope to take the drift velocity into consideration in the in two dimensions. Journal of Computational Physics 65, 2,
future. 314–343.
The aggregate viscosity is crucial for real-world simulation. We C AHN , J. W., AND H ILLIARD , J. E. 1958. Free Energy of
have introduced the Refutas method, which is simple and plausi- a Nonuniform System. I. Interfacial Free Energy. Journal of
ble. However, this issue is much more complex than discussed, i.e., Chemical Physics 28, 2, 258–267.
the viscosities of non-Newtonian fluids are mostly shear-dependent,
however we haven’t taken this into account. It deserves more efforts C OMMINS , S., AND RUDMAN , M. 1999. An SPH Projection
and further research. Method. Journal of Computational Physics 152, 2, 584–607.

The PBD framework enables the use of large time steps which are C ORNELIS , J., I HMSEN , M., P EER , A., AND T ESCHNER , M.
critical for real-time simulation. Our method can offer simulation in 2014. IISPH-FLIP for incompressible fluids. Computer Graph-
real time but the results require computationally expensive volume ics Forum (Proceedings of Eurographics 2014) 33, 2, 255–262.
rendering. We hope to develop a real-time multiple-fluid rendering DA , F., BATTY, C., AND G RINSPUN , E. 2014. Multimaterial
technique in the future. Mesh-Based Surface Tracking. ACM Transactions on Graphics
(Proceedings of SIGGRAPH 2014) 33, 4, 112:1–112:11.
Nielsen and Østerby [2013] simulated spray in the Eulerian domain
using a two-continua approach, which treats mist in a miscible fluid F EDKIW, R., S TAM , J., AND J ENSEN , H. W. 2001. Visual Simu-
kind of way. It would be practical to combine their work with ours. lation of Smoke. ACM Transactions on Graphics (Proceedings
of SIGGRAPH 2001), 15–22.
We note that temperature plays important roles in multiple-fluid
simulation. We aim to take into consideration the further expan- G ARCKE , H., N ESTLER , B., AND S TOTH , B. 1998. On Anisotrop-
sion of the simulation range for multiple-fluid in the future. ic Order Parameter Models for Multi-Phase Systems and Their
Sharp Interface Limits. Physica D: Nonlinear Phenomena 115,
1-2, 87–108.
Acknowledgements
H E , X., L IU , N., WANG , H., AND WANG , G. 2012. Local Poisson
We would like to thank Sarah George-Waterfield and Ehtzaz SPH For Viscous Incompressible Fluids. Computer Graphics
Chaudhry for helping to proofread the final version of this pa- Forum 31, 6, 1948–1958.
per. We also thank the anonymous reviewers for their construc-
H IRSCHLER , M., H UBER , M., S ÄCKEL , W., K UNZ , P., AND
tive comments. This work is supported in part by the Ministry of
N IEKEN , U. 2014. An Application of the Cahn-Hilliard Ap-
Education of the People’s Republic of China, the EU project Dr.
proach to Smoothed Particle Hydrodynamics. Mathematical
Inventor (FP7-ICT-2013.8.1 611383), and the U.S. National Sci-
Problems in Engineering 2014(694894):10.
ence Foundation. The earlier research leading to this project al-
so received funding from the People Programme (Marie Curie Ac- H ONG , J.-M., AND K IM , C.-H. 2005. Discontinuous Fluids. ACM
tions) of the European Unions Seventh Framework Programme F- Transactions on Graphics (Proceedings of SIGGRAPH 2005)
P7 (2007-2013) under REA grant agreement No.612627-“AniNex”, 24, 3 (July), 915–920.
and University of North Carolina Arts & Sciences Foundation.
H ONG , J.-M., L EE , H.-Y., YOON , J.-C., AND K IM , C.-H. 2008.
Bubbles Alive. ACM Transactions on Graphics (Proceedings of
References SIGGRAPH 2008) 27, 3 (Aug.), 48:1–48:4.

A KINCI , N., I HMSEN , M., A KINCI , G., S OLENTHALER , B., AND I HMSEN , M., C ORNELIS , J., S OLENTHALER , B., H ORVATH , C.,
AND T ESCHNER , M. 2013. Implict Incompressible SPH. IEEE
T ESCHNER , M. 2012. Versatile Rigid-Fluid Coupling for In-
compressible SPH. ACM Transactions on Graphics (Proceed- Transactions on Visualization and Computer Graphics 20, 03
ings of SIGGRAPH 2012) 31, 4, 62:1–62:8. (July), 426–435.
I HMSEN , M., O RTHMANN , J., S OLENTHALER , B., KOLB , A.,
BADALASSI , V. E., C ENICEROS , H. D., AND BANERJEE , S. AND T ESCHNER , M. 2014. SPH Fluids in Computer Graphics.
2003. Computation of multiphase systems with phase field mod- In Eurographics 2014 - State of the Art Reports, The Eurograph-
els. Journal of Computational Physics 190, 2, 371–397. ics Association, 21–42.
BAO , K., W U , X., Z HANG , H., AND W U , E. 2010. Volume frac- JACQMIN , D. 1999. Calculation of Two-Phase Navier-Stokes
tion based miscible and immiscible fluid animation. Computer Flows Using Phase-Field Modeling. Journal of Computational
Animation and Virtual Worlds 21, 3-4 (May), 401–410. Physics 155, 1, 96–127.
B ECKER , M., AND T ESCHNER , M. 2007. Weakly compressible JACQMIN , D. 2000. Contact-line dynamics of a diffuse fluid inter-
SPH for free surface flows. In Proceedings of SCA ’07, 209–217. face. Journal of Fluid Mechanics 402, 01, 57–88.
B ODIN , K., L ACOURSI ÉRE , C., AND S ERVIN , M. 2012. Con- K ANG , N., PARK , J., N OH , J., AND S HIN , S. Y. 2010. A Hybrid
straint Fluids. IEEE Transactions on Visualization and Comput- Approach to Multiple Fluid Simulation using Volume Fractions.
er Graphics 18, 3 (Mar.), 516–526. Computer Graphics Forum 29, 2, 685–694.
ACM Transactions on Graphics, Vol. 34, No. 6, Article 201, Publication Date: November 2015
Fast Multiple-Fluid Simulation Using Helmholtz Free Energy • 201:11

K IM , J. 2005. A continuous surface tension force formulation for M ÜLLER , M., H EIDELBERGER , B., H ENNIX , M., AND R ATCLIF -
diffuse-interface model. Journal of Computational Physics 204, F, J. 2007. Position Based Dynamics. Journal of Visual Com-
2, 784–804. munication and Image Representation 18, 2 (Apr.), 109–118.
K IM , J. 2007. A numerical method for the Cahn-Hilliard equation N IELSEN , M. B., AND Ø STERBY, O. 2013. A Two-Continua
with a variable mobility. Communications in Nonlinear Science Approach to Eulerian Simulation of Water Spray. ACM Transac-
and Numerical Simulation 12, 8, 1560–1571. tion on Graphics (Proceedings of SIGGRAPH 2013) 32, 4 (July),
67:1–67:10.
K IM , J. 2009. A generalized continuous surface tension force for-
mulation for phase-field models for immiscible multi-component PARK , J., K IM , Y., W I , D., K ANG , N., S HIN , S. Y., AND N OH ,
fluid flows. Computer Methods in Applied Mechanics and Engi- J. 2008. A Unified Handling of Immiscible and Miscible Fluids.
neering 198, 37-40, 3105–3112. Computer Animation and Virtual Worlds 19, 3-4 (September),
455–467.
K IM , B. 2010. Multi-Phase Fluid Simulations Using Regional
Level Sets. ACM Transactions on Graphics (Proceedings of SIG- P REMO ŽE , S., TASDIZEN , T., B IGLER , J., L EFOHN , A., AND
GRAPH Asia 2010) 29, 6 (Dec.), 175:1–175:8. W HITAKER , R. T. 2003. Particle-Based Simulation of Fluids.
Computer Graphics Forum 22, 3, 401–410.
K IM , J. 2012. Phase-Field Models for Multi-Component Fluid
R AVEENDRAN , K., W OJTAN , C., AND T URK , G. 2011. Hybrid
Flows. Communications in Computational Physics 12, 3, 613–
Smoothed Particle Hydrodynamics. In Proceedings of SCA ’11,
661.
33–42.
L ENTINE , M., A ANJANEYA , M., AND F EDKIW, R. 2011. Mass R EN , B., L I , C., YAN , X., L IN , M. C., B ONET, J., AND H U ,
and Momentum Conservation for Fluid Simulation. In Proceed- S.-M. 2014. Multiple-fluid SPH Simulation Using a Mixture
ings of SCA ’11, 91–100. Model. ACM Transactions on Graphics (Proceedings of SIG-
L IU , S., L IU , Q., AND P ENG , Q. 2011. Realistic simulation of GRAPH Asia 2014) 33, 5 (Aug.), 171:1–171:11.
mixing fluids. The Visual Computer 27, 3 (Mar.), 241–248. S CHECHTER , H., AND B RIDSON , R. 2012. Ghost SPH for Ani-
L OSASSO , F., S HINAR , T., S ELLE , A., AND F EDKIW, R. 2006. mating Water. ACM Transactions on Graphics (Proceedings of
Multiple Interacting Liquids. ACM Transactions on Graphics SIGGRAPH 2012) 31, 4, 61:1–61:8.
(Proceedings of SIGGRAPH 2006) 25, 3 (July), 812–819. S HAO , S., AND L O , Y. 2003. Incompressible SPH method for sim-
ulating Newtonian and non-Newtonian flows with a free surface.
M ACKLIN , M., AND M ÜLLER , M. 2013. Position Based Fluid-
Advances in water resources 26, 7, 787–800.
s. ACM Transactions on Graphics (Proceedings of SIGGRAPH
2013) 32, 4 (July), 104:1–104:12. S OLENTHALER , B., AND PAJAROLA , R. 2008. Density contrast
SPH Interfaces. In Proceedings of SCA ’08, 211–218.
M ACKLIN , M., M ÜLLER , M., C HENTANEZ , N., AND K IM , T.-
Y. 2014. Unified Particle Physics for Real-Time Application- S OLENTHALER , B., AND PAJAROLA , R. 2009. Predictive-
s. ACM Transactions on Graphics (Proceedings of SIGGRAPH corrective incompressible SPH. ACM Transactions on Graphics
2014) 33, 4, 153:1–153:12. (Proceeding of SIGGRAPH 2009) 28, 3, 40:1–40:6.
M APLES , R. E. 2000. Petroleum Refinery Process Economics. Z HU , Y., AND B RIDSON , R. 2005. Animating Sand as a Flu-
PennWell Books. id. ACM Transactions on Graphics (Proceedings of SIGGRAPH
2005) 24, 3, 965–972.
M ISZTAL , M., E RLEBEN , K., BARGTEIL , A., F URSUND , J.,
C HRISTENSEN , B., BARENTZEN , J., AND B RIDSON , R. 2012.
Multiphase Flow of Immiscible Fluids on Unstructured Moving
Meshes. In Proceedings of SCA ’12, 97–106.
M ONAGHAN , J. J. 1989. On the problem of penetration in particle
methods. Journal of Computational Physics 82, 1, 1–15.
M ONAGHAN. 1992. Smoothed Particle Hydrodynamics. Annual
Review of Astronomy and Astrophysics 30, 1, 543–574.
M ONAGHAN. 1994. Simulating Free Surface Flows with SPH.
Journal of Computational Physics 110, 2 (Feb.), 399–406.
M ONAGHAN. 2000. SPH without a Tensile Instability. Journal of
Computational Physics 159, 2 (Apr.), 290–311.
M ORRIS , J., F OX , P., AND Z HU , Y. 1997. Modeling Low
Reynolds Number Incompressible Flows Using SPH. Journal
of Computational Physics 136, 1, 214–226.
M ÜLLER , M., C HARYPAR , D., AND G ROSS , M. 2003. Particle-
Based Fluid Simulation for Interactive Application. In Proceed-
ings of SCA ’03, 154–159.
M ÜLLER , M., S OLENTHALER , B., K EISER , R., AND G ROSS , M.
2005. Particle-Based Fluid-Fluid Interaction. In Proceedings of
SCA ’05, 237–244.
ACM Transactions on Graphics, Vol. 34, No. 6, Article 201, Publication Date: November 2015

You might also like

pFad - Phonifier reborn

Pfad - The Proxy pFad of © 2024 Garber Painting. All rights reserved.

Note: This service is not intended for secure transactions such as banking, social media, email, or purchasing. Use at your own risk. We assume no liability whatsoever for broken pages.


Alternative Proxies:

Alternative Proxy

pFad Proxy

pFad v3 Proxy

pFad v4 Proxy