In this paper, we investigate phase-field interface capturing equations for two-fluid systems to probe their accuracy and computational cost. Two different schemes are considered: In the first scheme, one of the two order parameters is numerically solved based on a phase-field equation, while the other order parameter is determined through the summation relation; the summation of order parameters equals unity. In the second scheme, the two order parameters are both obtained numerically by solving their respective phase-field equations. A phase-field model based on the color-gradient (CG) method is chosen, and available lattice Boltzmann models are employed for solving the interface-capturing equations together with the hydrodynamic equation. It is shown that for the first scheme, which includes the summation relation, numerical results become asymmetrical. Also, in some cases, it results in nonphysical interfaces. In terms of computational resources, this first scheme is about 11% faster with 25% less computational memory usage than the second scheme. It is shown that only for a zero velocity domain do the two schemes lead to equal results. Also, a theoretical analysis is conducted to highlight the differences between the two approaches.

Multiphase (multi-fluid) flows are ubiquitous both in industry and in nature, including bubbles and droplets,1 contact lines,2 and flow in porous media,3 to name a few. Complex phenomena accompanied by different time and space scales make both analytical and experimental investigations of these systems difficult, often impossible. Numerical modeling is, therefore, an indispensable tool in investigating multiphase systems. Over the past years, different approaches have been proposed for capturing or tracking interfaces in multiphase systems, including the phase-field,4,5 volume-of-fluid (VOF),6 and level-set7,8 methods. The phase-field method is a diffuse interface, and order parameters (phase fields or volume fractions) are defined in such a way that they have their bulk values in the bulk fluids and change smoothly across the interfaces.9 The two most popular models in the phase-field method context are the Cahn–Hilliard (CH)4 and Allen–Cahn (AC)5 models. These models were first developed for binary fluids and then were extended to handle ternary10,11 as well as phase-changing systems.12,13

In modeling multiphase flows, one common relation is that the summation of the order parameters is equal to unity, hereafter called the summation relation. To the best of our knowledge, the effect of this relation on the results and resources when being employed in a numerical solver has not been explored. In the present work, we aim to show the effects of this analytical relation by conducting several numerical tests.

An alternative to classical methods, the lattice Boltzmann method (LBM) has experienced rapid development and attracted great attention during the past three decades, especially in fluid and thermal systems.14 Since its emergence, different methods have been proposed for multiphase systems.15 In this study, a recently developed color-gradient-based phase-field model is employed as the interface-capturing equation16 together with a robust lattice Boltzmann (LB) model for the hydrodynamic equations.10,17 Two different schemes are discussed; the first scheme is that one order parameter is determined based on the phase-field equation and the other order parameter is determined based on the summation relation (hereafter, we call this scheme the “one-eq scheme”). The second scheme is that we solve two phase-field equations to determine the two order parameters (hereafter, we call this scheme the “two-eq scheme”). The rest of this paper is organized as follows: In Sec. III, the LB model used for solving the two schemes (as one-eq and two-eq schemes) together with an LB model for recovering the hydrodynamic properties is described. In Sec. IV, the two schemes are investigated and compared with each other. We first start with a complex benchmark in which the interface-capturing equations together with the hydrodynamic equation are solved. Then, the velocity field is prescribed in a way that mimics a complex flow and a benchmark is conducted based on this velocity field. Then, over several benchmarks, the complexity of the velocity field is reduced to highlight the different behavior of the one-eq and two-eq schemes. Concluding remarks are presented in Sec. V.

The interface-capturing equations employed in this study were recently developed by Haghani et al.16 Consider a domain Ω comprised of two incompressible and immiscible fluids, named the red (subscript r) and the blue (subscript b) fluid. The continuity equation for each fluid reads as
ρ ̃ k t + · ( ρ ̃ k u k ) = 0 , k = r , b ,
(1)
where ρ ̃ k ( x , t ) and u k are the local density and local velocity of fluid k, respectively, x is the spatial location, and t is the time. The order parameter ϕ k of fluid k is defined as
ϕ k = ρ ̃ k ρ k , k = r , b ,
(2)
where ρk is the bulk density of fluid k. The order parameter ϕ k is zero (unity) when the cell is empty of (filled with) fluid k and changes across the interfaces. In analytical modeling, we assume that the summation of the order parameters is always equal to unity (summation relation),
k ϕ k = 1 , k = r , b .
(3)
However, it is not clear whether this relation holds in a numerical setting. The continuity equation (1) can be recast in the order parameter framework. Based on a recently developed model,16 the order parameters can be captured based on the following equations:
(4)
ϕ r t + · ( ϕ r u ) = · [ D ( ϕ r 4 ξ ϕ r ϕ b ϕ r + ϕ b n ) ] ,
(4a)
ϕ b t + · ( ϕ b u ) = · [ D ( ϕ b + 4 ξ ϕ r ϕ b ϕ r + ϕ b n ) ] ,
(4b)
where D is called mobility in the phase-field context.18  ξ is the interface thickness, and n is the unit vector normal to the interface with the following definition:
n = ϕ | ϕ | ,
(5)
where
ϕ ( x , t ) = 1 2 [ ϕ r ( x , t ) ϕ b ( x , t ) ϕ r ( x , t ) + ϕ b ( x , t ) + 1 ] .
(6)
The local density in the hydrodynamic equations is determined by the following relation:
ρ = ρ ̃ r + ρ ̃ b = ϕ r ρ r + ϕ b ρ b .
(7)

