Numerical Studies on Phase Field Diffusion and Flow Solvers

Size: px
Start display at page:

Download "Numerical Studies on Phase Field Diffusion and Flow Solvers"

Transcription

1 Numerical Studies on Phase Field Diffusion and Flow Solvers Author: E. Man Supervisors: Prof.dr.ir. C.R. Kleijn, M.Sc. H.G. Pimpalgaonkar May 7, 2014 Delft University of Technology Facaulty of Applied Sciences Department of Chemical Engineering Research group: Transport Phenomena

2 ABSTRACT The goal of this project is to validate and evaluate developed numerical solvers that solve both the Cahn-Hilliard diffusion equation and the Cahn-Hilliard-Navier-Stokes coupled equations. The solvers are written for the implementation in the open source CFD software platform, OpenFOAM. In Chapter 1, we give a brief description of the phase field theory which we have implemented in our solvers. This theory is used to study phase separation in multiphase flows. We also discuss the physics behind the phase separation. We also give a short derivation of Cahn-Hilliard equation and the coupled Cahn-Hilliard-Navier-Stokes equation. In chapter 2, we validate our phase field diffusion solver and diffusion-reaction solver. We examine the temporal evolution of the characteristic length R(t) and we show that it follows classical Lifshitz-Slyozov law. To validate diffusion reaction solver, we simulate Liesegang pattern inducing reaction systems and validate our results with the available results in literature. In chapter 3, we validate our Cahn-Hilliard-Navier-Stokes coupled solvers for the velocity field using test cases for which analytical solution is available. Herein, we evaluate the effect of the phenomenological parameters on some of the simulation characteristics, such as parasitic current and phase field parameter overshoot. We show that these characteristics also follow the expected behavior. 1

3 Contents 1 Phase Field Model and Theory Cahn-Hilliard(CH) Equation Navier-Stokes(NS) Equation Scope of the Project Validation of Cahn-Hilliard Diffusion and Diffusion-Reaction Solver Case: Length Scale Study Case: Diffusion-Reaction Solver Validation of Cahn-Hilliard-Navier-Stokes coupled Solver Case: Square Droplet Case: Lid Driven Cavity Conclusions and Recommendations Conclusions Recommendations APPENDIX 25 2

4 Chapter 1 Phase Field Model and Theory In the Fickian diffusion description, molecules move in the direction of the gradient of concentration. Despite of its general applicability, sometimes it cannot describe some of the common transport phenomenona, like the separation of the components of an immiscible mixture, e.g. an oil/water mixture, separating into oil and water layer. We start with a well dispersed mixture of immiscible components, say oil and water, where the concentration is homogeneous across the whole system, Fick s diffusion law would predict this as a stable system, but the experiments show that this is an unstable system. As time progresses, the system evolves into two separate water-rich and oil-rich layers. The physical explanation of such phase separation can be understood from the principle of the minimum energy: for a closed system, the total free energy must be minimized. For a binary system, like oil/water mixture, there are 3 different possible free energy contributions: the interaction of the same molecules: oil-oil or water-water, and the interaction of two different molecules; oil-water interaction. Both oil-oil and water-water interactions must be more energetically favorable than the oil-water interactions for phases to separate. Thermodynamically, the system will evolve to minimize the number of interactions between different kind of molecules and replace it with the interaction of same kind of molecules, which in turn is equivalent to minimization of the contact surface of the two fluids. This leads eventually into the aforementioned separation. The theory that can correctly predict and describe this phenomenon is the Phase Field Theory, which was developed by John W. Cahn and John E. Hilliard [1]. In the following section we will explain the Cahn-Hilliard equation and present the simplified version of the derivation of the equation that is done in the paper of Cahn and Hilliard. 1.1 Cahn-Hilliard(CH) Equation Phase field theory also describes a diffusion process. It can be regarded as an extension of the Fick s Diffusion law, a more complex variant of it. As we know the Fick s second law of diffusion (1D), c t = D 2 c x 2 (1.1) 3

5 is a combination of the first diffusion law and the continuity equation: J = D c x and, c t + J = 0 (1.3) where D is the diffusivity and c is the concentration. We start the derivation of phase field equations with same continuity equation. In absence of a source, it can be stated that any changes of the concentration can only be caused by the inflow or the outflow of the particles from a control volume due to diffusion flux. We replace the concentration with a more convenient phase field parameter φ (a function of the time and spatial coordinates), which determines the composition of both phases. The volume fraction, y, of a species can have values between 0 and 1, while total volume fraction in a control volume must add up to 1. We can then take a transformation of the volume fraction with, φ = 2y 1. Even after the transformation the continuity equation does not change. φ will takes values between -1 & 1, for a equimolar composition, φ = 0. (1.2) From a conventional Fickian analogy, the flux is proportional to the gradient of concentration, which serves to be the driving force of the diffusion. However this analogy fails to model phase separation. Clearly, there is some other force that drives the diffusional flux. In the paper of Cahn and Hilliard [1], authors proposed and proved that for an isothermal system, the driving force of the diffusion flux should be the gradient of the chemical potential, µ. Therefore J can be express as: J = M µ (1.4) where M is the mobility of the particles, analogous to the diffusion coefficient. Conventionally, chemical potential is defined as a derivative of Gibbs free energy with respect to the concentration, F c. But just like the continuity equation, in phase field equation we would like to express all parameters in terms of the phase field parameter φ. It can be seen that for F c = F φ, from here we can reformulate eq. (1.3) as the Cahn-Hilliard Equation (CH equation): φ t M 2 µ = 0 (1.5) According to Cahn and Hilliard [1], the total free energy of a nonuniform system, F, can be evaluated as an integral of the local free energy function, f, over the whole region. f can then be expressed as a sum of two contributions, which yields the following equation: F = [f(φ 0 ) + κ( φ) 2 ]dv (1.6) Physical explanation of each term is as follows: R 1. The homogeneous free energy, f(φ 0 ) represent the free energy contribution due to local composition at equilibrium. This term solely depends on the local phase composition, it takes form of a double-well potential [7]. One commonly used function to defines double-well potential is: f(φ 0 ) = 1 4 (φ2 1) 2 (1.7) 4

6 where the 2 minima represent the composition of two pure phases which is thermodynamically stable(see fig. 1.1). 2. The gradient free energy, κ( φ) 2. This is the energy penalty due to the changes in concentration in the vicinity of given point. The only part of the system that has a gradient in concentration is the interface surface, this is then also called the Interface energy. The constant κ serves as a phenomenological parameter is which related to the interface thickness. If we plug in the definition of chemical potential using the total free energy function of Cahn and Hilliard as of the free energy of Gibbs, µ becomes: µ = F φ = f (φ) κ 2 φ = φ 3 φ κ 2 φ (1.8) and combine eq. 1.5 and eq. 1.8, we derive the Cahn-Hilliard Equation: φ t = M 2 µ µ = φ 3 φ κ 2 φ φ t = M 2 (φ 3 φ κ 2 φ) (1.9) With this result, we see that CH equation is a 4 th order nonlinear differential equation. Figure 1.1: Double well potential function, f(φ 0 ) = 1 4 (φ2 1) Navier-Stokes(NS) Equation In the previous section, we described a diffusion only system. We assumed that any changes of the concentration can only be caused by diffusion flux. But in a dynamic fluid system, concentration can also be influenced by the convection flow of the fluid. Therefore we need to reformulate the species continuity equation as: φ t + ( uφ) = M 2 µ (1.10) 5

7 where u is the velocity field of the system. Since we need to take fluid motion into account, the system also has to satisfy the law of mass conservation and momentum conservation. For the incompressible fluid the mass conservation law gives: and the standard Navier-Stokes equation is modified as: u = 0 (1.11) ρ( u t + ( u ) u) = p + τ + F s + ρg (1.12) where F s is the surface tension force that is added into the NS equation to extend its applicability to the two phase flow and τ the stress tensor. Based on the principle of conservation of energy, the change of the kinetic energy that is induced by surface tension force has to be compensated with the change in free energy of the system. Below is the expression for the change of the kinetic energy from Jacqmin[10]: u F s dv (1.13) then here follow the expression for the change of free energy: F F F t = t dv = φ φ t dv = µ φ dv (1.14) t Using chain rule, we can express the change of free energy in terms of the chemical potential µ and the rate of change of φ, if we plug in the expression of eq only consider the convection flux term: F t = µ ( uφ)dv = µ(φ u + u φ)dv = µ u φdv = uφ µdv (1.15) If we equate eq and 1.15, we get an expression of the surface tension force that is in terms of chemical potential and the phase field parameter: F s = φ µ (1.16) Combining equations 1.10, 1.11, 1.12, we have the Cahn-Hilliard-Navier-Stokes couple equation that govern the velocity field in a two phase diffusion/convection system. 1.3 Scope of the Project In this poject, we would like to evaluate and validate the developed numerical solvers with some standard test cases. The solvers we want to test include: Cahn-Hilliard diffusion solver (equation 1.4), diffusion-reaction solver (see chapter 3.2) and Cahn-Hilliard-Navier-Stokes coupled solver (equation 1.12). For diffusion and diffusion-reaction solver we plan to qualitatively validate solvers using test cases from literature. For flow solvers, we wish to perform a girdsize dependence study and a simulation parameters dependence study. Different conservative and non-conservative solvers were used to simulate flows. We would also like to study the sensitivity of the parasitic current on the different solvers. For Ca hn-hilliard-navier- Stokes coupled solver, we would like to obtain velocity profiles for simple cases such as flow between plates for which an analytical solution is available. Then, we would like to evaluate our solvers for parasitic currents and interface width as done by Hoang et al. [11]. We would also like to reproduce analytical functionality between the phase field parameter shift and the Cahn number. 6

