Skip to main content
Springer logoLink to Springer
. 2019 Feb 25;64(4):937–949. doi: 10.1007/s00466-019-01688-1

A multilevel Monte Carlo finite element method for the stochastic Cahn–Hilliard–Cook equation

Amirreza Khodadadian 1,2,, Maryam Parvizi 2, Mostafa Abbaszadeh 3, Mehdi Dehghan 3, Clemens Heitzinger 2,4
PMCID: PMC6936653  PMID: 31929667

Abstract

In this paper, we employ the multilevel Monte Carlo finite element method to solve the stochastic Cahn–Hilliard–Cook equation. The Ciarlet–Raviart mixed finite element method is applied to solve the fourth-order equation. In order to estimate the mild solution, we use finite elements for space discretization and the semi-implicit Euler–Maruyama method in time. For the stochastic scheme, we use the multilevel method to decrease the computational cost (compared to the Monte Carlo method). We implement the method to solve three specific numerical examples (both two- and three dimensional) and study the effect of different noise measures.

Keywords: Multilevel Monte Carlo, Finite element, Cahn–Hilliard–Cook equation, Euler–Maruyama method, Time discretization

Introduction

The Cahn–Hilliard equation is a robust mathematical model for describing different phase separation phenomena, from co-polymer systems to lipid membranes. The equation is used to model binary metal alloys [1], polymers [2] as well as cell proliferation and adhesion [3]. In material science, when a binary alloy is sufficiently cooled down, we observe a partial nucleation or spinodal decomposition, i.e., the material quickly becomes inhomogeneous. In fact, after a few seconds, material coarsening will be happened [4]. In polymer solutions and blends, the phase separation process is a dynamic process that one phase stable solution separates into two equilibrium phases upon changes in temperature, pressure, concentration, or even flow fields [5]. In these cases, the spinodal decomposition is described by the Cahn–Hilliard model [6].

The equation is a nonlinear partial differential equation of fourth-order in space and first order in time for which an analytical treatment is not possible. There are several numerical techniques to solve the equation including the finite element method (FEM) [7], isogeometric analysis based on finite element method [8], multigrid finite element [9], conservative nonlinear multigrid method [10], least squares spectral element method [11], Monte Carlo methods [12], radial basis functions (RBF) [13] and meshless local collocation methods [14]. A finite element error analysis of the equation is given in [15]. Adaptive finite elements can also be applied to solve the equation using residuals based a posteriori estimates [16, 17].

A difficulty of the numerical analysis of the Cahn–Hilliard equation is the discretization of the fourth-order operator. Here, after converting the fourth-order equation into a system of two second-order equations (by introducing an auxiliary variable) and writing the variational formulation, the Ciarlet–Raviart mixed finite element method is used for the spatial discretization. The method has been implemented for the damped Boussinesq equation by the authors [18] and they considered the convergence rate and the stability for the semi-discretization scheme and the fully discretized method. For the Cahn–Hilliard equation, the technique was used in [19, 20] for the space discretization.

The stochastic Cahn–Hilliard equation was first considered by Cook [21]. The system allows for considering thermal fluctuations directly in terms of the Cahn–Hilliard–Cook (CHC) equation by a conserved noise source term. The thermal fluctuations play an essential role in the early stage of phase dynamics such as initial dynamics of nucleation [22, 23]. Some authors, such as Binder [24] and Pego [25], have expressed the belief that only the stochastic version can correctly describe the whole decomposition process in a binary alloy [26]. In [27], as another numerical approach, the authors employed the direct meshless local Petrov–Galerkin (DMLPG) to solve the stochastic Cahn-Hilliard-Cook and stochastic Swift-Hohenberg equations.

Multilevel Monte Carlo (MLMC) [28] is a simple and efficient computational technique to estimate the expected value of a random process. Using the method enables us to decrease the computational costs noticeably. The multilevel method was implemented to solve the stochastic elliptic equations, e.g., the drift-diffusion-Poisson system with uniformly distributed random variables [29] and quasi-random points [30]. In [31], the convergence and complexity of the MLMC using Galerkin discretizations in space and a Euler–Maruyama discretization in time for the parabolic equations were explained in details. The technique was used in [32] for solving parabolic (heat equation) and hyperbolic (advection equation) driven by additive Wiener noise