One can solve one of the two equations of (4) and compute the other order parameter based on the summation relation (3). In this case, relation (6) reduces to ϕ = ϕ r (assume that we solve the order parameter of the red fluid, as such ϕ b = 1 ϕ r). However, in the numerical simulations, due to overshooting and undershooting of the order parameters, employing relation (3) requires further care. Some remedies have been proposed such as using a lattice stencil with higher discrete velocities like D2Q17,19 or employing higher-order discretization schemes20 to reduce dispersion errors. As for the AC interface-capturing equation, Ren et al.21 showed that the numerical dispersion in the AC equation is large, and they implemented a cutoff value approach to restrict the order parameters to its theoretical range for simulating Rayleigh–Taylor instability (RTI). This is expected to violate mass concervation. Hu et al.22 proposed another approach by implementing a linear combination of the non-local (weight coefficient of zero) and local (weight coefficient of unity). They showed that a weight coefficient of 0.9 minimized the order parameter overshooting or undershooting; however, the underlying physics of this approach is not clear.

In Sec. IV, we will show that by considering the summation relation (3), results are asymmetrical and inaccurate. It is worth mentioning that we reach the AC interface-capturing equation if we solve one equation of (4).

All benchmarks in this study are conducted in 2D. A D2Q9 stencil is selected for both the interface-capturing and hydrodynamic equations. Also, for the hydrodynamic equation, a multi-relaxation time (MRT) collision operator is chosen for the RTI benchmark.17 A linear interpolation is used to update the relaxation time across the interface, i.e., τ = ϕ r τ r + ϕ b τ b with τ being the relaxation time. For the sake of briefness, we do not present the lattice Boltzmann equations (LBEs) employed in this study for solving the interface-capturing equations as well as the hydrodynamic ones. The models are presented in Refs. 10, 16, and 17 in detail.

Since we are only interested in the differences between the one-eq and the two-eq schemes, we used the same hydrodynamic equation for both schemes. Since there are different types of surface tension force,23 and in order to avoid their effects on numerical results, we simulate all benchmarks in this study with zero surface tension. It should also be noted that the interface-capturing equations are coupled to the hydrodynamic equation through the velocity field and the surface tension force is not embedded in the interface-capturing equations.24,25 To verify that the employed LB model is sufficiently accurate, we simulated Poiseuille flow for our two schemes and validated the results to the analytical solution, as shown in the  Appendix. In the following, we investigate the differences between the one-eq scheme and the two-eq scheme through analytical and numerical analyses.

In the following, a range of benchmarks are considered to investigate the differences between the one-eq and two-eq schemes. These two schemes are compared in terms of accuracy and computational cost. Throughout the paper, interface thickness ξ and the mobility D are, respectively, determined with the Cahn number (Ch) and the Péclet number (Pe) which are defined as
Ch = ξ L 0 ,
(8)
Pe = U 0 L 0 D ,
(9)
with L0 and U0 being length and velocity references, respectively. It should be mentioned that all quantities in this study are either dimensionless or in the LB units.

The RTI is our first benchmark for comparing the two schemes. RTI is extensively utilized for evaluating multiphase fluid models.16,17,26,27 This instability occurs when a heavy fluid (the red fluid here) is sitting on top of a lighter fluid (the blue fluid here) in a gravitational field. The heavy fluid moves downward pushing the lighter fluid to move upward. Two layers of fluids with the initial perturbation of y p = 0.1 L 0 cos ( 2 π x / L 0 ) at the interface are placed in a domain of size L 0 × 4 L 0. The top and bottom boundaries are considered to be walls, while the two side boundaries are treated as periodic. The surface tension is zero and L 0 = 256. The dimensionless numbers governing the physics are the Reynolds number Re = ρ r g L 0 L 0 / η r = 3000 and the Atwood number At = ( ρ r ρ b ) / ( ρ r + ρ b ) = 1 / 2, where η is the dynamic viscosity and g is the gravitational acceleration. Other parameters are set to η r / η b = 1 , Ch = 5 / 256, and Pe = 1000.

Figure 1 shows the interface, where the order parameter is ϕ = 1 / 2, at different dimensionless times t * = t / L 0 / ( g × At ) of the instability for the two schemes. It should be noted that for the one-eq scheme, we simulate two different cases. In one case, the red fluid equation is solved and the order parameter of the blue fluid is obtained via the summation relation (3). In another case, the order parameter of the blue fluid is solved based on the interface-capturing equation, and the order parameter of the red fluid is obtained via the summation relation (3). As can be seen, the results of the two schemes are similar at early times. However, at later times, the one-eq scheme sooner results in an asymmetrical interface with respect to a vertical line in the middle of the domain. It should be noted that due to floating-point effects,28 numerical results are asymmetric for both the one-eq and two-eq schemes. However, due to an additional term in the one-eq scheme for the other fluid, Eq. (10), the asymmetry happens faster in the one-eq scheme as Fig. 1 suggests. By changing the interface capturing equation from the red fluid to the blue fluid, the result changes for the one-eq scheme. Thus, the results depend on the fluid choice for which the interface equation is solved. Interestingly, the one-eq scheme for the blue fluid shows better symmetry. Note that since the density field is computed through the linear relation (7) and the densities of the two fluids are different, slight overshooting and undershooting of the order parameter in the one-eq scheme have different effects on the density field when the fluid of choice is changed. As shown in Fig. 4(a), the order parameter (6) used for calculation of the normal vector (5) shows higher oscillation when the red fluid is solved for which in return leads to higher asymmetry. On the other hand, in the two-eq scheme, the results are independent of the fluid of choice since both fluids are equally solved. It should be mentioned that, during the simulation, the droplets with radii smaller than three grid units do not shrink over time for both schemes, as apparent in Fig. 1(f).

FIG. 1.