8 Chapter 2 Validation of Cahn-Hilliard Diffusion and Diffusion-Reaction Solver In this chapter, we will validate the CH diffusion solver developed within the Transport Phenomena group by reproducing results from literature. First, we will validate our solver qualitatively by verifying that the solver reproduces the Lifshitz-Slyozov law. Next, we will test our diffusion-reaction solver for simulation of formation of precipitation pattern. 2.1 Case: Length Scale Study In this validation study, we will estimate an important simulation property, namely the Characteristic Length (R(t)) of the system. As explained before in the previous chapter, when free energy exhibits a double-well potential function, the homogeneous mixture will spontaneously separate into two pure phases and begin the process of coarsening. The size of single (pure) phase region will grow gradually, until the system reaches its chemical equilibrium of minimum free energy. If we closely examine fig. 2.1, we can observe growth of the morphological patterns at different times. It has been shown that if we rescale the rate of growth of the patterns by the characteristic length, R(t), growth of microstructure are essentially the same [8]. That means the morphology of the system is self similar and only depends on time via R(t). Many studies [2][3][4] came to a conclusion that this particular characteristic length, R(t), follows a specific temporal growth law: R(t) n R n 0 = Kt (2.1) where R(t) and R 0 are respectively the characteristic length of the single phase domain at a given time and at t = 0, and K is the coarsening constant. In previous studies, they find a power law relation of R(t) n R0 n t with n 3 for the stage right after the initial coarsening, and n 4 for later stage [3]. This particular growth model of R(t) with n = 3 is referred to as the Lifshitz-Slyozov(LS) law [5]. Lifshitz and Slyozov had derived this law for the phenomenon called Ostwald Ripening: A large droplet will grow in size by the condensation of diffused material through the evaporation of smaller droplets. This is called evaporation- 7

9 (a) (b) (c) (d) Figure 2.1: Morphological pattern of the phase separation at time: (a) t = 0s, (b) t = 0.001s, (c) t = 0.01s, (d) t = 1s condensation mechanism, which is the dominant mechanism in the initial stages of coarsening. Our goal in this study is to confirm the validity of the CH solver by qualitatively reproducing the same functionality as that of Lifshitz-Slyozov law. Scaling Function It has been shown in the studies that there are two methods to estimate the characteristic length R(t). It can be done either via Fourier transformation and calculation of the structure factor [2][3][4], or via autocorrelation of the phase field function [8]. In our studies we have chosen the latter approach. It is less complex mathematically, and also requires less postprocessing procedures. Structure function studies are more important when dealing with real experiment. Suppose we have a two dimensional discrete N by N phase field function φ(m, n), with 0 m N 1 and 0 n N 1. From this phase field function we can take the standard 2D auto-correlation function: C(k, l) = N 1 N 1 X X φ(m, n)φ (m k, n l) m=0 n=0 8 (2.2)

10 Since C(k, l) is considered to be a rotational invariant function, all points with the same radius r = m 2 + n 2 share statistically the same function value of C. By taking circular average of this function we can simplify this 2D autocorrelation function into a direction invariant function C( r): C( r) = G C( x)ds G ds = 2π 0 C(θ)rdθ 2πr (2.3) where numerator represents a line integral of the function C( x) along a circular close path G, and denominator is the length of the path G (circumference of the circle). But for our auto-correlation function, we only know the discretized function value at each grid point, not the function itself. To make eq. 2.3 still useful for our analysis, we first define an array of coordinates on the discretized path G with radius R 1 in polar coordinate: G R1 : p 0 = (R 1, 0), p 1 = (R 1, θ), p 2 = (R 1, 2 θ),..., p n = (R 1, n θ) (2.4) then mapping these polar coordinate back to cartesian coordinates in order to perform 2D interpolation on those points. After finding out the interpolated function value of each point, F (p i ), we can substitute into the following expression that is analogical to eq. 2.3: C( r) = F (p 0) + F (p 1 ) + F (p 2 ) F (p n ) n = 1 n F (p i ) n i=0 (2.5) Qualitatively speaking, C( r) is considered to represent the probability that two randomly chosen points separated by distance r, have the same phase field value, i.e. C(r) = P [φ(r1 ) = φ(r 2 )]. Using this definition of C( r), we can predict that: for r is small, both points are likely to be within the same phase region C( r) 1. As r grows larger, C( r) decreases exponentially into a minimum and eventually leading into an asymptotic value of overall phase composition φ 0. The distance λ between the origin and the first minimum of the function is roughly corresponding to the separation distance of the morphological pattern [8]. For λ describes the typical length of the domain, we can use this as the characteristic length, R(t). According to the LS growth law, λ must follows eq Simulation In our simulations, we consider a 2D square discretized domain that contains 256 by 256 grid points. We then simulate the homogeneous initial state by randomly assigning the phase field parameter φ = 1 or φ = 1 in each grid cell. Because of the randomness, the global phase composition statistically approaches zero i.e. φ 0 0. As time progresses, the phase field φ of each cell will evolve according to the CH equation. To prove the independence of the growth law with the initial state, we generated 8 different sets of initial condition, no two initial condition have the same distribution of φ, yet the φ 0 s are all approximately equal to 0. This was archieved by using different seed values in a random number generator. To validate the LS law, we calculated the characteristic length R(t) of every time step based on the auto-correlation function. According to eq. 2.1, we would expect a straight line from the plot of R 3 (t) versus t, yet fig. 2.3a shows otherwise. We can clearly see that the graph begins relatively linear, then around t = 0.02 the slope flatten out as time increases. We can 9

11 (a) (b) Figure 2.2: (a) Morphological pattern of the phase separation at time t = 0.007s, (b) 1D circular average of the autocorrelation function, C(r). Distance λ indicate the first minimum of the function that can be associate with the length of the microstructure. conclude that the LS law can only be applied at the initial stages of the coarsening, after that another growing mechanism must dominate the system s evolution. This is indicated in the logarithm plot of the data, see fig. 2.3d. The slopes in the two time intervals (t = [0, 0.2] and t = [0.05, 0.2]) clearly have two different values. A steeper slope (t = [0, 0.2]) indicates a faster growth relationship and shallower slope (t = [0.05, 0.2]) indicates slower growth. After the initial stage of coarsening, which is described by LS law and evaporation-condensation mechanism, most of the single phase regions have grown into a layer-like shape (see fig. 2.1c), where most of the small droplets have already been absorbed into the layer-structure. From now on, the dominant way to reduce the free energy, i.e. reduce the interface between region, is to rearrange the molecules within single phase region to smooth out the curvature. It can be seen from µ in eq. 1.4 that within a single phase region, there can be no flux. Diffusion only takes place where particles can move, i.e. along the interface. Particles will diffuse from places with high curvature into places of low curvature in order to flatten out the interface which means less contact area. This curvature-driven diffusion mechanism is much slower and has the corresponding exponent of the growth law of n = 4[3]. The statistical value of R 2 = of the linear fit on R(t) 3 = Ax + b from 0s < t < 0.02s (fig. 2.3b) strongly suggests that our data does fit into the LS growth law in the initial stage of the coarsening. To find out the actual growth constant, we can take the nonlinear fit of our data using the following approximation, R(t) A + Bt m, which is a result from the binomial expansion of eq. 2.1 (Appx A). After analyzing our data, we found that for 0s < t < 0.02s, m = 0.26 which means our growth exponent is slightly smaller than the theoretical value of m = 1/3. It has been reported in literature that this exponent asymptotically approaches the LS law [13]. Hence a simulation with more than 256x256 space grids will help in taking this number closer to 1/3. Before we discuss the result of t > 0.02, we need to mentioned that all R(t) values are the mean values of the averaging over all 8 dataset. As for the error analysis, 10