Generally, for the time-dependent stochastic problems, the total error consists of the spatial error (due to the finite element method), the time discretization error (due to the Euler–Maruyama technique) and the statistical error (number of samples). We already know that for the space discretization, fine meshes are needed (specifically for the curved surfaces) which lead to the higher computational complexity. The multilevel Monte Carlo method uses hierarchies of meshes for time and space approximations in the sense that the number of samples and mesh sizes (as well as time steps) on the different levels are chosen such that the errors are equilibrated. For the stochastic Cahn–Hilliard–Cook equation, we strive to determine an optimal hierarchy of meshes, number of samples and time intervals which minimize the total computational work. As a result, we give a-priori estimates on the explained error contributions. In this paper, we use the MLMC-FEM for the fourth-order stochastic equations and calculate the mild solution of the Cahn–Hilliard–Cook equation. In fact, we estimate the total computational error according to the three error contributions. Then, we strive to minimize the computational complexity with respect to a given error tolerance. This procedure is compared to the Monte Carlo method.

The rest of the paper is organized as follows. In Sect. 2, we explain the Cahn–Hilliard and the Cahn–Hilliard–Cook equations with their boundary conditions. Then, we describe how the Ciarlet–Raviart mixed finite element can be used to convert the stochastic equation to a system of second-order equations. In Sect. 3, we demonstrate the implementation of the MLMC-FEM for the time-dependent stochastic equations. In Sect. 4, we give three numerical examples according to two different initial conditions. The solutions of the stochastic equation (the concentration) and the optimization (the optimal hierarchies) are given in this section. Finally, the conclusions are drawn in Sect. 5.

Cahn–Hilliard–Cook equation

J. W. Cahn and J. E. Hilliard proposed the Cahn–Hilliard (CH) equation. The equation is a mathematical physics model that describes the process of phase separation. The CH equation is as follows

dudt=MΔ(F(u)-ϵ2Δu)inΩ×[0,T], 1

with the Neumann boundary conditions

uν=0,-ϵ2Δu+F(u)ν=0onΩ×[0,T]. 2

We consider the initial condition at t=0 as

u(x,0)=u0(x)forxΩ, 3

where ν denotes the unit outward normal of the boundary and Ω is a bounded domain in Rd(d=1,2,3). The solution u is a rescaled density of atoms or concentration of one of the material components where, in the most applications u[-1,1]. We should note that M is the mobility (here a constant) and the variable ϵ is a positive constant. The equation arises from the Ginzburg–Landau free energy

L(u)=ΩF(u)+ϵ22|u|2dx. 4

The above free energy includes the bulk energy F(u) and the interfacial energy (the second term). A popular example of a nonlinear function is

F(u)=14u2(1-u)2. 5

The Cahn–Hilliard–Cook equation presents a more realistic model including the internal thermal fluctuations. It can be derived from (1) by adding the thermal noise as

dudt=MΔ(F(u)-ϵ2Δu)+σξinΩ×[0,T], 6a
uν=0,Δuν=0onΩ×[0,T], 6b

where ξ indicates the colored noise (here white noise) and σ is the noise intensify measure.

Ciarlet–Raviart mixed finite element

To construct a mixed finite element approximation of the Cahn–Hilliard–Cook equation, we first find its weak formulation. For this purpose, we define the auxiliary variable

γ:=-MΔu+F(u). 7

Therefore, the Cahn–Hilliard–Cook equation can be rewritten in the form

γ=-MΔu+F(u), 8a
du=·(Mγ)+σdW, 8b
uν=γν=0. 8c

The weak formulation of (8) is given by seeking (u,γ)H1(Ω)×H1(Ω) such that

(γ,χ)Ω=Mu,χΩ+F(u),χΩχH1(Ω), 9a
du,ψΩ=-Mγ,ψΩ+σdW,ψΩψH1(Ω), 9b

where

H1(Ω)=uH1(Ω)|Ωudx=0. 10

Now let τh be a family of triangulations of Ω into a finite number of elements (simplex) such that

h=maxkτhdiam(k). 11

We assume that each element has at least one face on Ω and k1,k2τh have only one common vertex or a whole edge. Now we define

Mh:=vC(Ω)|v|kPn,n1kτh, 12
Nh:=MH1(Ω), 13

and Pn is the space of all polynomials of degree at most n1. The semi-discrete Galerkin approximation of the solutions (9a)–(9b) may be defined as a pair of approximations (uh,γh)Nh×Mh for which the equalities

(γh,χh)Ω=Muh,χhΩ+F(uh),χhΩχhMh, 14a
(duh,ψh)Ω=-Mγh,ψhΩ+(dW,ψh)ΩψhNh, 14b

hold.

Full discretization scheme

In this section we apply a fully discretize scheme based the mild solution of (8). In order to obtain the fully discretized scheme, we first rewrite the variational formulation of (9) as follows:

Find (u,γ)H1(Ω)×H1(Ω) such that

(γ,χ)Ω=(Mu,χ)Ω+(F(u),χ)ΩχH1(Ω), 15a
(u(t),ψ)Ω-(u0(t),ψ)Ω=-0t(Mγ,ψ)Ω+σ(W(t),ψ)ΩψH1(Ω). 15b