Snapshot of the order parameter ϕ = 0.5 at different dimensionless times. The solid black line corresponds to the two-eq scheme, while the solid red line indicates the one-eq scheme when the red fluid is solved, and the solid blue line indicated the one-eq scheme when the blue fluid is solved for. Note that the result of the two-eq scheme is independent of the fluids.

FIG. 1.

Snapshot of the order parameter ϕ = 0.5 at different dimensionless times. The solid black line corresponds to the two-eq scheme, while the solid red line indicates the one-eq scheme when the red fluid is solved, and the solid blue line indicated the one-eq scheme when the blue fluid is solved for. Note that the result of the two-eq scheme is independent of the fluids.

Close modal

In Fig. 2, the divergence of the velocity field ( · u), calculated based on a finite difference scheme,29 is shown for the one-eq scheme when the red fluid is solved for. As can be seen, the velocity field is not divergence-free. This affects the solution of the one-eq scheme. We will conduct simulations with the same magnitude of divergence as this benchmark to show the effects of the hydrodynamic field on the interface-phase capturing equations (Secs. IV B–IV E).

FIG. 2.

Snapshot of the divergence of the velocity field · u at different dimensionless times. The black dashed lines indicate the interface profile ϕ = 0.5. These results are for the one-eq scheme when the red fluid is solved for. The other scenarios have qualitatively the same results.

FIG. 2.

Snapshot of the divergence of the velocity field · u at different dimensionless times. The black dashed lines indicate the interface profile ϕ = 0.5. These results are for the one-eq scheme when the red fluid is solved for. The other scenarios have qualitatively the same results.

Close modal

The time history of the system mass, i.e., M = Ω ρ d V, is shown in Fig. 3. Note that the red and blue lines overlap in the figure. As can be seen in Fig. 3, the mass of the system is not conserved in the two-eq scheme at early stages, which is in line with the findings of Fig. 2. At later stages, the deviation from the convergence value of unity for the two-sq scheme is about 0.01%. Based on Fig. 2, the divergence of the velocity field is more pronounced around the interfaces. This non-divergence-free condition leads to local mass conservation violation, which, in turn, results in total mass violation of the system. The reason why the one-eq scheme yields perfect conservation despite the non-divergence-free field needs further investigation which is out of the scope of the current study.

FIG. 3.

Temporal evolution of the domain mass. The mass is nondimensionalized with the initial value. The red line and the blue line correspond to the one-eq scheme when the red and blue fluid is solved for, respectively. The black dashed line corresponds to the two-eq scheme. Note that the blue line is fully covered by the red line.

FIG. 3.

Temporal evolution of the domain mass. The mass is nondimensionalized with the initial value. The red line and the blue line correspond to the one-eq scheme when the red and blue fluid is solved for, respectively. The black dashed line corresponds to the two-eq scheme. Note that the blue line is fully covered by the red line.

Close modal

To further investigate the differences between these two schemes, the time history of the maximum and minimum values of ϕ , ϕ r , ϕ b, and ϕ r + ϕ b are shown in Figs. 4 and 5, respectively. In order to have a clear presentation, we show the difference from the analytical value of 1 in Fig. 4. As can be seen in Figs. 4(a)–4(c), in the case of the two-eq scheme, the red and blue order parameters have a larger magnitude of oscillation around their equilibrium ones, especially at early times. Since the two order parameters are not strictly linked together through the summation relation (3) in the two-eq scheme, it takes more time for the two order parameters to reach equilibrium. Figures 5(a)–5(c) show that the variations of the minimum of ϕ , ϕ r, and ϕ b are almost the same for both schemes, except for the blue fluid at very early stages. Figures 4(d) and 5(d) indicate that the summation of two order parameters, i.e., ϕ r + ϕ b, is not always equal to unity in numerical modelings in contrast to the theoretical relation (3). Also, the maximum and minimum values of ϕ r + ϕ b reach their steady state at almost the same time of t * 80. Since the velocity field is not divergence-free, the summation cannot be unity, and imposing the restriction of Eq. (3) results in asymmetry and other problems which will be highlighted in the following benchmarks.

FIG. 4.

Temporal evolution of the relative maximum of (a) ϕ, (b) ϕ r, (c) ϕ b, and (d) ϕ r + ϕ b. The red line and the blue line correspond to the one-eq scheme when the red and blue fluid is solved for, respectively. The black dashed line corresponds to the two-eq scheme.

FIG. 4.

Temporal evolution of the relative maximum of (a) ϕ, (b) ϕ r, (c) ϕ b, and (d) ϕ r + ϕ b. The red line and the blue line correspond to the one-eq scheme when the red and blue fluid is solved for, respectively. The black dashed line corresponds to the two-eq scheme.

Close modal
FIG. 5.

Temporal evolution of the minimum of (a) ϕ, (b) ϕ r, (c) ϕ b, and (d) ϕ r + ϕ b. The red line and the blue line correspond to the one-eq scheme when the red and blue fluid is solved for, respectively. The black dashed line corresponds to the two-eq scheme.

FIG. 5.

Temporal evolution of the minimum of (a) ϕ, (b) ϕ r, (c) ϕ b, and (d) ϕ r + ϕ b. The red line and the blue line correspond to the one-eq scheme when the red and blue fluid is solved for, respectively. The black dashed line corresponds to the two-eq scheme.

Close modal

The computational cost of the two schemes for this benchmark is tabulated in Table I. All simulations in this paper are carried out on a PC with Intel® Core™ i7–6700 HQ 2.60 GHz CPU and 16 GB RAM. As can be seen in the table, for this benchmark the one-eq scheme is only 11% faster than the two-eq scheme. Also, the one-eq scheme consumes 25% less computational memory compared to its two-eq counterpart for data storage. Note that the computational time and memory for solving the hydrodynamic equation are included in the comparisons above. By taking the summation relation into account, one interface-capturing equation is not solved, and we expect that by increasing the number of fluids (N), these differences in computational time and memory will vanish as the ratio ( N 1 ) / N approaches unity.