12 we used the following formula to determined the confidence interval: X n ± A S n n (2.6) where X n is the mean value, A is statistical value of the student s T-distribution value(99%), S n the sample variance and n the sample size. The errors of the interval 0s < t < 0.02s are so small that we decide not to plot it. As for the growth constant at t > 0.02s, we plotted R 4 (t) versus time, we found for the linear fit R 2 = 0.986, which is a decent indication of the validity of n = 4. On the other hand the error bars are relatively large, this shows that for a reliable fit and conclusion, we need to increase our sample size. And for the nonlinear fit of eq. 2.1, we only obtain an unphysical value that is not even close to m = 1/4, which is expected given the large error bars. (a) (b) (c) (d) Figure 2.3: The cubic of the characteristic length versus time, (a) t = 0s to t = 0.3s, (b) Logarithm plot, (c) Only the linear part of the (a) i.e. t = 0s to t = 0.02s and the linear fit of R 3 (t) = Ax + b with R 2 = 0.992, (d)the fourth power of the characteristic length versus time t = 0.05s to t = 0.2s and linear fit R 4 (t) = Ax + b with R 2 =

13 2.2 Case: Diffusion-Reaction Solver Next, we wish to validate the diffusion-reaction solver. One way to test it is to simulate precipitation patterns. One specific case is called the Liesegang Pattern. Depending of the geometry of the domain, the Liesegang pattern can be bands, rings or shells. These alternating patterns are the alternating single phase regions that are created during precipitation of reactions due to phase separation. One of the determining factors of the patterns is the instability condition. Unlike the previous case, in which the whole domain is considered to be thermodynamically unstable, Liesegang pattern formation is controlled by a guiding field of instability condition, this guiding field can be temperature, PH-level and in case of precipitation, the concentration of reactant. The source of instability often starts at one end of the domain, then gradually spread over the whole region, and the same goes with the formation of the pattern. (a) (b) Figure 2.4: 1D Liesegang pattern at two different time (a) t = 0.6s, (b) t = 3s. Modeling of the governing equation We follow here the approach given by Antal et al[6] to simulate Liesegang pattern formation. Let us consider the standard CH equation (eq. 1.9). To incorporate a guiding field into our simulation, we need to slightly modify the equation to satisfy the instability condition. Based on the equation, we see that the start of the phase separation is only determined by the sign of the first two terms of the equation. We can simply insert a parameter ɛ to control activation of phase separation. If we consider a 1D domain and rescale all parameters to dimensionless the CH equation can be written as: φ t = 2 x 2 (ɛφ φ3 + κ 2 φ x 2 ) (2.7) The parameter ɛ represent the presence of the source of instability. Depending on the initial condition ɛ can always rescale between 1 and +1. When ɛ changes sign the separation starts. Unless ɛ changes sign, phase separation does not initiate. Since ɛ is related to the concentration profile of the reactant, we can use the standard Fick s equation of diffusion to model the evolution of ɛ: ɛ t = D 2 ɛ x 2 (2.8) where D is the dimensionless diffusion coefficient of the system. For a 1D domain that the reaction starts at one end, the corresponding initial conditions are: at t = 0, ɛ(x > 0) = 1 and ɛ(x = 0) = 1, and also at then other end x = L there is no mass flux, ɛ x = 0. 12

14 Result In our simulations, we are able to reproduce similar results of Antal et al[6]. First we can confirm that the ɛ profile in time indeed follows Fick s theory of mass transfer. According to the penetration theory, which is derived from the Fick s law, the following relationship of penetration depth and time must hold, x p t. After performing a power fit on the data we found the exponent of 0.48 ± 0.18, which is very close to the theoretical value of 0.5. (a) (b) Figure 2.5: (a) ɛ profile of t = 0.05s(blue),t = 0.5s(red),t = 1s(green) and the penetration depth calculated as tangent of the ɛ profile (dashed line), (b) Power fit of the penetration depth vs time, y = ax b with b = 0.48 ± In fig. 2.6, we can see the details of the formation of the alternating pattern. By comparing our result(left) with the result of literature [6] (right), we can conclude that we qualitatively have the same result. The peaks and lows of the pattern follow precisely the squared root function of the guiding field, also the spinodal line is indicated in the figure. These two lines are the direct result of the altering of the first two terms of the CH equation. This way, the 13

15 local free energy function is continuously changing depending on the value of ɛ. Ideally, we would like run the simulation until it reaches the stationary state, however due to the large amount of simulation time required, we stop the simulation at t = 60s. In fig. 2.7, we can see that our result (top) shows similar shape to the result of [6], we would expect that after a longer simulation time, when the system reaches the stationary state, all peaks and lows will reach the single phase phase-field value of φ = 1, +1. (a) (b) Figure 2.6: (a) Snapshot of the guiding field ɛ(x)(blue dashed), phase field φ(x) (black), spinodal line ± ɛ(x)/3 (red), local equilibria ɛ(x) (green), (b) Similar simulation result from Antal et al.[6] 14

16 (a) (b) Figure 2.7: Numerical solution of phase field parameter, (a) with L = 4000, D = 1, φ 0 = 0.05, solution at t = 60s(last time point of the simulation), (b) Stationary solution from Antal et al.[6] 15

17 Chapter 3 Validation of Cahn-Hilliard-Navier-Stokes coupled Solver 3.1 Case: Square Droplet When phase field theory is integrated with the Navier-Stokes equation to simulate multiphase flow, the surface tension force of a two-phase mixture is formulated as a function of the phase field parameter φ and the chemical potential µ. A solver has been developed in the Transport Phenomena group which solves the NS equation along with the phase field equation and continuity equation. To verify this implementation of the surface tension force into the Navier- Stokes equation, we will check our solver by performing an interface deformation simulation. Simulation In this test case, we will simulate the relaxation of a 2D square droplet in the surrounding of a different phase, where the phases of the droplet and the surrounding are the two stable states of the free energy function. Regarding the transport properties for both phases, they share the same viscosity, mobility and density, the only difference is the surface tension. Due to surface tension, the droplet will relax into the minimum energy configuration i.e. a circle. When it relaxes into a circular shape, all surface tension forces at the interface cancel out and it also reaches the minimum area of contact surface. Within this simulation, we will also evaluate some of the characteristics of the simulation. First, we will check the interface width with the value reported in literature in which a different modelling method is used to solve similar multiphase flows. Second, we will discuss two effects that often appear in the modeling of phase field theory, parameter overshoot and parasitic current. 16

18 (a) (b) (c) (d) (e) (f) Figure 3.1: Relaxation of a square droplet into a circular droplet at (a) t = 0s, (b) t = 0.01s, (c) t = 0.05s, (d) t = 0.2s, (e) t = 0.5s, (f) t = 1s. 17

19 Interface thickness In fig 3.2, we have plotted the interface thickness on 3 different meshsizes, the contour lines indicate the phase field parameter. We define interface thickness as the region between φ = 0.9 and φ = 0.9 (the inner and the outer contour line of fig. 3.2), the corresponding interface thickness is approximately between 4 to 5 grid cells. It is noteworthy to point out that the number of grid cells which the interface occupies is constant, in spite of the increasing meshsize. This means that the interface is getting smaller when we are using a finer mesh. We compare this thickness to that reported by Hoang et al [12], in their simulation. They observed that the interface is 6 grid cells for Volume of fluid (VOF) solving method, see fig (a) (b) (c) Figure 3.2: Interface of 3 mesh size, inner and outer contour line respectively: φ = 0.9 and φ = 0.9 (a) 64x64, (b) 128x128, (c) 256x256 Figure 3.3: Interface of the simulation of Hoang et al. [11] Parameter Overshoot The definition of phase field parameter φ is given as a rescaled volume fraction of the molecules. φ should be bounded in the range of [-1,1], any values beyond the range have no physical meaning. But in our simulation we have observed that φ will shift in range of [ 1 + φ, 1 + φ] with φ when using Krylov subspace solvers. Such overshoot in phase field parameter φ can affect the accuracy of the simulation, but is unavoidable unless special solvers are used. It has been reported in study of Yeu et al. [12] that this parameter overshoot is linearly related to the interface thickness, after it is rescaled into a dimensionless 18