The mixed finite element formulation of (15) is defined by (uh(t),γh(t))Nh×Mh such that

(γh,χh)Ω=(Muh,χh)Ω+(F(uh),χh)ΩχhMh, 16a
(uh(t),ψh)Ω-(u0(t),ψh)Ω=-0t(Mγh,ψh)Ω+σ(W(t),ψh)ΩψhNht(0,T]. 16b

Now we can rewrite (8) in the following abstract evolution equation

dX(t)+A2X+AF(X)dt=σdW(t)t(0,T], 17
X(0)=X0, 18

where A is the negative Neumann Laplacian considered as an unbounded operator in the Hilbert space H=L2(Ω), which is the generator of an analytic semigroup (S(t),t0) on H [33]. The initial value X0 is deterministic and W is a cylindrical Wiener process in H (i.e., the spatial derivative of a space–time white noise) with respect to a filtered probability space (Ψ,F,P,{Ft}t0) defined as

W(t)=j,k=1μj,k12βj,k(t)sin(jπx)sin(kπy). 19

Here, βj,kj,kN indicates a family of real-valued, identically distributed independent Brownian motions and μj,kj,kN denote the eigenvalues (here, μj,k=1 since W(t) is cylindrical) [34]. Therefore, the Cahn–Hilliard–Cook equation has a continuous mild solution

X(t)=S(t)X0+0tAS(t-s)F(X(s))ds+σ0tS(t-s)dW(s), 20

where t[0,T], X:[0,T]×ΩH and S(t)=e-tA2 used as the analytic semigroup generated by -A2. The existence of the mild solution X was shown in [35]. Considering X0L2(Ω,H)+, for all t[0,T] the solution X satisfies [31]

X(t)L2(Ω,H)C(T)1+X0L2(Ω,H), 21

where C is a constant which depends on T. Also, for 0s<tT, there exists a constant C(T) such that the mild solution satisfies the inequality [31]

X(t)-X(s)L2(Ω,H)C(T)t-s1+X0L2(Ω,H). 22

In order to estimate the mild solution we use finite elements for space discretization and the semi-implicit Euler–Maruyama scheme in time direction. Let us assume that V (N0) is a nested family of finite element subsequences of H with refinement level >0 and refinement size h(N0). Defining the analytic semigroup S=e-tA2, for tT, the semidiscrete problem (20) has the form

X(t)=e-tA2X(0)+0tAe-(t-s)A2F(X(s))ds+σ0te-(t-s)A2dW(s). 23

For the time direction, we approximate the time discretization with step sizes δtζ=Tr-ζ where r>1. Therefore, for ζN0, we define the sequence

Θζ:=tkζ=Tr-ζk=δtζk,k=0,,rζ 24

of equidistant time discretization. In the computational geometry (Ω), we estimate the mild solution X, with a finite element discretization. In other words, we suppose that the domain can be partitioned into quasi-uniform triangles or tetrahedra such that sequences {τh}=0 of regular meshes are obtained. For any 0, we denote the mesh size of τh by

h:=maxKτhdiamK.

Uniform refinement of the mesh can be achieved by regular subdivision. This results in the mesh sizes

h:=r-h0, 25

where h0 denotes the mesh size of the coarsest triangulation and r>1 is independent of .

Multilevel Monte Carlo finite element method

The Monte Carlo method is a simple and efficient computational technique to solve SPDEs. As already mentioned, we use Euler–Maruyama to solve the equation on [0, T] and the finite element method for the space discretization. In order to obtain the mean square error (MSE) of ε, we require δt=O(ε) (for the time discretization). The Monte Carlo error (statistical error) is O(1/M) (where M is the number of samples) which yields M-1=O(ε2). Using a finite element scheme also gives rise to O(ε-d/α), where α is the convergence rate of the discretization error. Therefore, by taking M samples, T/δt time steps and h as the mesh size, we have the following total cost

W=Oε-(2+1+d/α). 26

It is obvious that for high dimensional geometries (i.e., d=2,3), the computational cost increases noticeably.

Multilevel Monte Carlo finite element method (MLMC-FEM) is an efficient alternative to the Monte Carlo method to decrease the cost. In the time discretization, the general idea of the technique is using a hierarchy of the time steps, i.e., δt (N0) at different levels (instead of a fixed time step). For the space discretization, we use the mesh refinement (25) to obtain the mesh size at level which leads to

h0>h1>>hL-1>hL. 27

In this section we strive to estimate the expectation of the mild solution on level L. First, for a given Hilbert space (H,·H) the space, L2(Ω;H) is defined to be the space of all measurable functions Y:ΨH such that

YLp(Ω;H)=E[YH2]1/2. 28