TABLE I.

Computational costs for the RTI benchmark.

Simulation time (s) Memory (MB)
One-eq scheme  178 298  161 
Two-eq scheme  198 365  202 
Increase (%)  11  25 
Simulation time (s) Memory (MB)
One-eq scheme  178 298  161 
Two-eq scheme  198 365  202 
Increase (%)  11  25 
The LBM in this study is developed for incompressible applications although it is considered to be a semi-compressible method.30 Therefore, the velocity field is not perfectly divergence-free. As such, one should pay attention to the convection term in the phase-capturing equations. When solving two equations, we can expect the same divergence in each phase, and it looks like each equation is responsible for tackling its error and reaching its equilibrium. However, by using one equation, a non-symmetry in the results happens as the convective term is not the same for the two fluids. As such, it matters which fluid is solved since the domain is not symmetric from a fluid-occupying point of view. For instance, by considering the summation relation (3) and the one-eq scheme (assume we solve the red fluid), the other fluid (the blue fluid) equation would be
ϕ b t + · ( ϕ b u ) · u = · [ D ( ϕ b 4 ξ ϕ b ( 1 ϕ b ) n ) ] ,
(10)
which includes the additional term · u compared to the red fluid equation, and this unwanted term causes the differences and early asymmetry when we change the fluid of choice in the one-eq scheme (compare the solid red line with the solid blue line in Fig. 1).

In realistic multiphase flow numerical simulations (like the one in Fig. 2), the velocity field is complicated with all possible stretching, shearing, fluid merging, and breakup, and the additional term in Eq. (10) might be problematic. As such, it is necessary to make sure that the one-eq scheme can still give us reliable results when the flow field is complicated. We will investigate this in the following four benchmarks. The velocity is prescribed and it is reversed in the middle of the simulation. Also, the interfaces do not cross the domain boundaries during the whole simulation. As such, based on the following statement, we expect that the initial interfaces match the final interfaces.

By considering a phase-field equation as the interface-capturing equation, the continuity equation actually solves the following equation (assume we solve the one-eq scheme for the red fluid):31,32
ρ t + · ( ρ u ) = d ρ d ϕ [ ϕ r t + · ( ϕ r u ) ] ± m ̇ = d ρ d ϕ · [ D ( ϕ r 4 ξ ϕ r ( 1 ϕ r ) n ) ] ± m ̇ ,
(11)
where d ρ d ϕ is obtained via Eq. (7) and ± m ̇ is a source/sink term per volume in the continuity equation which is included for the sake of completeness (in this study, it is modeled based on singularities in the velocity fields). For fluid flows with matched density and without source/sink terms, the above equation reduces to
ρ t + · ( ρ u ) = 0 ,
(12)
where mass conserves both locally and globally. However, with the general form of Eq. (11), the mass is globally conserved if appropriate boundary conditions are applied. Let Ω be the boundary of the domain Ω with the outward unit vector n Ω. By integrating Eq. (11) and employing the divergence theorem, we obtain
Ω ρ t d V + Ω ρ u · n Ω d S = d ρ d ϕ Ω D ( ϕ r 4 ξ ϕ r ( 1 ϕ r ) n ) · n Ω d S ± Ω m ̇ d V .
(13)
For a periodic flow field, and when the interface does not intersect the boundaries, the second term on the left-hand side is zero at the end of a period. If the interface does not cross the boundary, then the first term on the right-hand side is zero. Also, if a reverse phenomenon is considered in which the flow is reversed and the source term becomes sink or vice versa, then the second term on the right-hand side becomes zero when integrating over the full period. It should be noted that the same remarks can be made for the blue fluid and the two-eq scheme. However, they are not presented here for the sake of briefness.

The difference between Eqs. (11) and (12) results in an additional term in the recovered hydrodynamic equations as pointed out by Li et al.32 In our case, the right-hand side of Eq. (11) is the additional term. They proposed a compensating term to remove this unwanted term. However, it is not clear how to evaluate the term since it contains both the order parameters and the velocity field, and it seems that a prediction-correction procedure is needed when computing the velocity. We implemented the additional term in our code and simulated the RTI, and the results were almost the same as the ones in Fig. 2. As such, we do not attribute the asymmetry and the differences between the one-eq and two-eq schemes of the results to this additional term.

Considering the statements mentioned above, in this study, we consider four benchmark tests in which we expect that the mass of the domain remains constant and the interfaces return to their initial positions at the end of the simulation period. In the first test, which is devised for the first time (Benchmark I), the velocity field is not divergence-free, i.e., · u 0 (with the same order of magnitude as observed in Fig. 2). In the second test (Benchmark II), the velocity field is set to be divergence-free, with the added complexity of source and sink terms (in this study, they appear in terms of singularity in the velocity field). In the third test (Benchmark III), the velocity field is divergence-free and there is no source/sink term. Finally, in the fourth benchmark (Benchmark IV), the velocity field is zero. We consider two initial conditions for these four benchmarks: Either the initial interface is filled with the red fluid or blue fluid. For the one-eq scheme, we only solve the interface-capturing equation for the red fluid, and the order parameter of the blue fluid is obtained via ϕ b = 1 ϕ r. It should be noted that solving for the red fluid and swapping the fluids inside and outside the interface, it is analogous to solving for both the red and blue fluid when keeping the fluid inside the interface red. For the two-eq scheme, we compute the order parameters of both fluids by solving two interface-capturing equations. All the benchmarks are tabulated in Table II.