20 number, the Cahn Number(Cn), as: The Cahn number is define as follows: κ Cn = L = ξ L 2 φ = Cn (3.1) 3 (3.2) where κ is the phenomenological parameter from the free energy function of the CH equation (see eq. 1.6). Since κ has dimension [m 2 ], hence we take its square root. L is the size of the domain, in our simulation it is set to L = 1. Since κ can be adjusted in our simulation, we altered Cahn number to validate equation 3.1. The result is plotted in fig It shows that φ decreases linearly with decreasing Cn, i.e. with finer mesh. Ideally, we want the deviation of φ to be as small as possible. But this also would mean the interface thickness should be very thin. To resolve this interface properly in simulation we need to use a very fine mesh. Thus, there is a trade off between the accuracy of the simulation and the available computational power. Figure 3.4: φ vs Cahn Number, Analytical solution Yue et al: φ = y = ax + b a=0.487, b=0.0009, R 2 = Cn, Linear Fit: Parasitic Current When the droplet reaches its stationary state (see fig. 3.1f), it means that the free energy is at its minimum and the driving force of any transport processes will be zero, the exact solution of the velocity should also be zero. Any non-zero velocity in the system is regarded as the parasitic current, which results due to numerical solution of the NS equation on a discretized domain. In fig. 3.5, we see the residual velocity in the domain. In this test case, we will evaluate the magnitude of the parasitic currents of the conservative and the non-conservative solvers. The conservative solvers is a MULES (Multidimensional Universal Limiter with Explicit Solution) based solver that maintains integral balance and at the same time keeps the field value (φ) offset within limit. The non-conservative solver is a Krylov subspace or iterative solver, in which neither integral balance nor field value (φ) offsets are managed efficiently. We can see from fig. 3.6 that the difference in the magnitude of the parasitic currents between the solvers is around This means that by imposing the constraints of 19

21 the phase field conservation, the parasitic currents are several order of magnitude larger than its non-conservative counterpart. Parasitic currents due to the non-conservative solvers, on the other hand, approach machine precision. Figure 3.5: Velocity profile of a relaxed droplet at t = 1s. Figure 3.6: Magnitude of parasitic currents of Conservative solver and Nonconservative solver. 20

22 3.2 Case: Lid Driven Cavity In the following case, we run a simulation where an external velocity field is applied on the system. We will check the velocity profile of the stationary state with the analytical solution and validate the solver for velocity profile. Simulation In this test case, we perform a 2D simulation of phase separation within a cavity, a standard squared domain, with both top and bottom connected to an imaginary lid that moves with the same velocity but in the opposite x-directions, v top = +1m/s, v bottom = 1m/s. Within this setup we have perform two simulations, first we assume both species to have the same transport properties, and in the second simulation one species will have a higher viscosity, µ 1 /µ 2 = 0.4. In both simulations we begin with a well dispersed mixture. In fig. 3.7, we can see the evolution of the morphological pattern; and in the last figure we find out the stationary state of the system. Strictly speaking, the system is not yet perfectly stationary, the interfaces between the phases are not a horizontal straight line yet, which means the free energy has not yet reached its minimum. For any longer simulation time, we observe a small ripple on the interface will not disappear but rather oscillate in time. So we use this last configuration as our template for the prediction of the velocity profile. It is also important to notice that this horizontal single layer configuration appears only when we apply cyclic boundary condition on the two sides of the cavity to simulate a unbound domain i.e. left wall and right wall are connected. For a actual square cavity (see Appx C), the simulation results suggest that there is no stationary state like fig. 3.7f. In fig. 3.8 we clearly see the effect of the single horizontal layer in the velocity profile. Depending on the value of the viscosity the slope of the velocity as well will change. Since viscosity determines the rate of diffusion of momentum, we expect regions with higher viscosity to show a steeper slope in velocity profile, while regions with lower viscosity should show shallower slope in velocity profile. The velocity profile obtained here is consistant with our observations. 21

23 (a) (b) (c) (d) (e) (f) Figure 3.7: Morphological pattern of lid driven cavity simulation at time: (a) t = 0s, (b) t = 0.01s, (c) t = 0.5s, (d) t = 2.5s, (e) t = 5s, (f) t = 7.5s. (a) (b) Figure 3.8: Velocity profile of the simulation with (a) same viscosity µ 1 = µ 2, (b) different viscosity µ 1 /µ 2 =

24 Chapter 4 Conclusions and Recommendations 4.1 Conclusions In this thesis, several numerical solvers are tested against the result of the other studies. In all 4 test cases we were able to reproduce qualitatively similar results, hereby validating our solver to be useful and reliable. For the four test cases, the following conclusions can be drawn: 1. The Length scale study shows that the growth relation of the morphological pattern indeed follows the Lifshitz-Slyozov law, but only at the initial stages. In order to obtain a more accurate agreement, simulations should be run with finer grid size. 2. Although the running time of the simulations of the Liesegang Pattern were not sufficient to reach the steady state, the comparison of the snapshots of both our result and that of [6] did prove the validity of the penetration theory and the diffusion-reaction solver. 3. The CH-NS coupled solver can accurately predict the deformation of a square droplet. As for numerical phenomena such as parasitic current and parameter overshoot, they are influenced by the chosen simulation parameters. Depending on the requirement of the simulation, they can be tweaked into optimum value. 4. As for the velocity profile of the lid driven cavity, the results are in agreement with the analytical solution of NS solver. 4.2 Recommendations During this project, there were several simulations that we were not able to finish. These included the simulation of a Taylor-drop experiment, which is an extension on the current lid driven cavity case. After we obtain a stable shear flow within the domain, we want to simulate droplet relaxation in such environment. In our simulation, we were not able to keep the droplet stationary. Because of the unbound domain, the droplet was carried away out of the domain by the fluid flows. Our first recommendation is to finish this simulation by fine tuning the simulation parameters, such as velocity, density, viscosty etc. to keep the droplet in place and/or employing a continuous feed back system to reposition the droplet. Next, 23

25 we would recommend to perform a sensitivity study of parasitic currents on the dependence of the meshsize. In our project we are only able to run simulations on 64x64 and 128x128. Simulations on finer meshsize should give a good indication of the parasitic current dependence on meshsize. Finally, we recommend to incorporate a better formulation of the surface tension into the solver. At the moment we are using the Weber number as input, but σ is a material property and will be a better input parameter for our simulations. 24

26 APPENDIX A Binominal Expansion Accoring to the Binominal Theorem, any power function of (x + y) n can be expanded as: ( ) ( ) ( ) ( ) ( ) n n n n n (x + y) n = x n y 0 + x n 1 y 1 + x n 2 y x 1 y n 1 + x 0 y n (4.1) n By only taking the first and last term we can approximate: B Simulation results of Length scale study Time(s) λ(r(t), Characteristic Length) Sample number Mean (x + y) n x n + y n (4.2) 25

27 C Lid driven cavity without cyclic boundary (a) (b) (c) (d) (e) (f) Figure 4.1: Phase field pattern, elapsed times are equal to (from left to right) t = 7.5s, t = 10s, t = 12.5s, t = 15s, t = 17.5s, t = 20s. 26

28 Reference [1] J.W. Cahn, J.E. Hilliard Journal of Chemical Physics 28, [2] A. Chakrabarti, R. Toral, J.D. Gunton Physical Review E 47, [3] J. Zhu, L. Chen, J. Shen, V. Tikare Physical Review E 60,3564. [4] P. Fratzl, J.L. Lebowitz, O. Penrose, J. Amar Physical Review B 44, [5] I.M. Lifshitz, V.V. Slyozov Journal of Physics and Chemistry of Solids, Vol. 19, 35. [6] T. Antal, I. Bena, M. Droz, K. Martens, Z. Rácz Physical Review E 76, [7] D. Lee, J, Huh, D, Jeong, J. Shin, A. Yun, J. Kim Computational Materials Science 81, [8] Y. Jiao, E, Padilla, N. Chawla Acta Materialia 61, [9] X. Cai, M. Wörner, O, Deutschmann th Open Source CFD International Conference, Hamburg,Germany, Oct [10] D. Jacqmin Journal of Computational Physics 155, [11] D.A. Hoang, V. van Steijn, L.M. Portela, M.T. Kreutzer, C.R. Kleijn Computers and Fluids 86, [12] P. Yue, C. Zhou, J.J. Feng Journal of Computational Physics [13] T.M. Rogers, K.R. Elder, R.C. Desai Physical Review B

Finite Difference Solution of the Heat Equation

Finite Difference Solution of the Heat Equation Finite Difference Solution of the Heat Equation Adam Powell 22.091 March 13 15, 2002 In example 4.3 (p. 10) of his lecture notes for March 11, Rodolfo Rosales gives the constant-density heat equation as:

More information

A PRACTICALLY UNCONDITIONALLY GRADIENT STABLE SCHEME FOR THE N-COMPONENT CAHN HILLIARD SYSTEM

A PRACTICALLY UNCONDITIONALLY GRADIENT STABLE SCHEME FOR THE N-COMPONENT CAHN HILLIARD SYSTEM A PRACTICALLY UNCONDITIONALLY GRADIENT STABLE SCHEME FOR THE N-COMPONENT CAHN HILLIARD SYSTEM Hyun Geun LEE 1, Jeong-Whan CHOI 1 and Junseok KIM 1 1) Department of Mathematics, Korea University, Seoul

More information

Coarsening kinetics from a variable-mobility Cahn-Hilliard equation: Application of a semi-implicit Fourier spectral method