For YL2(Ω;H) the standard Monte Carlo estimator EM[Y] can be defined as

EM[Y]:=1Mi=1MY^(i), 29

where for i=1,,M, Y(i) indicated a sequence of i.i.d. copies of Y. Let Y(N0) be a sequence of random variables such that YV, we can write YL as

YL=Y0+=1LY-Y-1, 30

taking expected value of the above equality leads to

E[YL]=E[Y0]+E=1L(Y-Y-1)=E[Y0]+=1LE[Y-Y-1]. 31

In order to approximate E[Y-Y-1] we can use the Monte Carlo estimator EM[Y-Y-1] (i.e., expectation of the difference of Y and Y-1) with independent number of samples M at level . Therefore, (31) can be estimated as

EL[YL]=EM0[Y0]+EM=1L(Y-Y-1), 32

In this part, we first provide the error bound for the single level Monte Carlo finite element. Then, using the obtained results, we achieve the error bound of the multilevel Monte Carlo considering the principal discretization error, i.e., spatial discretization (using finite element method), time stepping errors (due to the Euler–Maruyama technique) and statistical (sampling) error.

Lemma 1

[29] For any number of samples MN and for YL2(Ω;H), the inequality

E[Y]-EM[Y]L2(Ω;H)=M-1/2σ[Y]M-1/2YL2(Ω;H) 33

holds for the MC error, where σ[Y]:=E[Y]-YL2(Ω;H).

According to Lemma 1 for ,ζN0 and tΘζ, we have the inequality

EX,ζ(t)-EMX,ζ(t)L2(Ω;H)1MX,ζ(t)L2(Ω;H), 34

where X,ζ(t) is the discrete mild solution at level and time interval ζ. In order to estimate the discretization error which stems from the spatial discretization and time stepping we define the following lemma.

Lemma 2

[31] Let X be the solution of (20) and X,ζ be the sequence of discrete mild solution (i.e., the solution of (23)). Then, there is a constant C(T) such that for all ,ζN0, we have

suptΘζX(t)-X,ζ(t)L2(Ω;H)C(T)h+δtζ1+X0L2(Ω;H). 35

Hence, the total computational error is given by [31]

suptΘζEX(t)-EMX,ζ(t)L2(Ω;H)C(T)h+δtζ+1M1+X0L2(Ω;H). 36

In order to prove, we add and subtract the term E[X,ζ(t)] to the left side and use the triangle inequality, Lemma 1, Lemma 2 and (34) to obtain the error bound. Now we couple the space and time errors and choose δtζh2 (i.e., δtζ=O(h2) and O(δtζ)=h2). Therefore, the total work W for the given spatial discretization level N0 is estimated by

Wh-dh-2M. 37

After estimating the error bounds for single level Monte Carlo, we provide the multilevel Monte Carlo error bounds. By using ζ=2 (due to δtζh2), for N0 we consider hr- and define δt:=Tr-2. Therefore, for the full discretization in the multilevel setting, we redefine (24) as

Θ:=tk()=Tr-2k()=δtk(),k()=0,,r2, 38

and we define the multilevel Monte Carlo estimator

EL[X(tk(L)L)]:=EM0[X0(tk(L)L)]+=1LEM[X(tk(L)L)-X-1(tk(L)L)]. 39

The computational error is given by

E=suptΘLE[X(t)]-EL[XL(t)]L2(Ω;H). 40

For fixed LN and any chosen tk(L)LΘL, we split the error into two parts, i.e., discretization error and statistical error (see Theorem 4.5 in [31]), to obtain

E[X(tk(L)L)]-EL[XL(tk(L)L)]L2(Ω;H)X(tk(L)L)-XL(tk(L)L)L2(Ω;H)+1M0X0(tk(L)L)L2(Ω;H)+=1L1MX(tk(L)L)-X-1(tk(L)L)L2(Ω;H) 41

Now we make the following convergence assumptions for the prescribed errors. The below assumption is used to estimate the convergence rate of the discretization error

X(tk(L)L)-XL(tk(L)L)L2(Ω;H)C1hLα. 42

Regarding the statistical error, the next assumptions

X0(tk(L)L)L2(Ω;H)C2, 43
X(tk(L)L)-X-1(tk(L)L)L2(Ω;H)C3h 44

are made. Hence, the total error can be estimated as

EC1hLα+C2M0+C3=1LhM. 45

The total work can be estimated by summing up the work of each level, i.e.,

W==0LW==0Lμh-dh-2M. 46

Now we define an optimization problem which minimizes the computational work (46) such that the error is less or equal than a given error tolerance (ε). In other words, for estimating the mild solution on level L, we estimate the optimal hierarchies of h,M,L=0=L such that