TABLE II.

Different benchmarks.

Benchmark Domain conditions
· u 0 
II  · u = 0 with singularity 
III  · u = 0 without singularity 
IV  u = 0 
Benchmark Domain conditions
· u 0 
II  · u = 0 with singularity 
III  · u = 0 without singularity 
IV  u = 0 
In this benchmark, which we devise to evaluate the performance of interface-capturing or interface-tracking equations in numerical flow fields, the velocity field is not divergence-free and there is no source/sink term. We place a circular interface with radius of R 0 = 20 at the corner ( x c , y c ) = ( 30 , 30 ) of a square domain of size L 0 × L 0 ( L 0 = 100). The velocity is prescribed as follows:
u x ( x , y ) = U 0 x / L 0 , u y ( x , y ) = U 0 y / L 0 ,
(14)
with U 0 = 0.001 ( | · u | max = 2 × 10 5), Ch = 3 / 100, and Pe = 100. All four sides are treated as zero-gradient boundaries. The reference time is defined as t 0 = L 0 / ( 2 U 0 ). The velocity field is reversed at t * = t / t 0 = 1, and the simulation continues until t * = 2. Figure 6 shows the results of the two schemes for t * = 1 (solid line) and t * = 2 (dashed line).
FIG. 6.

Temporal evolution of the order parameter. Results of the one-eq scheme when the interface is filled with (a) the red fluid, (b) the blue fluid, and two-eq scheme when the interface is filled with (c) the red fluid, (d) the blue fluid. The initial condition is shown by the black dashed lines, results at t * = 1 are shown by the black solid lines, and the results of t * = 2 are shown by colored lines.

FIG. 6.

Temporal evolution of the order parameter. Results of the one-eq scheme when the interface is filled with (a) the red fluid, (b) the blue fluid, and two-eq scheme when the interface is filled with (c) the red fluid, (d) the blue fluid. The initial condition is shown by the black dashed lines, results at t * = 1 are shown by the black solid lines, and the results of t * = 2 are shown by colored lines.

Close modal

As can be seen, the one-eq scheme results in severe discrepancies between the initial interface and the final interface. These discrepancies also depend on which fluid fills the interface. In the figure, the red (blue) line represents the interface at the final time when the red (blue) fluid initially filled the inside of the dashed circle. However, for the two-eq scheme, the initial and final interface match, and changing the filling fluid from the red to the blue does not change the results.

In this benchmark, the divergence of the velocity field is zero everywhere; however, there is a singularity at the center of the domain which acts like a source/sink term. From t = 0 to t * = 1, the mass term acts as a source term, while from t * = 1 to t * = 2, it acts as a sink. The prescribed velocity field in the polar coordinate system is given by
u r ( r , θ ) = U 0 / 2 r , u θ ( r , θ ) = 0 ,
(15)
where r is the distance from the reference point (which is the center of the domain) and θ is the angle from the reference direction (the horizontal direction). Other properties are the same as before. Figure 7 shows the interface profile for the one-eq and two-eq schemes.
FIG. 7.

Temporal evolution of the order parameter at t * = 1 (upper frames) and t * = 2 (bottom frames). Results of the one-eq scheme when the interface is filled with [(a) and (e)] the red fluid, [(b) and (f)] the blue fluid, and two-eq scheme when the interface is filled with [(c) and (g)] the red fluid, and [(d) and (h)] the blue fluid. The black dashed lines indicate ϕ = 0.5 at the initial time.

FIG. 7.

Temporal evolution of the order parameter at t * = 1 (upper frames) and t * = 2 (bottom frames). Results of the one-eq scheme when the interface is filled with [(a) and (e)] the red fluid, [(b) and (f)] the blue fluid, and two-eq scheme when the interface is filled with [(c) and (g)] the red fluid, and [(d) and (h)] the blue fluid. The black dashed lines indicate ϕ = 0.5 at the initial time.

Close modal

As can be seen in Fig. 7, in the case of singularity in the velocity field, the one-eq scheme leads to the wrong result with dependency on the chosen fluid. On the other hand, the two-eq scheme results in accurate results which are independent of the chosen fluid.

In this benchmark, the velocity field is divergence-free, and no source/sink term exists. A circular of radius R 0 = L 0 / 5 is placed at ( x c , y c ) = ( L 0 / 2 , 3 L 0 / 4 ) in a square domain of length size L 0 = 200. The velocity field is prescribed as follows:
u x ( x , y ) = U 0 sin 2 ( π x L 0 ) sin ( 2 π y L 0 ) cos ( π t t 0 ) , u y ( x , y ) = U 0 sin 2 ( π y L 0 ) sin ( 2 π x L 0 ) cos ( π t t 0 ) ,
(16)
where t 0 = 6 L 0 / U 0 , U 0 = 0.01 , Pe = 2000, and Ch = 3 / 200. This velocity field causes large topological changes to the interface. Periodic boundary conditions are applied on all sides. Figure 8 shows the interface shape at different times.
FIG. 8.

Temporal evolution of the order parameter for U 0 = 0.01 and Pe = 2000. Results for the one-eq scheme when the circle is filled with (a) the red fluid and (b) the blue fluid, and for the two-eq scheme when the circle is filled with (c) the red fluid and (d) the blue fluid. The initial condition is shown by the black dashed lines, results at t * = 0.5 are shown by the black solid lines, and the results at t * = 1 are shown by colored lines.

FIG. 8.

Temporal evolution of the order parameter for U 0 = 0.01 and Pe = 2000. Results for the one-eq scheme when the circle is filled with (a) the red fluid and (b) the blue fluid, and for the two-eq scheme when the circle is filled with (c) the red fluid and (d) the blue fluid. The initial condition is shown by the black dashed lines, results at t * = 0.5 are shown by the black solid lines, and the results at t * = 1 are shown by colored lines.