Coarsening kinetics from a variable-mobility Cahn-Hilliard equation: Application of a semi-implicit Fourier spectral method PHYSICAL REVIEW E VOLUME 60, NUMBER 4 OCTOBER 1999 Coarsening kinetics from a variable-mobility Cahn-Hilliard equation: Application of a semi-implicit Fourier spectral method Jingzhi Zhu and Long-Qing

More information

VIII. Phase Transformations. Lecture 38: Nucleation and Spinodal Decomposition

VIII. Phase Transformations. Lecture 38: Nucleation and Spinodal Decomposition VIII. Phase Transformations Lecture 38: Nucleation and Spinodal Decomposition MIT Student In this lecture we will study the onset of phase transformation for phases that differ only in their equilibrium

More information

Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang,

Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang, Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang, yfwang09@stanford.edu 1. Problem setting In this project, we present a benchmark simulation for segmented flows, which contain

More information

Bubbles and Filaments: Stirring a Cahn Hilliard Fluid

Bubbles and Filaments: Stirring a Cahn Hilliard Fluid Bubbles and Filaments: Stirring a Cahn Hilliard Fluid Lennon Ó Náraigh and Jean-Luc Thiffeault Department of Mathematics Imperial College London APS-DFD Meeting, 21 November 2006 1 / 12 The classical Cahn

More information

MOMENTUM TRANSPORT Velocity Distributions in Turbulent Flow

MOMENTUM TRANSPORT Velocity Distributions in Turbulent Flow TRANSPORT PHENOMENA MOMENTUM TRANSPORT Velocity Distributions in Turbulent Flow Introduction to Turbulent Flow 1. Comparisons of laminar and turbulent flows 2. Time-smoothed equations of change for incompressible

More information

meters, we can re-arrange this expression to give

meters, we can re-arrange this expression to give Turbulence When the Reynolds number becomes sufficiently large, the non-linear term (u ) u in the momentum equation inevitably becomes comparable to other important terms and the flow becomes more complicated.

More information

Linear Theory of Evolution to an Unstable State

Linear Theory of Evolution to an Unstable State Chapter 2 Linear Theory of Evolution to an Unstable State c 2012 by William Klein, Harvey Gould, and Jan Tobochnik 1 October 2012 2.1 Introduction The simple theory of nucleation that we introduced in

More information

Detailed Numerical Simulation of Liquid Jet in Cross Flow Atomization: Impact of Nozzle Geometry and Boundary Condition

Detailed Numerical Simulation of Liquid Jet in Cross Flow Atomization: Impact of Nozzle Geometry and Boundary Condition ILASS-Americas 25th Annual Conference on Liquid Atomization and Spray Systems, Pittsburgh, PA, May 23 Detailed Numerical Simulation of Liquid Jet in Cross Flow Atomization: Impact of Nozzle Geometry and

More information

Dimensionality influence on energy, enstrophy and passive scalar transport.

Dimensionality influence on energy, enstrophy and passive scalar transport. Dimensionality influence on energy, enstrophy and passive scalar transport. M. Iovieno, L. Ducasse, S. Di Savino, L. Gallana, D. Tordella 1 The advection of a passive substance by a turbulent flow is important

More information

Explicit algebraic Reynolds stress models for internal flows

Explicit algebraic Reynolds stress models for internal flows 5. Double Circular Arc (DCA) cascade blade flow, problem statement The second test case deals with a DCA compressor cascade, which is considered a severe challenge for the CFD codes, due to the presence

More information

Chapter 9: Differential Analysis of Fluid Flow

Chapter 9: Differential Analysis of Fluid Flow of Fluid Flow Objectives 1. Understand how the differential equations of mass and momentum conservation are derived. 2. Calculate the stream function and pressure field, and plot streamlines for a known

More information

Project 4: Navier-Stokes Solution to Driven Cavity and Channel Flow Conditions

Project 4: Navier-Stokes Solution to Driven Cavity and Channel Flow Conditions Project 4: Navier-Stokes Solution to Driven Cavity and Channel Flow Conditions R. S. Sellers MAE 5440, Computational Fluid Dynamics Utah State University, Department of Mechanical and Aerospace Engineering

More information

Chapter 9: Differential Analysis

Chapter 9: Differential Analysis 9-1 Introduction 9-2 Conservation of Mass 9-3 The Stream Function 9-4 Conservation of Linear Momentum 9-5 Navier Stokes Equation 9-6 Differential Analysis Problems Recall 9-1 Introduction (1) Chap 5: Control

More information

A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation

A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation S. Bordère a and J.-P. Caltagirone b a. CNRS, Univ. Bordeaux, ICMCB,

More information

Simulating Interfacial Tension of a Falling. Drop in a Moving Mesh Framework

Simulating Interfacial Tension of a Falling. Drop in a Moving Mesh Framework Simulating Interfacial Tension of a Falling Drop in a Moving Mesh Framework Anja R. Paschedag a,, Blair Perot b a TU Berlin, Institute of Chemical Engineering, 10623 Berlin, Germany b University of Massachusetts,

More information

THE PHYSICS OF FOAM. Boulder School for Condensed Matter and Materials Physics. July 1-26, 2002: Physics of Soft Condensed Matter. 1.

THE PHYSICS OF FOAM. Boulder School for Condensed Matter and Materials Physics. July 1-26, 2002: Physics of Soft Condensed Matter. 1. THE PHYSICS OF FOAM Boulder School for Condensed Matter and Materials Physics July 1-26, 2002: Physics of Soft Condensed Matter 1. Introduction Formation Microscopics 2. Structure Experiment Simulation

More information

PORE-SCALE PHASE FIELD MODEL OF TWO-PHASE FLOW IN POROUS MEDIUM

PORE-SCALE PHASE FIELD MODEL OF TWO-PHASE FLOW IN POROUS MEDIUM Excerpt from the Proceedings of the COMSOL Conference 2010 Paris PORE-SCALE PHASE FIELD MODEL OF TWO-PHASE FLOW IN POROUS MEDIUM Igor Bogdanov 1*, Sylvain Jardel 1, Anis Turki 1, Arjan Kamp 1 1 Open &

More information

MAE 598 Project #1 Jeremiah Dwight

MAE 598 Project #1 Jeremiah Dwight MAE 598 Project #1 Jeremiah Dwight OVERVIEW A simple hot water tank, illustrated in Figures 1 through 3 below, consists of a main cylindrical tank and two small side pipes for the inlet and outlet. All

More information

Shell Balances in Fluid Mechanics

Shell Balances in Fluid Mechanics Shell Balances in Fluid Mechanics R. Shankar Subramanian Department of Chemical and Biomolecular Engineering Clarkson University When fluid flow occurs in a single direction everywhere in a system, shell

More information

Numerical Simulation of the Hagemann Entrainment Experiments

Numerical Simulation of the Hagemann Entrainment Experiments CCC Annual Report UIUC, August 14, 2013 Numerical Simulation of the Hagemann Entrainment Experiments Kenneth Swartz (BSME Student) Lance C. Hibbeler (Ph.D. Student) Department of Mechanical Science & Engineering

More information

6.2 Governing Equations for Natural Convection

6.2 Governing Equations for Natural Convection 6. Governing Equations for Natural Convection 6..1 Generalized Governing Equations The governing equations for natural convection are special cases of the generalized governing equations that were discussed

More information

NUMERICAL INVESTIGATION OF THERMOCAPILLARY INDUCED MOTION OF A LIQUID SLUG IN A CAPILLARY TUBE

NUMERICAL INVESTIGATION OF THERMOCAPILLARY INDUCED MOTION OF A LIQUID SLUG IN A CAPILLARY TUBE Proceedings of the Asian Conference on Thermal Sciences 2017, 1st ACTS March 26-30, 2017, Jeju Island, Korea ACTS-P00786 NUMERICAL INVESTIGATION OF THERMOCAPILLARY INDUCED MOTION OF A LIQUID SLUG IN A

More information

Model Studies on Slag-Metal Entrainment in Gas Stirred Ladles

Model Studies on Slag-Metal Entrainment in Gas Stirred Ladles Model Studies on Slag-Metal Entrainment in Gas Stirred Ladles Anand Senguttuvan Supervisor Gordon A Irons 1 Approach to Simulate Slag Metal Entrainment using Computational Fluid Dynamics Introduction &

More information

Turbulence: Basic Physics and Engineering Modeling

Turbulence: Basic Physics and Engineering Modeling DEPARTMENT OF ENERGETICS Turbulence: Basic Physics and Engineering Modeling Numerical Heat Transfer Pietro Asinari, PhD Spring 2007, TOP UIC Program: The Master of Science Degree of the University of Illinois

More information

Complex Fluids. University of California - Santa Barbara, CA April 26, Abstract

Complex Fluids. University of California - Santa Barbara, CA April 26, Abstract Gravitational Effects on Structure Development in Quenched Complex Fluids V. E. Badalassi, a H. D. Ceniceros b and S. Banerjee c a,c Department of Chemical Engineering, b Department of Mathematics University