minimizeM,h0,rf(M,h0,r,L):==0LWsubject tog(M,h0,r,L):=C1hLα+C2M0+C3=1LhMε. 47

In the problem we have M>1,h0>0 and r>1. The exponent (α) as well as the coefficients (C1,C2,C3) must be determined analogously. Finally, we should note that for Monte Carlo method the optimization problem with respect to (26) can be written as

minimizeM,hf(M,h):=Mh-(d+1)subject tog(M,h):=C1hα+C2Mε, 48

where again the optimization problem is over M>1 and h>0.

Numerical results

In this section, we present three numerical examples of the stochastic Cahn–Hilliard–Cook equations where in all cases the optimal MLMC-FEM is used to obtain the solution. Due to the fact that the examples are real-world problems, their exact solutions are not given. The simulations are performed using MATLAB 2017b software on an Intel Core i7 machine with 32GB of memory. In all examples, ϵ=0.01 is used and the constant mobility M=0.25 is applied. For the nonlinear term (i.e., F(u)), we use Newton’s method where several iterations are needed to reach the stopping tolerance (here TOL=1×10-8). In each iteration, the built-in direct solver is employed to solve the linearized system.

A 2D example

As the first example, we take u0=0.25+0.1ω as the initial condition. The random variable ω is uniformly distributed between 0 and 1. The computational geometry (Ω) is a circle with radius r=2 and zero center point. As the first step, we try to solve the optimization problems (for MLMC-FEM and MC-FEM). This will enable us to find the optimal number of samples and mesh sizes. As explained in Sect. 2.1, we use the Ciarlet–Raviart mixed finite element with P1 elements. The estimation of the exponent α is crucial, however, it relates to the order of polynomials. Due to the fact that the exact solution of the stochastic equation is not available, we calculate the error between different mesh sizes and h=0.01 (as the reference solution) at T=5. Figure 1 depicts α with respect to different mesh sizes (here uniform refinement). The simulations show α=0.952, C1=0.51, where the exponent agrees very well with the order of P1 finite element technique (linear elements). The rest of the coefficients is estimated as C2=0.066, C3=0.223. Now we are ready to solve the optimization problem (47) with respect to the aforementioned parameters. In order to solve the optimization problem, we apply interior method where the details of the technique are given in [29]. The optimal hierarchies of the MLMC-FEM are shown in Table 1.

Fig. 1.

Fig. 1

The discretization error as a function of different mesh sizes where α=0.95 as the convergence rate is obtained

Table 1.

The optimal hierarchies of MLMC-FEM with respect to different prescribed errors

ε h0 r M0 M1 M2 M3 M4
0.100 0.764 1.458 73 50 15
0.050 0.615 1.568 280 138 31
0.020 0.461 1.726 1672 524 85
0.010 0.370 1.856 6474 1445 184
0.005 0.580 1.990 187,700 46,448 4615 459

As the next step, in order to compare the efficiency of the multilevel setting with the Monte Carlo simulation, we solve the optimization given in (48). Again, the optimal mesh size and the optimal number of samples are given in Table 2 where the same convergence rate (α) is used. Finally, we draw a comparison between MLMC-FEM and MC-FEM which is shown in Fig. 2. The results indicate that the multilevel method costs approximately O(ε-3.27) and the computational work of Monte Carlo sampling is O(ε-5.1). The comparison indicates noticeably the efficiency of the MLMC-FEM.

Table 2.

The optimal values of MC-FEM with respect to different prescribed errors

ε 0.1 0.05 0.02 0.01 0.005
h 0.108 0.052 0.020 0.010 0.005
M 3 12 73 289 1 152

Fig. 2.

Fig. 2

A comparison between the optimal work of MLMC-FEM and MC-FEM showing the efficiency of the multilevel technique is pronounced

Finally, we compare the evolution of the concentration E[u(T)] at different times (from T=0.2 to T=15) (with σ=0.1) where the obtained results are depicted in Fig. 3. It is shown that from T=0.2 to T=1, a slow coarsening happens. Here, we use ε=0.05 in the sense that the solution at the last level (here L=2) is shown in the figure (see Table 1 for the optimal mesh size and number of samples). In order to study the noise effect we solve the deterministic equation with the same mesh size as illustrated in Fig. 4.

Fig. 3.

Fig. 3

The solution of the stochastic CHC equation at T=0.1 (top left), T=0.5 (top right), T=3 (bottom left) and T=15 (bottom right)

Fig. 4.

Fig. 4

The solution of the Cahn–Hilliard equation (σ=0) at T=0.1 (top left), T=0.5 (top right), T=3 (bottom left) and T=15 (bottom right)

The 3D examples

Here we choose a more complicated example and use MLMC-FEM and CR-MFE to obtain the solution (expected value) of CHC equation in a cubic geometry, i.e., Ω=[0,2]×[0,2]×[0,2]. The initial condition is