Close modal

As can be seen in Fig. 8, when the velocity field is divergence-free and there is no source/sink term, the one-eq and two-eq schemes result in almost indistinguishable results.

To further investigate the differences, we set Pe = 500 and U 0 = 0.08. Results for the new set of variables are shown in Fig. 9. Here, we utilize contours instead of lines to show the differences.

FIG. 9.

Temporal evolution of the order parameter for U 0 = 0.08 and Pe = 500. Results for the one-eq scheme when the circle is filled with (a) the red fluid and (b) the blue fluid, and for the two-eq scheme when the circle is filled with (c) the red fluid and (d) the blue fluid. The initial condition is shown by the black dashed lines, results at t * = 0.5 are shown by the black solid lines, and the results at t * = 1 are shown by contours of ϕ.

FIG. 9.

Temporal evolution of the order parameter for U 0 = 0.08 and Pe = 500. Results for the one-eq scheme when the circle is filled with (a) the red fluid and (b) the blue fluid, and for the two-eq scheme when the circle is filled with (c) the red fluid and (d) the blue fluid. The initial condition is shown by the black dashed lines, results at t * = 0.5 are shown by the black solid lines, and the results at t * = 1 are shown by contours of ϕ.

Close modal

As can be seen in Fig. 9, even for a divergence-free and without singularity velocity field, one-eq scheme results in an unphysical appearance of one fluid in the bulk region of the other fluid [Fig. 9(b)].

In the final benchmark, the velocity field is zero throughout the simulation. As such, Eqs. (4) reduce to diffusion equations. A square domain of the length size L 0 = 100 is considered and a circle of radius R 0 = 20 is placed at the center of it. Other properties are the same as Fig. 6. Figure 10 shows the interface for the two schemes. As can be seen, there is no apparent difference between the one-eq and the two-eq schemes when the filling fluid is changed.

FIG. 10.

Order parameter ϕ = 0.5 at t = 1 × 10 5. Results for the one-eq scheme when the circle is filled with (a) the red fluid and (b) the blue fluid, and for the two-eq scheme when the circle is filled with (c) the red fluid and (d) the blue fluid. The initial condition is shown by the black dashed lines and the results at the final time are shown by colored lines.

FIG. 10.

Order parameter ϕ = 0.5 at t = 1 × 10 5. Results for the one-eq scheme when the circle is filled with (a) the red fluid and (b) the blue fluid, and for the two-eq scheme when the circle is filled with (c) the red fluid and (d) the blue fluid. The initial condition is shown by the black dashed lines and the results at the final time are shown by colored lines.

Close modal

Figures 11(a) and 11(b) plot the time history of the maximum and minimum values of ϕ, respectively, and Fig. 11(c) plots the summation of ϕ r + ϕ b for the two schemes when the interface is filled with the red fluid. It should be noted that similar results are obtained when the interface is filled with the blue fluid. As can be seen, both schemes produce the same results when the velocity is zero, and the convection-diffusion-like Eqs. (4) reduce to diffusion-like equations.

FIG. 11.

Deviation of (a) the maximum and (b) the minimum of ϕ, and (c) the summation ϕ r + ϕ b from their theoretical values. The red fluid fills the inside of the interface while the blue fluid fills the surrounding.

FIG. 11.

Deviation of (a) the maximum and (b) the minimum of ϕ, and (c) the summation ϕ r + ϕ b from their theoretical values. The red fluid fills the inside of the interface while the blue fluid fills the surrounding.

Close modal
For the two-eq scheme, if the summation of the two order parameter is initially set to unity, i.e., ϕ r ( x , 0 ) + ϕ b ( x , 0 ) = 1, then the summation of Eqs. (4) reduces to
( ϕ r + ϕ b ) t = · [ D ( ϕ r + ϕ b ) ] .
(17)
As such, throughout the simulation, we always have ϕ r ( x , t ) + ϕ b ( x , t ) = 1 and the two-eq scheme almost resembles the one-eq scheme which is in line with the finding of this benchmark.

A commonly used relation in the context of the phase-field modeling, i.e., the summation of the order parameter is equal to unity, is evaluated in numerical settings. Two different schemes are considered: in the one-equation scheme, one interface-capturing equation is solved and the order parameter of the other fluid is obtained via the summation relation. While in the two-eq scheme, two interface-capturing equations are solved for determining the order parameters of the two fluids. These two schemes were investigated in terms of accuracy and computational costs using the LBM as the numerical solvers. It was shown that using the one-eq scheme produces asymmetrical results for a symmetrical flow, and also the results depend on the fluid of choice. To further investigate the differences, we prescribed the velocity field in a way that mimics different difficulties of a real velocity field, i.e., not divergence-free velocity fields and velocity fields with singularities. Results showed that when the velocity field is not divergence-free or it has singularities, the one-eq scheme leads to inaccurate and fluid-dependent results. The problem is alleviated to some extent when the velocity field is totally divergence-free and there are not any singularities. We observe that the one-eq and two-eq schemes give the same results only if the velocity is zero. Although this paper is based on one specific interface-capturing equation, it is believed that based on the partial differential equation (PDE) of Eq. (10), we would get the same qualitative results for other methods of solving this PDE such as finite-difference or finite-volume methods and also with other phase-field equations such as the CH equation.

The authors have no conflicts to disclose.

Reza Haghani: Conceptualization (lead); Investigation (lead); Methodology (lead); Validation (lead); Visualization (lead); Writing – original draft (lead). Hamidreza Erfani: Conceptualization (supporting); Writing – review & editing (supporting). James E. McClure: Conceptualization (supporting); Writing – review & editing (supporting). Carl Fredrik Berg: Conceptualization (supporting); Supervision (lead); Writing – review & editing (equal).