More information

Module 3: "Thin Film Hydrodynamics" Lecture 12: "" The Lecture Contains: Linear Stability Analysis. Some well known instabilities. Objectives_template

Module 3: Thin Film Hydrodynamics Lecture 12:  The Lecture Contains: Linear Stability Analysis. Some well known instabilities. Objectives_template The Lecture Contains: Linear Stability Analysis Some well known instabilities file:///e /courses/colloid_interface_science/lecture12/12_1.htm[6/16/2012 1:39:16 PM] Linear Stability Analysis This analysis

More information

CENG 501 Examination Problem: Estimation of Viscosity with a Falling - Cylinder Viscometer

CENG 501 Examination Problem: Estimation of Viscosity with a Falling - Cylinder Viscometer CENG 501 Examination Problem: Estimation of Viscosity with a Falling - Cylinder Viscometer You are assigned to design a fallingcylinder viscometer to measure the viscosity of Newtonian liquids. A schematic

More information

Simulation of a Pressure Driven Droplet Generator

Simulation of a Pressure Driven Droplet Generator Simulation of a Pressure Driven Droplet Generator V. Mamet* 1, P. Namy 2, N. Berri 1, L. Tatoulian 1, P. Ehouarn 1, V. Briday 1, P. Clémenceau 1 and B. Dupont 1 1 DBV Technologies, 2 SIMTEC *84 rue des

More information

Coarsening: transient and self-similar dynamics in 1-D

Coarsening: transient and self-similar dynamics in 1-D Coarsening: transient and self-similar dynamics in 1-D ½ 1 5 1 4 h ln(t) Ú ¼º N 1 3 N t 2/5 1 2 1 5 1 15 x ¼ 1 ¼ ¼º ½ 1 1 4 1 8 1 12 1 16 Ü t Michael Gratton (Northwestern) and Thomas Witelsi (Due) Cahn-Hilliard

More information

Investigation of an implicit solver for the simulation of bubble oscillations using Basilisk

Investigation of an implicit solver for the simulation of bubble oscillations using Basilisk Investigation of an implicit solver for the simulation of bubble oscillations using Basilisk D. Fuster, and S. Popinet Sorbonne Universités, UPMC Univ Paris 6, CNRS, UMR 79 Institut Jean Le Rond d Alembert,

More information

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Roy Stogner Computational Fluid Dynamics Lab Institute for Computational Engineering and Sciences University of Texas at Austin March

More information

The dynamics of small particles whose size is roughly 1 µmt or. smaller, in a fluid at room temperature, is extremely erratic, and is

The dynamics of small particles whose size is roughly 1 µmt or. smaller, in a fluid at room temperature, is extremely erratic, and is 1 I. BROWNIAN MOTION The dynamics of small particles whose size is roughly 1 µmt or smaller, in a fluid at room temperature, is extremely erratic, and is called Brownian motion. The velocity of such particles

More information

5.1 2D example 59 Figure 5.1: Parabolic velocity field in a straight two-dimensional pipe. Figure 5.2: Concentration on the input boundary of the pipe. The vertical axis corresponds to r 2 -coordinate,

More information

Formation and Long Term Evolution of an Externally Driven Magnetic Island in Rotating Plasmas )

Formation and Long Term Evolution of an Externally Driven Magnetic Island in Rotating Plasmas ) Formation and Long Term Evolution of an Externally Driven Magnetic Island in Rotating Plasmas ) Yasutomo ISHII and Andrei SMOLYAKOV 1) Japan Atomic Energy Agency, Ibaraki 311-0102, Japan 1) University

More information

2. FLUID-FLOW EQUATIONS SPRING 2019

2. FLUID-FLOW EQUATIONS SPRING 2019 2. FLUID-FLOW EQUATIONS SPRING 2019 2.1 Introduction 2.2 Conservative differential equations 2.3 Non-conservative differential equations 2.4 Non-dimensionalisation Summary Examples 2.1 Introduction Fluid

More information

Reduction of parasitic currents in the DNS VOF code FS3D

Reduction of parasitic currents in the DNS VOF code FS3D M. Boger a J. Schlottke b C.-D. Munz a B. Weigand b Reduction of parasitic currents in the DNS VOF code FS3D Stuttgart, March 2010 a Institut für Aerodynamik und Gasdynamik, Universität Stuttgart, Pfaffenwaldring

More information

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost Game and Media Technology Master Program - Utrecht University Dr. Nicolas Pronost Soft body physics Soft bodies In reality, objects are not purely rigid for some it is a good approximation but if you hit

More information

Spatial discretization scheme for incompressible viscous flows

Spatial discretization scheme for incompressible viscous flows Spatial discretization scheme for incompressible viscous flows N. Kumar Supervisors: J.H.M. ten Thije Boonkkamp and B. Koren CASA-day 2015 1/29 Challenges in CFD Accuracy a primary concern with all CFD

More information

Long-time behavior and different shear regimes in quenched binary mixtures

Long-time behavior and different shear regimes in quenched binary mixtures PHYSICAL REVIEW E 75, 011501 2007 Long-time behavior and different shear regimes in quenched binary mixtures G. Gonnella* Dipartimento di Fisica, Università di Bari, and INFN, Sezione di Bari, Via Amendola

More information

Monte Carlo Simulation of Ferroelectric Domain Structure: Electrostatic and Elastic Strain Energy Contributions

Monte Carlo Simulation of Ferroelectric Domain Structure: Electrostatic and Elastic Strain Energy Contributions Monte Carlo Simulation of Ferroelectric Domain Structure: Electrostatic and Elastic Strain Energy Contributions B.G. Potter, Jr., B.A. Tuttle, and V. Tikare Sandia National Laboratories Albuquerque, NM

More information

with deterministic and noise terms for a general non-homogeneous Cahn-Hilliard equation Modeling and Asymptotics

with deterministic and noise terms for a general non-homogeneous Cahn-Hilliard equation Modeling and Asymptotics 12-3-2009 Modeling and Asymptotics for a general non-homogeneous Cahn-Hilliard equation with deterministic and noise terms D.C. Antonopoulou (Joint with G. Karali and G. Kossioris) Department of Applied

More information

Generating cloud drops from CCN. Wallace & Hobbs (1977)

Generating cloud drops from CCN. Wallace & Hobbs (1977) Generating cloud drops from CCN Wallace & Hobbs (1977) Cloud Drops and Equilibrium Considera3ons: review We discussed how to compute the equilibrium vapor pressure over a pure water drop, or a solu3on

More information

Modeling of Multicomponent Reactive Systems

Modeling of Multicomponent Reactive Systems TECHNISCHE MECHANIK, 32, 2-5, (2012), 105 112 submitted: October 11, 2011 Modeling of Multicomponent Reactive Systems D. Anders, K. Weinberg In recent engineering applications reaction-diffusion systems

More information

Imploded Shell Parameter Estimation Based on Radiograph Analysis. George Liu. Pittsford Sutherland High School. LLE Advisor: Reuben Epstein

Imploded Shell Parameter Estimation Based on Radiograph Analysis. George Liu. Pittsford Sutherland High School. LLE Advisor: Reuben Epstein Imploded Shell Parameter Estimation Based on Radiograph Analysis George Liu Pittsford Sutherland High School LLE Advisor: Reuben Epstein Laboratory for Laser Energetics University of Rochester Summer High

More information

Numerical Simulation of Core- Annular Flow in a Curved Pipe

Numerical Simulation of Core- Annular Flow in a Curved Pipe Numerical Simulation of Core- Annular Flow in a Curved Pipe Simulation of two phase flow with OpenFOAM Report Number:2625(MEAH:277) Master of Science Thesis Process and Energy Numerical Simulation of

More information

Lattice Boltzmann Method Solver Documentation

Lattice Boltzmann Method Solver Documentation Lattice Boltzmann Method Solver Documentation Release 0.0.1 Sayop Kim May 03, 2016 Contents 1 Code Instruction 3 1.1 Quick instruction for running the simulation.............................. 3 2 Results

More information

Introduction to Heat and Mass Transfer. Week 10

Introduction to Heat and Mass Transfer. Week 10 Introduction to Heat and Mass Transfer Week 10 Concentration Boundary Layer No concentration jump condition requires species adjacent to surface to have same concentration as at the surface Owing to concentration

More information

arxiv: v1 [physics.comp-ph] 10 Aug 2015

arxiv: v1 [physics.comp-ph] 10 Aug 2015 Numerical experiments on the efficiency of local grid refinement based on truncation error estimates Alexandros Syrakos a,, Georgios Efthimiou a, John G. Bartzis a, Apostolos Goulas b arxiv:1508.02345v1

More information

Fluid Mechanics. Chapter 9 Surface Resistance. Dr. Amer Khalil Ababneh