u0(x,y,z):=0.5+0.17cos(πx)cos(2πy)cos(πz)+0.2cos(3πx)cos(πy)cos(πz), 49

where (xyz) is a point on the cube. The same procedure for solving the optimization problem can be used, however, due to the three-dimensional structure we set d=3. We should note that as ζ=2, we define the optimal time interval as δtζh2. First, we consider the effect of the noise intensify measure in the sense that the deterministic case (σ=0) is compared with the stochastic equation (σ=0.1,0.2,0.3). The results are shown in Fig. 5 at T=1. Clearly, higher σ affects the concentration mostly. Similar to the 2D example, we consider the effect of time on the concentration. The results are shown in Fig. 6 for different times from T=0.1 to T=10. It illustrates that the initial homogeneous phase quickly segregates (at T=0.1), however, after the segregation the domain starts to slowly coarsen in time.

Fig. 5.

Fig. 5

A comparison between different noise intensify measure, i.e., σ=0 (top left), σ=0.1 (top right), σ=0.2 (bottom left) and σ=0.3 (bottom right) at T=1

Fig. 6.

Fig. 6

The expected value of the solution of CHC equation at T=0.1 (top left), T=0.4 (top right), T=2 (bottom left) and T=10 (bottom right). Here, h=0.2 and σ=0.1

In the next step, we use the Monte Carlo finite element method to compare the effect of the number of grids. Here, two mesh sizes, i.e., h=0.5 (with 1373 nodes) and h=0.1 (with 66513 nodes) are employed and the results are shown in Figs. 7 and 8 for stochastic and deterministic cases, respectively. We solved the CHC equation with σ=0.15 and compared its solution with the deterministic case (σ=0) at time T=5. It shows that the mesh size does not considerably affect the solution.

Fig. 7.

Fig. 7

A comparison between two mesh sizes h=0.5 (left) and h=0.1 (right) at T=5 for the stochastic Cahn–Hilliard–Cook equation

Fig. 8.

Fig. 8

A comparison between two mesh sizes, i.e., h=0.5 (left) and h=0.1 (right) at T=5 for the deterministic Cahn–Hilliard equation

Finally, we consider the second 3D example (a torus). The first comparison is regarding the evolution of the concentration which is illustrated in Fig. 9 where in the simulations σ=0.1 is used. In the second case, we study the effect of different noise measures from deterministic case to stochastic case with σ=0.5 at T=1. Here, the results are shown in Fig. 10. The simulations point out that the effect of σ=0.4 and σ=0.5 on the concentrations are more tangible.

Fig. 9.

Fig. 9

The evolution of the solution of the times T=0.1 (top left), T=0.5 (top right), T=3 (bottom left) and T=20 (bottom right)

Fig. 10.

Fig. 10

A comparison between different noise intensify measure, i.e., σ=0 (top left), σ=0.1 (top right), σ=0.2 (middle left) and σ=0.3 (middle right), σ=0.4 (bottom left) and σ=0.5 (bottom right) at T=1

Conclusions

In this paper, we considered the Cahn–Hilliard and Cahn–Hilliard–Cook equations as forth-order time-dependent equations. As the first step, after defining an auxiliary variable, we converted the equation into a system of second-order time-dependent problems. Then, we presented a variational formulation for the system and used the Ciarlet–Raviart mixed finite element method. Afterwards, we rewrote the equation as a stochastic ODE in order to estimate its mild solution u(t).

We have already shown that for the stochastic time-dependent problems, the computational cost of the Monte Carlo finite element method is O(ε-(2+1+d/α)). Applying the multilevel technique for this problem reduces noticeably the computational costs. In a two-dimensional problem, the optimal hierarchies h,r,M,δt=0=L reduce the complexity to O(ε-3.27) as certified in numerical example.

We showed three numerical examples with two specific initial conditions. We estimated the solution of stochastic/deterministic Cahn–Hilliard equation for different time intervals. As a result, we demonstrated distinctive coarsening and phase separation. For the stochastic equation, we studied the effect of noise measure, for showing that more σ intensifies the noisy concentration.

Acknowledgements

Open access funding provided by Austrian Science Fund (FWF). The first and the last authors acknowledge support by FWF (Austrian Science Fund) START Project No. Y660 PDE Models for Nanotechnology. The second author also acknowledges support by FWF Project No. P28367-N35.

Footnotes

Publisher's Note

Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Contributor Information

Amirreza Khodadadian, Email: amirreza.khodadadian@tuwien.ac.at.

Maryam Parvizi, Email: maryam.parvizi@tuwien.ac.at.

Mostafa Abbaszadeh, Email: m.abbaszadeh@aut.ac.ir.