The data that support the findings of this study are available from the corresponding author upon reasonable request.

In this Appendix, the gravity-driven flow of a stratified mixture of fluids is simulated to assess the accuracy of the two schemes and the hydrodynamic equation. In most studies, the interface is prescribed and the benchmark is employed to assess the hydrodynamic equations.17,33 In this study, we employ this benchmark to assess the interface-capturing equations together with the hydrodynamic equations. A 2D channel with periodic boundary conditions in the y-direction and wall boundary conditions in the x-direction is considered. The width of the channel is L0 and the red fluid is filling the channel from the left wall to L 0 / 2 while the blue fluid is filling the channel from L 0 / 2 to L0. A gravity force in the y-direction is imposed on the mixture which results in a velocity in the y-direction. In the absence of the surface tension force, the Navier–Stokes (NS) equation simplifies to
d d x ( η d u y d x ) + ρ g = 0 .
(A1)
The above equation is solved with a second-order finite-difference (FD) method and is considered the analytical solution of the hydrodynamic equation. Also, the interface profile is initially defined as
ϕ = 1 2 1 2 tanh ( 2 ( x L 0 / 2 ) ξ ) ,
(A2)
which is considered the analytical profile. First, to avoid the effect of the different relaxation time interpolations,17 we considered density- and viscosity-matched mixtures, i.e., ρ * = 1 and η * = 1. Figure 12 shows the results for L 0 = 100, ξ = 4, and g = 1 × 10 6. As can be seen, there is almost no difference between the two schemes with the initial interface profile. Also in Fig. 12(a), the results of solving only the hydrodynamic equation are also included (circle symbol) for comparison in which the interface profile is prescribed as the initial condition (A2).
FIG. 12.

(a) Normalized velocity profile with the maximum of the analytical solution (A1) and (b) order parameter profile across the channel for ρ * = 1 and η * = 1. The analytical solution (A2) is shown by the solid black line. Also, the result of solving the hydrodynamic equation with the initial profile prescribed is also included (circle symbol).

FIG. 12.

(a) Normalized velocity profile with the maximum of the analytical solution (A1) and (b) order parameter profile across the channel for ρ * = 1 and η * = 1. The analytical solution (A2) is shown by the solid black line. Also, the result of solving the hydrodynamic equation with the initial profile prescribed is also included (circle symbol).

Close modal

In Fig. 13, the results of a case with ρ * = 1000 and η * = 100 are shown with no distinguishable differences. As can be seen, the two schemes are producing almost the same results in this benchmark for different density and viscosity ratios.

FIG. 13.

(a) Normalized velocity profile with the maximum of the analytical solution (A1) and (b) order parameter profile across the channel for ρ * = 1000 and η * = 100. The analytical solution (A2) is shown by the solid black line. Also, the result of solving the hydrodynamic equation with the initial profile prescribed is also included (circle symbol).

FIG. 13.

(a) Normalized velocity profile with the maximum of the analytical solution (A1) and (b) order parameter profile across the channel for ρ * = 1000 and η * = 100. The analytical solution (A2) is shown by the solid black line. Also, the result of solving the hydrodynamic equation with the initial profile prescribed is also included (circle symbol).