Fluid Mechanics. Chapter 9 Surface Resistance. Dr. Amer Khalil Ababneh Fluid Mechanics Chapter 9 Surface Resistance Dr. Amer Khalil Ababneh Wind tunnel used for testing flow over models. Introduction Resistances exerted by surfaces are a result of viscous stresses which create

More information

Numerical simulation of wave breaking in turbulent two-phase Couette flow

Numerical simulation of wave breaking in turbulent two-phase Couette flow Center for Turbulence Research Annual Research Briefs 2012 171 Numerical simulation of wave breaking in turbulent two-phase Couette flow By D. Kim, A. Mani AND P. Moin 1. Motivation and objectives When

More information

An Introduction to Theories of Turbulence. James Glimm Stony Brook University

An Introduction to Theories of Turbulence. James Glimm Stony Brook University An Introduction to Theories of Turbulence James Glimm Stony Brook University Topics not included (recent papers/theses, open for discussion during this visit) 1. Turbulent combustion 2. Turbulent mixing

More information

The behaviour of high Reynolds flows in a driven cavity

The behaviour of high Reynolds flows in a driven cavity The behaviour of high Reynolds flows in a driven cavity Charles-Henri BRUNEAU and Mazen SAAD Mathématiques Appliquées de Bordeaux, Université Bordeaux 1 CNRS UMR 5466, INRIA team MC 351 cours de la Libération,

More information

Heat and Mass Transfer Prof. S.P. Sukhatme Department of Mechanical Engineering Indian Institute of Technology, Bombay

Heat and Mass Transfer Prof. S.P. Sukhatme Department of Mechanical Engineering Indian Institute of Technology, Bombay Heat and Mass Transfer Prof. S.P. Sukhatme Department of Mechanical Engineering Indian Institute of Technology, Bombay Lecture No. 18 Forced Convection-1 Welcome. We now begin our study of forced convection

More information

APPRAISAL OF FLOW SIMULATION BY THE LATTICE BOLTZMANN METHOD

APPRAISAL OF FLOW SIMULATION BY THE LATTICE BOLTZMANN METHOD APPRAISAL OF FLOW SIMULATION BY THE LATTICE BOLTZMANN METHOD Guillermo Izquierdo Bouldstridge Imperial College of London Department of Aeronautics Master s Thesis Supervisor: Dr. Joaquim Peiró September

More information

Nonlinear Wave Theory for Transport Phenomena

Nonlinear Wave Theory for Transport Phenomena JOSO 2016 March 9-11 2015 Nonlinear Wave Theory for Transport Phenomena ILYA PESHKOV CHLOE, University of Pau, France EVGENIY ROMENSKI Sobolev Institute of Mathematics, Novosibirsk, Russia MICHAEL DUMBSER

More information

Absorption of gas by a falling liquid film

Absorption of gas by a falling liquid film Absorption of gas by a falling liquid film Christoph Albert Dieter Bothe Mathematical Modeling and Analysis Center of Smart Interfaces/ IRTG 1529 Darmstadt University of Technology 4th Japanese-German

More information

Application of Chimera Grids in Rotational Flow

Application of Chimera Grids in Rotational Flow CES Seminar Write-up Application of Chimera Grids in Rotational Flow Marc Schwalbach 292414 marc.schwalbach@rwth-aachen.de Supervisors: Dr. Anil Nemili & Emre Özkaya, M.Sc. MATHCCES RWTH Aachen University

More information

Isogeometric Analysis of the Navier Stokes Cahn Hilliard equations with application to incompressible two-phase flows

Isogeometric Analysis of the Navier Stokes Cahn Hilliard equations with application to incompressible two-phase flows Isogeometric Analysis of the Navier Stokes Cahn Hilliard equations with application to incompressible two-phase flows Babak S. Hosseini 1, Stefan Turek 1, Matthias Möller 2 1 TU Dortmund University, Institute

More information

MODENA. Deliverable 3.2. WP s leader: TU/e. Simulations for foams, dispersion and mixing and developed SW. Principal investigator:

MODENA. Deliverable 3.2. WP s leader: TU/e. Simulations for foams, dispersion and mixing and developed SW. Principal investigator: Delivery date: 11-4-2015 MODENA Authors: Patrick Anderson, Martien Hulsen, Christos Mitrias TU/e E-mail : pda@tue.nl Deliverable 3.2 Simulations for foams, dispersion and mixing and developed SW Daniele

More information

An evaluation of a conservative fourth order DNS code in turbulent channel flow

An evaluation of a conservative fourth order DNS code in turbulent channel flow Center for Turbulence Research Annual Research Briefs 2 2 An evaluation of a conservative fourth order DNS code in turbulent channel flow By Jessica Gullbrand. Motivation and objectives Direct numerical

More information

CHAPTER 11: REYNOLDS-STRESS AND RELATED MODELS. Turbulent Flows. Stephen B. Pope Cambridge University Press, 2000 c Stephen B. Pope y + < 1.

CHAPTER 11: REYNOLDS-STRESS AND RELATED MODELS. Turbulent Flows. Stephen B. Pope Cambridge University Press, 2000 c Stephen B. Pope y + < 1. 1/3 η 1C 2C, axi 1/6 2C y + < 1 axi, ξ > 0 y + 7 axi, ξ < 0 log-law region iso ξ -1/6 0 1/6 1/3 Figure 11.1: The Lumley triangle on the plane of the invariants ξ and η of the Reynolds-stress anisotropy

More information

Entropy generation and transport

Entropy generation and transport Chapter 7 Entropy generation and transport 7.1 Convective form of the Gibbs equation In this chapter we will address two questions. 1) How is Gibbs equation related to the energy conservation equation?

More information

CHAPTER V. Brownian motion. V.1 Langevin dynamics

CHAPTER V. Brownian motion. V.1 Langevin dynamics CHAPTER V Brownian motion In this chapter, we study the very general paradigm provided by Brownian motion. Originally, this motion is that a heavy particle, called Brownian particle, immersed in a fluid

More information

1.3 Molecular Level Presentation

1.3 Molecular Level Presentation 1.3.1 Introduction A molecule is the smallest chemical unit of a substance that is capable of stable, independent existence. Not all substances are composed of molecules. Some substances are composed of

More information

TABLE OF CONTENTS CHAPTER TITLE PAGE

TABLE OF CONTENTS CHAPTER TITLE PAGE v TABLE OF CONTENTS CHAPTER TITLE PAGE TABLE OF CONTENTS LIST OF TABLES LIST OF FIGURES LIST OF SYMBOLS LIST OF APPENDICES v viii ix xii xiv CHAPTER 1 INTRODUCTION 1.1 Introduction 1 1.2 Literature Review

More information

Spinodal decomposition

Spinodal decomposition Part V. Solid-solid transformations II Module 1 : Spinodal decomposition Part V. Solid-solid transformations II In this part, we discuss two transformations namely spinodal decomposition and ordering.

More information

Chapter 7. Three Dimensional Modelling of Buoyancy-Driven Displacement Ventilation: Point Source

Chapter 7. Three Dimensional Modelling of Buoyancy-Driven Displacement Ventilation: Point Source Chapter 7 Three Dimensional Modelling of Buoyancy-Driven Displacement Ventilation: Point Source 135 7. Three Dimensional Modelling of Buoyancy- Driven Displacement Ventilation: Point Source 7.1 Preamble

More information

Part IV: Numerical schemes for the phase-filed model

Part IV: Numerical schemes for the phase-filed model Part IV: Numerical schemes for the phase-filed model Jie Shen Department of Mathematics Purdue University IMS, Singapore July 29-3, 29 The complete set of governing equations Find u, p, (φ, ξ) such that

More information

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Soft-Body Physics Soft Bodies Realistic objects are not purely rigid. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Deformed

More information

5. FVM discretization and Solution Procedure

5. FVM discretization and Solution Procedure 5. FVM discretization and Solution Procedure 1. The fluid domain is divided into a finite number of control volumes (cells of a computational grid). 2. Integral form of the conservation equations are discretized

More information

Mush liquid interfaces with cross flow

Mush liquid interfaces with cross flow Mush liquid interfaces with cross flow Devin Conroy March 15, 27 1 Introduction The solidification of a binary melt growing into a supercooled region may lead to the formation of a mushy layer as a result

More information

Level Set and Phase Field Methods: Application to Moving Interfaces and Two-Phase Fluid Flows

Level Set and Phase Field Methods: Application to Moving Interfaces and Two-Phase Fluid Flows Level Set and Phase Field Methods: Application to Moving Interfaces and Two-Phase Fluid Flows Abstract Maged Ismail Claremont Graduate University Level Set and Phase Field methods are well-known interface-capturing

More information

Simulation analysis using CFD on vibration behaviors of circular cylinders subjected to free jets through narrow gaps in the vicinity of walls