Mehdi Dehghan, Email: mdehghan@aut.ac.ir.

Clemens Heitzinger, Email: clemens.heitzinger@tuwien.ac.at.

References

  • 1.Cahn JW, Hilliard JE. Free energy of a nonuniform system. I. Interfacial free energy. J Chem Phys. 1958;28(2):258–267. doi: 10.1063/1.1744102. [DOI] [Google Scholar]
  • 2.Cogswell DA (2010) A phase-field study of ternary multiphase microstructures, Ph.D. thesis, Massachusetts Institute of Technology
  • 3.Khain E, Sander LM. Generalized Cahn–Hilliard equation for biological applications. Phys Rev E. 2008;77(5):051129. doi: 10.1103/PhysRevE.77.051129. [DOI] [PubMed] [Google Scholar]
  • 4.Miranville A. The Cahn–Hilliard equation and some of its variants. AIMS Math. 2017;2(3):479–544. doi: 10.3934/Math.2017.2.479. [DOI] [Google Scholar]
  • 5.Ghiass M, Moghbeli MR, Esfandian H. Numerical simulation of phase separation kinetic of polymer solutions using the spectral discrete cosine transform method. J Macromol Sci Part B. 2016;55(4):411–425. doi: 10.1080/00222348.2016.1153403. [DOI] [Google Scholar]
  • 6.Novick-Cohen A, Segel LA. Nonlinear aspects of the Cahn–Hilliard equation. Phys D Nonlinear Phenom. 1984;10(3):277–298. doi: 10.1016/0167-2789(84)90180-5. [DOI] [Google Scholar]
  • 7.Du Q, Ju L, Tian L. Finite element approximation of the Cahn–Hilliard equation on surfaces. Comput Methods Appl Mech Eng. 2011;200(29–32):2458–2470. doi: 10.1016/j.cma.2011.04.018. [DOI] [Google Scholar]
  • 8.Gómez H, Calo VM, Bazilevs Y, Hughes TJ. Isogeometric analysis of the Cahn–Hilliard phase-field model. Comput Methods Appl Mech Eng. 2008;197(49–50):4333–4352. doi: 10.1016/j.cma.2008.05.003. [DOI] [Google Scholar]
  • 9.Kay D, Welford R. A multigrid finite element solver for the Cahn–Hilliard equation. J Comput Phys. 2006;212(1):288–304. doi: 10.1016/j.jcp.2005.07.004. [DOI] [Google Scholar]
  • 10.Kim J. A numerical method for the Cahn–Hilliard equation with a variable mobility. Commun Nonlinear Sci Numer Simul. 2007;12(8):1560–1571. doi: 10.1016/j.cnsns.2006.02.010. [DOI] [Google Scholar]
  • 11.Fernandino M, Dorao C. The least squares spectral element method for the Cahn–Hilliard equation. Appl Math Model. 2011;35(2):797–806. doi: 10.1016/j.apm.2010.07.034. [DOI] [Google Scholar]
  • 12.Tafa K, Puri S, Kumar D. Kinetics of phase separation in ternary mixtures. Phys Rev E. 2001;64(5):056139. doi: 10.1103/PhysRevE.64.056139. [DOI] [PubMed] [Google Scholar]
  • 13.Dehghan M, Mohammadi V. The numerical solution of Cahn–Hilliard (CH) equation in one, two and three-dimensions via globally radial basis functions (GRBFs) and RBFs-differential quadrature (RBFs-DQ) methods. Eng Anal Bound Elements. 2015;51:74–100. doi: 10.1016/j.enganabound.2014.10.008. [DOI] [Google Scholar]
  • 14.Dehghan M, Abbaszadeh M. The meshless local collocation method for solving multi-dimensional Cahn–Hilliard, Swift–Hohenberg and phase field crystal equations. Eng Anal Bound Elements. 2017;78:49–64. doi: 10.1016/j.enganabound.2017.02.005. [DOI] [Google Scholar]
  • 15.Barrett JW, Blowey JF, Garcke H. Finite element approximation of the Cahn–Hilliard equation with degenerate mobility. SIAM J Numer Anal. 1999;37(1):286–318. doi: 10.1137/S0036142997331669. [DOI] [Google Scholar]
  • 16.Baňas L, Nürnberg R. Adaptive finite element methods for Cahn–Hilliard equations. J Comput Appl Math. 2008;218(1):2–11. doi: 10.1016/j.cam.2007.04.030. [DOI] [Google Scholar]
  • 17.Feng X, Wu H. A posteriori error estimates for finite element approximations of the Cahn-Hilliard equation and the Hele-Shaw flow. J Comput Math. 2008;26:767–796. [Google Scholar]
  • 18.Parvizi M, Eslahchi MR, Khodadadian A. Analysis of Ciarlet–Raviart mixed finite element methods for solving damped Boussinesq equation (submitted for publication)
  • 19.Feng X, Prohl A (2001) Numerical analysis of the Cahn–Hilliard equation and approximation for the Hele–Shaw problem, part II: error analysis and convergence of the interface, IMA Preprint Series 1799. http://hdl.handle.net/11299/3660
  • 20.Boyarkin O, Hoppe RH, Linsenmann C. High order approximations in space and time of a sixth order Cahn–Hilliard equation. Russ J Numer Anal Math Model. 2015;30(6):313–328. doi: 10.1515/rnam-2015-0029. [DOI] [Google Scholar]
  • 21.Cook H. Brownian motion in spinodal decomposition. Acta Metall. 1970;18(3):297–306. doi: 10.1016/0001-6160(70)90144-6. [DOI] [Google Scholar]
  • 22.Langer J, Bar-On M, Miller HD. New computational method in the theory of spinodal decomposition. Phys Rev A. 1975;11(4):1417. doi: 10.1103/PhysRevA.11.1417. [DOI] [Google Scholar]
  • 23.Blomker D, Sander E, Wanner T. Degenerate nucleation in the Cahn–Hilliard–Cook model. SIAM J Appl Dyn Syst. 2016;15(1):459–494. doi: 10.1137/15M1028844. [DOI] [Google Scholar]
  • 24.Binder K (1981) Kinetics of phase separation. In: Stochastic nonlinear systems in physics, chemistry, and biology, Springer, pp 62–71
  • 25.Pego RL. Front migration in the nonlinear Cahn–Hilliard equation. Proc R Soc Lond A. 1989;422:261–278. doi: 10.1098/rspa.1989.0027. [DOI] [Google Scholar]
  • 26.Blomker D, Maier-Paape S, Wanner T. Spinodal decomposition for the Cahn–Hilliard–Cook equation. Commun Math Phys. 2001;223(3):553–582. doi: 10.1007/PL00005585. [DOI] [Google Scholar]
  • 27.Abbaszadeh M, Khodadadian A, Parvizi M, Dehghan M, Heitzinger C. A direct meshless local collocation method for solving stochastic Cahn–Hilliard–Cook and stochastic Swift–Hohenberg equations. Eng Anal Bound Elements. 2019;98:253–264. doi: 10.1016/j.enganabound.2018.10.021. [DOI] [Google Scholar]
  • 28.Giles MB. Multilevel Monte Carlo path simulation. Oper Res. 2008;56(3):607–617. doi: 10.1287/opre.1070.0496. [DOI] [Google Scholar]
  • 29.Taghizadeh L, Khodadadian A, Heitzinger C. The optimal multilevel Monte–Carlo approximation of the stochastic drift-diffusion-Poisson system. Comput Methods Appl Mech Eng (CMAME) 2017;318:739–761. doi: 10.1016/j.cma.2017.02.014. [DOI] [Google Scholar]
  • 30.Khodadadian A, Taghizadeh L, Heitzinger C. Optimal multilevel randomized quasi-Monte–Carlo method for the stochastic drift-diffusion-Poisson system. Comput Methods Appl Mech Eng (CMAME) 2018;329:480–497. doi: 10.1016/j.cma.2017.10.015. [DOI] [Google Scholar]
  • 31.Barth A, Lang A, Schwab C. Multilevel Monte Carlo method for parabolic stochastic partial differential equations. BIT Numer Math. 2013;53(1):3–27. doi: 10.1007/s10543-012-0401-5. [DOI] [Google Scholar]
  • 32.Barth A, Lang A. Multilevel Monte Carlo method with applications to stochastic partial differential equations. Int J Comput Math. 2012;89(18):2479–2498. doi: 10.1080/00207160.2012.701735. [DOI] [Google Scholar]
  • 33.Kovács M, Larsson S, Mesforush A. Finite element approximation of the Cahn–Hilliard–Cook equation. SIAM J Numer Anal. 2011;49(6):2407–2429. doi: 10.1137/110828150. [DOI] [Google Scholar]
  • 34.Chai S, Cao Y, Zou Y, Zhao W. Conforming finite element methods for the stochastic Cahn–Hilliard–Cook equation. Appl Numer Math. 2018;124:44–56. doi: 10.1016/j.apnum.2017.09.010. [DOI] [Google Scholar]
  • 35.Da Prato G, Debussche A. Stochastic Cahn–Hilliard equation. Nonlinear Anal. 1996;2(26):241–263. doi: 10.1016/0362-546X(94)00277-O. [DOI] [Google Scholar]

Articles from Computational Mechanics are provided here courtesy of Springer

RESOURCES