Close modal
1.
R.
Clift
,
J. R.
Grace
, and
M. E.
Weber
,
Bubbles, Drops, and Particles
(
Courier Corporation
,
Chelmsford, MA
,
2005
).
2.
Y.
Sui
,
H.
Ding
, and
P. D.
Spelt
, “
Numerical simulations of flows with moving contact lines
,”
Annu. Rev. Fluid Mech.
46
,
97
119
(
2014
).
3.
C.
Pan
,
L.-S.
Luo
, and
C. T.
Miller
, “
An evaluation of lattice Boltzmann schemes for porous medium flow simulation
,”
Comput. Fluids
35
,
898
909
(
2006
).
4.
J. W.
Cahn
and
J. E.
Hilliard
, “
Free energy of a nonuniform system—I: Interfacial free energy
,”
J. Chem. Phys.
28
,
258
267
(
1958
).
5.
S. M.
Allen
and
J. W.
Cahn
, “
Mechanisms of phase transformations within the miscibility gap of Fe-rich Fe-Al alloys
,”
Acta Metall.
24
,
425
437
(
1976
).
6.
C. W.
Hirt
and
B. D.
Nichols
, “
Volume of fluid (VOF) method for the dynamics of free boundaries
,”
J. Comput. Phys.
39
,
201
225
(
1981
).
7.
S.
Osher
and
J. A.
Sethian
, “
Fronts propagating with curvature-dependent speed: Algorithms based on Hamilton-Jacobi formulations
,”
J. Comput. Phys.
79
,
12
49
(
1988
).
8.
J. A.
Sethian
,
Level Set Methods and Fast Marching Methods: Evolving Interfaces in Computational Geometry, Fluid Mechanics, Computer Vision, and Materials Science
(
Cambridge University Press
,
1999
), Vol.
3
.
9.
H.
Wang
,
X.
Yuan
,
H.
Liang
,
Z.
Chai
, and
B.
Shi
, “
A brief review of the phase-field-based lattice Boltzmann method for multiphase flows
,”
Capillarity
2
,
33
52
(
2019
).
10.
R.
Haghani-Hassan-Abadi
,
M.-H.
Rahimian
, and
A.
Fakhari
, “
Conservative phase-field lattice-Boltzmann model for ternary fluids
,”
J. Comput. Phys.
374
,
668
691
(
2018
).
11.
F.
Boyer
and
C.
Lapuerta
, “
Study of a three component Cahn-Hilliard flow model
,”
ESAIM: Math. Modell. Numer. Anal.
40
,
653
687
(
2006
).
12.
R.
Haghani-Hassan-Abadi
,
A.
Fakhari
, and
M.-H.
Rahimian
, “
Phase-change modeling based on a novel conservative phase-field method
,”
J. Comput. Phys.
432
,
110111
(
2021
).
13.
H.
Safari
,
M. H.
Rahimian
, and
M.
Krafczyk
, “
Extended lattice Boltzmann method for numerical simulation of thermal phase change in two-phase fluid flow
,”
Phys. Rev. E
88
,
013304
(
2013
).
14.
L.
Li
,
J.
Lu
,
H.
Fang
,
Z.
Yin
,
T.
Wang
,
R.
Wang
,
X.
Fan
,
L.
Zhao
,
D.
Tan
, and
Y.
Wan
, “
Lattice Boltzmann method for fluid-thermal systems: Status, hotspots, trends and outlook
,”
IEEE Access
8
,
27649
27675
(
2020
).
15.
K.
Petersen
and
J.
Brinkerhoff
, “
On the lattice Boltzmann method and its application to turbulent, multiphase flows of various fluids including cryogens: A review
,”
Phys. Fluids
33
,
041302
(
2021
).
16.
R.
Haghani
,
H.
Erfani
,
J.
McClure
, and
C. F.
Berg
, “
Color gradient lattice Boltzmann method for fluid flow with high density and viscosity ratios
,” (unpublished) (
2023
).
17.
A.
Fakhari
,
T.
Mitchell
,
C.
Leonardi
, and
D.
Bolster
, “
Improved locality of the phase-field lattice-Boltzmann model for immiscible fluids at high density ratios
,”
Phys. Rev. E
96
,
053301
(
2017
).
18.
T.
Lee
, “
Effects of incompressibility on the elimination of parasitic currents in the lattice Boltzmann equation method for binary fluids
,”
Comput. Math. Appl.
58
,
987
994
(
2009
).
19.
L.
Zheng
,
B.
Shi
, and
Z.
Guo
, “
Multiple-relaxation-time model for the correct thermohydrodynamic equations
,”
Phys. Rev. E
78
,
026705
(
2008
).
20.
T.
Lee
and
C.-L.
Lin
, “
A stable discretization of the lattice Boltzmann equation for simulation of incompressible two-phase flows at high density ratio
,”
J. Comput. Phys.
206
,
16
47
(
2005
).
21.
F.
Ren
,
B.
Song
,
M. C.
Sukop
, and
H.
Hu
, “
Improved lattice Boltzmann modeling of binary flow based on the conservative Allen-Cahn equation
,”
Phys. Rev. E
94
,
023311
(
2016
).
22.
Y.
Hu
,
D.
Li
,
L.
Jin
,
X.
Niu
, and
S.
Shu
, “
Hybrid Allen-Cahn-based lattice Boltzmann model for incompressible two-phase flows: The reduction of numerical dispersion
,”
Phys. Rev. E
99
,
023302
(
2019
).
23.
J.
Kim
, “
A continuous surface tension force formulation for diffuse-interface models
,”
J. Comput. Phys.
204
,
784
804
(
2005
).
24.
P.-H.
Chiu
and
Y.-T.
Lin
, “
A conservative phase field method for solving incompressible two-phase flows
,”
J. Comput. Phys.
230
,
185
204
(
2011
).
25.
M.
Geier
,
A.
Fakhari
, and
T.
Lee
, “
Conservative phase-field lattice Boltzmann model for interface tracking equation
,”
Phys. Rev. E
91
,
063309
(
2015
).
26.
Y. Q.
Zu
and
S.
He
, “
Phase-field-based lattice Boltzmann model for incompressible binary fluid systems with density and viscosity contrasts
,”
Phys. Rev. E
87
,
043301
(
2013
).
27.
H.
Erfani
,
M.
Babaei
,
C. F.
Berg
, and
V.
Niasar
, “
Scaling CO2 convection in confined aquifers: Effects of dispersion, permeability anisotropy and geochemistry
,”
Adv. Water Resour.
164
,
104191
(
2022
).
28.
N.
Fleischmann
,
S.
Adami
, and
N. A.
Adams
, “
Numerical symmetry-preserving techniques for low-dissipation shock-capturing schemes
,”
Comput. Fluids
189
,
94
107
(
2019
).
29.
T.
Lee
and
L.
Liu
, “
Lattice Boltzmann simulations of micron-scale drop impact on dry surfaces
,”
J. Comput. Phys.
229
,
8045
8063
(
2010
).
30.
T.
Krüger
,
H.
Kusumaatmaja
,
A.
Kuzmin
,
O.
Shardt
,
G.
Silva
, and
E. M.
Viggen
,
The Lattice Boltzmann Method
(
Springer International Publishing
,
2017
), Vol.
10
, pp.
4
15
.
31.
H.
Ding
,
P. D.
Spelt
, and
C.
Shu
, “
Diffuse interface model for incompressible two-phase flows with large density ratios
,”
J. Comput. Phys.
226
,
2078
2095
(
2007
).
32.
Q.
Li
,
K. H.
Luo
,
Y. J.
Gao
, and
Y. L.
He
, “
Additional interfacial force in lattice Boltzmann models for incompressible multiphase flows
,”
Phys. Rev. E
85
,
026704
(
2012
).
33.
A.
Subhedar
, “
Color-gradient lattice Boltzmann model for immiscible fluids with density contrast
,”
Phys. Rev. E
106
,
045308
(
2022
).