Simulation analysis using CFD on vibration behaviors of circular cylinders subjected to free jets through narrow gaps in the vicinity of walls Fluid Structure Interaction V 85 Simulation analysis using CFD on vibration behaviors of circular cylinders subjected to free jets through narrow gaps in the vicinity of walls K. Fujita Osaka City University,

More information

A combined application of the integral wall model and the rough wall rescaling-recycling method

A combined application of the integral wall model and the rough wall rescaling-recycling method AIAA 25-299 A combined application of the integral wall model and the rough wall rescaling-recycling method X.I.A. Yang J. Sadique R. Mittal C. Meneveau Johns Hopkins University, Baltimore, MD, 228, USA

More information

Exercise: concepts from chapter 10

Exercise: concepts from chapter 10 Reading:, Ch 10 1) The flow of magma with a viscosity as great as 10 10 Pa s, let alone that of rock with a viscosity of 10 20 Pa s, is difficult to comprehend because our common eperience is with s like

More information

We may have a general idea that a solid is hard and a fluid is soft. This is not satisfactory from

We may have a general idea that a solid is hard and a fluid is soft. This is not satisfactory from Chapter 1. Introduction 1.1 Some Characteristics of Fluids We may have a general idea that a solid is hard and a fluid is soft. This is not satisfactory from scientific or engineering point of view. In

More information

Particle resuspension

Particle resuspension 86 Chapter 6 Particle resuspension 6.1 Motivation In previous chapters, the relative effective viscosity of a flow with particles denser than the interstitial liquid was discussed. Such results show that

More information

Development of a Parallel, 3D, Lattice Boltzmann Method CFD Solver for Simulation of Turbulent Reactor Flow

Development of a Parallel, 3D, Lattice Boltzmann Method CFD Solver for Simulation of Turbulent Reactor Flow DOE-FIU SCIENCE & TECHNOLOGY WORKFORCE DEVELOPMENT PROGRAM STUDENT SUMMER INTERNSHIP TECHNICAL REPORT June 4, 2012 to August 10, 2012 Development of a Parallel, 3D, Lattice Boltzmann Method CFD Solver

More information

Two Dimensional Orbital Mixing for a Fluid. Written by Shawn Lillie Supervised by Dr. Bruce Finlayson

Two Dimensional Orbital Mixing for a Fluid. Written by Shawn Lillie Supervised by Dr. Bruce Finlayson Two Dimensional Orbital Mixing for a Fluid Written by Shawn Lillie Supervised by Dr. Bruce Finlayson University of Washington Department of Chemical Engineering Undergraduate Research December 13, 2006

More information

Overview of Tokamak Rotation and Momentum Transport Phenomenology and Motivations

Overview of Tokamak Rotation and Momentum Transport Phenomenology and Motivations Overview of Tokamak Rotation and Momentum Transport Phenomenology and Motivations Lecture by: P.H. Diamond Notes by: C.J. Lee March 19, 2014 Abstract Toroidal rotation is a key part of the design of ITER

More information

Fundamentals of Fluid Dynamics: Elementary Viscous Flow

Fundamentals of Fluid Dynamics: Elementary Viscous Flow Fundamentals of Fluid Dynamics: Elementary Viscous Flow Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Institute of Fundamental Technological Research

More information

Diffusive Transport Enhanced by Thermal Velocity Fluctuations

Diffusive Transport Enhanced by Thermal Velocity Fluctuations Diffusive Transport Enhanced by Thermal Velocity Fluctuations Aleksandar Donev 1 Courant Institute, New York University & Alejandro L. Garcia, San Jose State University John B. Bell, Lawrence Berkeley

More information

Differential relations for fluid flow

Differential relations for fluid flow Differential relations for fluid flow In this approach, we apply basic conservation laws to an infinitesimally small control volume. The differential approach provides point by point details of a flow

More information

INFLUENCE OF AN APPLIED STRAIN FIELD ON MICROSTRUCTURAL EVOLUTION DURING THE α 2 O- PHASE TRANSFORMATION IN Ti Al Nb SYSTEM

INFLUENCE OF AN APPLIED STRAIN FIELD ON MICROSTRUCTURAL EVOLUTION DURING THE α 2 O- PHASE TRANSFORMATION IN Ti Al Nb SYSTEM Acta mater. 49 (2001) 13 20 www.elsevier.com/locate/actamat INFLUENCE OF AN APPLIED STRAIN FIELD ON MICROSTRUCTURAL EVOLUTION DURING THE α 2 O- PHASE TRANSFORMATION IN Ti Al Nb SYSTEM Y. H. WEN 1, 2 *,

More information

Similarities and differences:

Similarities and differences: How does the system reach equilibrium? I./9 Chemical equilibrium I./ Equilibrium electrochemistry III./ Molecules in motion physical processes, non-reactive systems III./5-7 Reaction rate, mechanism, molecular

More information

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers Applied and Computational Mathematics 2017; 6(4): 202-207 http://www.sciencepublishinggroup.com/j/acm doi: 10.11648/j.acm.20170604.18 ISSN: 2328-5605 (Print); ISSN: 2328-5613 (Online) A Robust Preconditioned

More information

Coarsening process in the 2d voter model

Coarsening process in the 2d voter model Alessandro Tartaglia (LPTHE) Coarsening in the 2d voter model May 8, 2015 1 / 34 Coarsening process in the 2d voter model Alessandro Tartaglia LPTHE, Université Pierre et Marie Curie alessandro.tartaglia91@gmail.com

More information

Introduction to Mass Transfer

Introduction to Mass Transfer Introduction to Mass Transfer Introduction Three fundamental transfer processes: i) Momentum transfer ii) iii) Heat transfer Mass transfer Mass transfer may occur in a gas mixture, a liquid solution or

More information

Computation for the Backward Facing Step Test Case with an Open Source Code

Computation for the Backward Facing Step Test Case with an Open Source Code Computation for the Backward Facing Step Test Case with an Open Source Code G.B. Deng Equipe de Modélisation Numérique Laboratoire de Mécanique des Fluides Ecole Centrale de Nantes 1 Rue de la Noë, 44321

More information

Phenomenological Theories of Nucleation

Phenomenological Theories of Nucleation Chapter 1 Phenomenological Theories of Nucleation c 2012 by William Klein, Harvey Gould, and Jan Tobochnik 16 September 2012 1.1 Introduction These chapters discuss the problems of nucleation, spinodal

More information

A marks are for accuracy and are not given unless the relevant M mark has been given (M0 A1 is impossible!).

A marks are for accuracy and are not given unless the relevant M mark has been given (M0 A1 is impossible!). NOTES 1) In the marking scheme there are three types of marks: M marks are for method A marks are for accuracy and are not given unless the relevant M mark has been given (M0 is impossible!). B marks are

More information

Computing the effective diffusivity using a spectral method

Computing the effective diffusivity using a spectral method Materials Science and Engineering A311 (2001) 135 141 www.elsevier.com/locate/msea Computing the effective diffusivity using a spectral method Jingzhi Zhu a, *, Long-Qing Chen a, Jie Shen b, Veena Tikare

More information

Table of Contents. Foreword... xiii. Preface... xv

Table of Contents. Foreword... xiii. Preface... xv Table of Contents Foreword.... xiii Preface... xv Chapter 1. Fundamental Equations, Dimensionless Numbers... 1 1.1. Fundamental equations... 1 1.1.1. Local equations... 1 1.1.2. Integral conservation equations...

More information

Rheometry. II.1 Introduction

Rheometry. II.1 Introduction II Rheometry II.1 Introduction Structured materials are generally composed of microstructures dispersed in a homogeneous phase [30]. These materials usually have a yield stress, i.e. a threshold stress

More information

CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION

CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION 7.1 THE NAVIER-STOKES EQUATIONS Under the assumption of a Newtonian stress-rate-of-strain constitutive equation and a linear, thermally conductive medium,

More information

Available online at ScienceDirect. Procedia Engineering 90 (2014 )

Available online at   ScienceDirect. Procedia Engineering 90 (2014 ) Available online at www.sciencedirect.com ScienceDirect Procedia Engineering 9 (214 ) 599 64 1th International Conference on Mechanical Engineering, ICME 213 Validation criteria for DNS of turbulent heat

More information

Project #1 Internal flow with thermal convection

Project #1 Internal flow with thermal convection Project #1 Internal flow with thermal convection MAE 494/598, Fall 2017, Project 1 (20 points) Hard copy of report is due at the start of class on the due date. The rules on collaboration will be released

More information

Lecture 1: Atomic Diffusion

Lecture 1: Atomic Diffusion Part IB Materials Science & Metallurgy H. K. D. H. Bhadeshia Course A, Metals and Alloys Lecture 1: Atomic Diffusion Mass transport in a gas or liquid generally involves the flow of fluid (e.g. convection

More information