• Nie Znaleziono Wyników

A parallel finite element method for two-phase flows

N/A
N/A
Protected

Academic year: 2021

Share "A parallel finite element method for two-phase flows"

Copied!
20
0
0

Pełen tekst

(1)

c

TU Delft, The Netherlands, 2006

A PARALLEL FINITE ELEMENT METHOD FOR

TWO-PHASE FLOWS

Michele Giordano∗†, Aldo Bonfiglioli∗ and Vinicio Magi∗

Universit`a degli Studi della Basilicata, DIFA

Via dell’Ateneo Lucano, Potenza, 85100, Italy

CASPUR,

Via dei Tizii 6/b, Roma, 00185, Italy

e-mail: mgiordano@unibas.it, bonfiglioli@unibas.it, magi@unibas.it

Key words: Finite Element Methods, SUPG, Two-Phase Flows, Parallel Implementation Abstract. A parallel finite element model for incompressible laminar two-phase flows is presented. A two-fluid model, describing the laminar non-equilibrium flow of two in-compressible phases, is discretized by means of a properly designed Streamline Upwind Petrov-Galerkin (SUPG) finite element procedure. Such a procedure is consistent with a continuous pressure equation. The design and the implementation of the algorithm are presented together with its validation throughout a comparison with simulations available in literature.

1 INTRODUCTION

The aim of this paper is to present some results on the application of a finite element methodology to the two-phase flows. Both, the mathematical modeling of the flow and the numerical discretization adopted are cosidered to be interesting for the reader, so that they are discussed in details.

(2)

to turbulences and to the motions of the interfaces. The first effect causes complicated coupling between the field equations of each phase and the interfacial conditions, whereas the second effect introduces statistical characteristics originating from the instability of the NS equations. Since these difficulties exist in almost all two-phase flow systems, an application of the local instant formulation to obtain a solution is very limited.

A method of averaging the local instant formulation is followed in practise. The av-eraging procedure is basically low pass filtering that eliminates unwanted high frequency signals from local instant fluctuations. Only the macroscopic and statistical effects appear in the averaged equations. Instead of considering local instant transfers at the interface, collective interactions between the phases are considered in a macroscopic two-phase flow formulation. Averaging procedures can be classified into three main groups: Eulerian, Lagrangian and Boltzmann statistical averages. In the Eulerian average, the time and space coordinates are taken as the independet variables and the averaging is done with respect to these variables. Lagrangian averages are directly related to the Lagrangian description of mechanics. The particle coordinate replaces the space coordinate, respect to the Eulerian approach, and averages are performed along particle trajectories. The Boltzmann statiscal averaging is based on the introduction of a probability density func-tion, described by the Boltzmann transport equafunc-tion, which plays a weighting role in the integration of the istantaneous values to obtain the averages of the dependent variables. Averaging results in macroscopic field equations for the mass, momentum and energy of each phase with coupling between the phases through appropriate terms. Closure relations are needed to model these interface transport terms.

Here the incompressibility constraint is considered for both phases, such that the energy conservation equations are not solved. Moreover a two-fluid model is used: this means that an Eulerian approach for both phases is adopted, and the tracking of individuals particles is avoided, but transport properties for the dispersed phase are defined. This approach is considered to be appropriate for the most general and detailed description of two-phase flows and represents a fair compromise between the complexity of the model and its suitability to the physics of the problem. Being an averaged model, it describes the two-phase system from a macroscopic point of view, allowing a more engineering oriented analysis. On the other hand, as said before, the averaging process leads to the loss of the information related to the heterogeneous structure of the flow and to a blurring of the material properties. In particular, the two-fluid model describes the flow as the combination of two interpenetrating continua, where the interactions between the two phases are described through ad hoc built forces and parameters.

(3)

functions. In the design of the stabilizing parameters, a common criterium has been used, i.e. the numerical discretization adopted to be consistent to the analogous finite element approach for incompressible single-phase flows. Hence, an extension of the SUPG method used for solving the single-phase NS equations is applied to the two-phase flow equations, and similarly to the single-phase flow the problem is written in terms of of the primitive variables. Since the system of equations is not symmetric, a straight-forward direction to be followed has not been traced in the SUPG frame, and the idea of maintaining such a consistency greatly helps in the design of the intrinsic time scales. In order to achieve a fair level of stabilization, a discontinuity capturing operator is introduced in order to prevent oscillations in boundary and sharp layer regions.

Due to the big amount of computations needed to perform a two-phase flow simulation, a parallelization strategy has been pursuit. Through the use of the MPI protocol and the free PETSc library [8], the code has been transposed from its first serial to its definitive parallel version.

In the following, the governing equations describing the two-phase flow and the stabi-lized finite element approach are given. Then, the parallelization process is shown, and some test cases to validate the proposed methodology are shown. Finally, conclusions are drawn.

2 TWO PHASE FLOW MODEL

The governing equations of the two-phase flow are presented in this section. In par-ticular, the two-fluid model adopted in this paper is discussed and displayed in its main faetures.

2.1 Basic Concepts

The chosen model is an Eulerian-Eulerian one [1], since both phases are treated as continua. Moreover, a pressure equilibrium between the phases is assumed, leading to the following relation:

pl = pg = p (1)

where p is the pressure, and the subscripts l and g are referred to as the primary and the secondary phases, respectively.

Since the phases are considered as interpenetrating, non-mixing continua, each of them occupies a well-defined volume of space. The volume Vq of the generic phase q is defined

by

Vq =

Z

αqdΩ (2)

where αq is the phasic volume fraction, representing the volume fraction occupied by the

(4)

relation:

αg+ αl = 1 (3)

Equation (3) represents the fundamental constitutive law for the volume fractions.

2.2 Mass Conservation

The two-fluid model must guarantee the conservation of mass. This is achieved writing the conservation equations for each phase. Referring to the continuity equation of the generic phase q, with the hypothesis of incompressibility, one can write:

∂αq

∂t + ∇ · (αq~uq) = 0 (4)

where ρq and ~uq are the density and the velocity of the phase, respectively.

2.3 Momentum Conservation

The two-phase flow model must guarantee the conservation of momentum as well. The momentum balance for the generic phase q, without body forces, yields

∂~uq

∂t + ~uq· ∇~uq = ~Fp,q+ ~Fv,q+ ~Fd,q (5) where ~Fp,q is representative of the pressure contribution, ~Fv,q of the viscous force, and ~Fd,q

of the drag force, i.e. the interaction between the phases. The pressure and the viscous force contribution are given by

~ Fp,q = − 1 ρq ∇p F~v,q = 1 ρqαq ∇ · αqτq  (6) where the stress tensor is written as

τq = µq ∇~uq+ ∇~uTq



(7) where µq is the shear viscosity and the superscript T denotes the transpose of ∇~uq.

Referring to the primary phase l and to the secondary phase g, the drag force [1, 9] can be written as ~ Fd,l= 3 4 CD dgρl αgρ|~ug− ~ul| (~ug− ~ul) (8) ~ Fd,g = 3 4 CD dgρg αlρ|~ul− ~ug| (~ul− ~ug) (9)

where CD is the drag coefficient, dg is the diameter of the bubbles of the secondary phase

and ρ is the mixture density defined as

(5)

2.4 System of Equations

Referring to the primary phase as l and to the secondary phase as g, the set of unknowns is given by the primitive variables

U = (p ul vl αg ug vg)T (11)

Hence, the final system of equations consists of six equations: since it appears logic to cal-culate velocities and volume fractions from the momentum and the continuity equations, respectively, the fundamental point is the assignment of the equation for the pressure. The chosen equation, obtained from the conservation of the total volume (P

q=l,gαq = 1)

applied to the mass conservation equations, reads X

q=l,g

∇ · (αq~uq) = 0 (12)

In this equation, the artificial compressibility formulation is used, i.e. a pressure time derivative is introduced to enhance robustness for steady state simulations [10]. Hence, the re-arranged equation for the pressure computation is

1 ρc2

∂p

∂t + ∇ · ((1 − αg)~ul) + ∇ · (αg~ug) = 0 (13) where c is a reference velocity and ρ is the mixture density.

3 FINITE ELEMENT APPROACH

The discretization of the governing equations is done through a Galerkin finite element approach with P 1 basis functions for all the variables [11]. This means piecewise linear functions are used both for the basis and the weighting functions and the domain is discretized into triangles. In addition, a Petrov-Galerkin stabilization is employed.

3.1 Galerkin Formulation

The governing equations can be written as a system of equations in terms of the chosen set of variables U

L(U ) = A0U,t+ Fadvi,i − F dif f

i,i = S (14)

where Fadv

i,i = AiU,i is the advective contribution, Fdif fi,i is the diffusive (pressure and

viscous term) contribution, and S represents the source term.

Introducing the trial solution space Vh, and the weighting solution space Wh, the weak

form of (14) reads as find U ∈ Vh such that ∀ W ∈ Wh

Z

(W · A0U,t+ W · Fadvi,i + W,i· Fdif fi − W · S) dΩ

− Z

Γ

(W · Fdif fi ) nidΓ = 0 (15)

where Ω is the spatial domain, Γ represents its boundaries and ni is a component of the

(6)

3.2 SUPG Formulation

The stabilization is obtained following a Streamline Upwind Petrov-Galerkin procedure applied to advection-diffusion systems. The new integral equation is

Z

(W · A0U,t+ W · Fadvi,i + W,i· Fdif fi − W · S) dΩ

− Z Γ (W · Fdif fi ) nidΓ + STsupg = 0 (16) where STsupg = nel X e=1 Z Ωe AT iW,i· τ (L(U ) − S)dΩ (17)

In the above formula Ωe is one of the nel elements in which the domain is divided, and τ

represents the matrix of the intrinsic time scales of the stabilizing operator. The choice of τ is cumbersome. In this work a simple diagonal matrix is used

τ = diag(τp, τml, τml, τα, τmg, τmg) (18) The values of the τ ’s are obtained by applying the one-dimensional theory to each equa-tion. Specifically, the values available in the literature [6, 7, 11] are considered and re-arranged for this methodology.

In particular, the time scale for the secondary-phase momentum equation is chosen as: τmg =

αghg

2||~ug||

ζ Rehg (19)

where h is the element length in the direction of the local flow, ~ug the local advection

velocity, Rehg the element Reynolds number based on the element length and ζ a function of Rehg. Their definitions are

Rehg = hg||~ug|| 2νg (20) ζ = max  0, min Re hg 3 , 1  (21) hg = 2 P3 i=1| ~ug ||~ug|| · ∇w ~ ug i | (22) where the summation is performed for all the nodes of the element and w~ug

i are the

weighting functions associated to the secondary phase velocity.

Similarly, the time scale for the primary-phase momentum equation is chosen as: τml =

(1 − αg)hl

2||~ul||

(7)

with Rehl = hl||~ul|| 2νl (24) hl = 2 P3 i=1| ~ ul ||~ul|| · ∇w ~ ul i | (25) In this work, the evaluation of τp hs not been considered, since zero matrix entries

corre-spond to the time scale related to the pressure equation residual in the SUPG framework. Finally, the expression of τα will be given in the next subsection.

3.3 Stabilization of the Continuity Equation

The key point of the proposed finite element approach concerns with the stabilization of the continuity equation.

Let us consider Eq.(4) written in terms of αg

∂αg

∂t + ~ug· ∇αg+ (∇ · ~ug) αg = 0 (26)

which is a scalar advection-reaction equation, where ~ug is the advection velocity and ∇·~ug

the reaction source. Then, the choice of the time scale τα follows the analogous choice of

the scalar advection-reaction equation given in ref. [12] τα =

C1 2||~ug||

hg + C2|∇ · ~ug|

(27) where C1 and C2 are constants set through numerical tests. Suggested values, to prevent

adding too much numerical viscosity, are C1 = 0.5 and C2= 12.

Moreover, in order to prevent oscillations in the boundary layer region, a discontinuity capturing operator [6] is introduced for the continuity equation. The scalar weighting function referred to αg is increased in the following way

˜ wα i = w α i + τα~ug· ∇wαi + τα2~ug||· ∇w α i (28)

with the last term representing the contribution coming from the discontinuity capturing operator. The definitions for ~ug|| and τα2 are

(8)

with τα|| = C1 2||~ug|||| hg|| + C2|∇ · ~ug| (31) From their definitions, ~ug|| is the component of ~ug in the direction of the αg gradient, and

τα2 is the extra-amount of the time scale in the ~ug|| direction. In the above formulas, hg|| is computed from ~ug|| and it is equal to

hg|| = 2 P3 i=1| ~ ug|| ||~ug||||· ∇w ~ ug i | (32)

4 REMARKS ON THE STABILIZATION METHOD

In this section, further details of the stabilization technique are given. The main idea is to prove it acts consistently with a PSPG-SUPG stabilization criterium used for the incompressible NS equations, in the case P1 linear interpolation functions and Galerkin approach are employed, so successfully circumventing the so-called Babu´ska-Brezzi (BB) condition [5, 13, 14].

4.1 Navier-Stokes Equations

The traditional stabilization method for a Galerkin finite element discretization of the incompressible NS equations is the so-called PSPG (Petrov-Galerkin Pressure Stabiliza-tion) stabilization for the continuity equation and SUPG stabilization for the momentum equation.

This method consists by adding the following stabilizing terms to the integral formu-lation of the continuity and momentum equations

SP SP G= X e Z Ωe (τP SP G∇wip) · ~r h momdΩe (33) SSU P G = X e Z Ωe τSU P G~uh· ∇wi~u ~r h momdΩe (34) where ~rh

mom is the residual of the discrete momentum equation, τP SP G and τSU P G are the

appropriate PSPG and SUPG time scales, and wip and w~u

i are the weighting functions

associated to the pressure and the velocity.

The same kind of stabilization is obtained when the SUPG formula (16) for a system of equations is applied to the NS equations. This is done by writing the equations in terms of the primitive variable and choosing the following τ matrix

(9)

with τP SP G= τSU P G= τm.

Infact, if we write the NS equations in the primitive variables U

U = ( p u v )T, (36)

the corresponding Euler Jacobian matrices Ax and Ay are

A x =   0 0 0 0 u 0 0 0 u   Ay =   0 0 0 0 v 0 0 0 v   . (37)

Since the stabilizing terms are given by equation (17): STsupg = nel X e=1 Z Ωe AT iW,i· τ (L(U ) − S)dΩ , (38)

it comes out that, with the above definition of the τ matrix,

STsupg= SP SP G+ SSU P G. (39)

4.2 Two-Fluid Model

Similarly, also for teh two-fluid model the SUPG term depends from the Euler Jacobian matrices Ai, with Fadvi,i = AiU,i. The two matrices Ax and Ay specifically are

A x =         0 1 − αg 0 ug− ul αg 0 0 ul 0 0 0 0 0 0 ul 0 0 0 0 0 0 ug αg 0 0 0 0 0 ug 0 0 0 0 0 0 ug         A y=         0 0 1 − αg vg − vl 0 αg 0 vl 0 0 0 0 0 0 vl 0 0 0 0 0 0 vg 0 αg 0 0 0 0 vg 0 0 0 0 0 0 vg         (40) Introducing Ax and Ay in Eq. (17), the stabilizing terms to be added to each equation

are obtained.

In particular, the stabilizing term for the momentum equation of the generic phase q is equal to Smq = X e Z Ωe  τmq~uhq · ∇w ~ uq i  ~rh mqdΩe (41) where ~rh

mq is the residual of the discrete q-phase momentum equation. It is clear that the

obtained stabilization term has the same espression as the one used in the momentum equation of the NS equations.

(10)

+X e Z Ωe τα(~uhg − ~u h l) · ∇w p ir h αdΩe (42) where ~rh

ml is the residual of the discrete momentum equation of the primary phase, ~r h mg

the residual of the discrete momentum equation of the secondary phase, and ~rh

α is the

residual of the continuity equation for αg. When the flow reduces to single-phase flow,

αg = 0 and its residual vanishes, so that the stabilizing term is equal to the PSPG term

in equation (33).

5 PARALLELIZATION STRATEGY

Parallelization of flow solvers offers the possibility of achieving computational speeds that are many times faster than the single-processor computation. To enhance this goal, an efficient parallel algorithm has to be implemented. In the following some details on the parallel algorithm through the use of PETSc are shown, and the evaluation of the parallelization based on the actual speed up is presented.

5.1 Use of PETSc

Starting from the mesh, already partitioned in a certain number of subdomain, each processor reads the informations corresponding to the partition of the domain assigned, and in particular the local connectivity. So, it has to be intended that most of computation runs at a local level, while only when needed communication between the processes is used. Great attention must be paid in the introduction of the mapping relating the local indexing of the nodes to the global one, since it makes possible to share informations from different processes, and in the treatment of the ghost nodes (Fig. 1-a). Both istances rely in the introduction of the so-called ghost vector (Fig. 1-b), defined in PETSc. This vector is defined such that it has a local and a global representation. In the local representation, the vector is made of a certain number of positions corresponding to the local internal nodes, and of a number of positions corresponding to those nodes, the ghost nodes, belonging, at least, to one element of the local subdomain. All the ghost positions are located at the end of the vector. In the global representation, each local position is translated into a global one through an appropriate mapping, and to each ghost node position corresponds only one global position. Thanks to the introduction of these ghost vectors, the communication between different processes is made possible by switching between local and global representation of the vector and between local and global mapping. Similarly, it is possible to introduce a local and a global representation for the matrices.

The entire parallellization process can be split into three main computational components: • construction of residual vector and mass matrix defining the problem, by means of

ghost vector and mapping;

(11)

(a)

Mapping

Global

Local Internal Ghost

(b)

Figure 1: Parallelization - detail of the ghost node region (a) and ghost vector in PETSc (b).

• solution of the preconditioned system.

Note the last two items are handled internally by the PETSc library.

5.2 Speed Up

The parallel performance of the present method is measured here in terms of speed up (computational time of Nproc processors divided by that of one processor) and efficiency

(speed up divided by Nproc).

In order to determine these parameters the test case described in Subsection 6.1 has been computed on a Beowulf HP Linux Cluster at the University of Basilicata. A crucial point in the determination of the speed up is the choice of the computational mesh, since it has to guarantee that a large number of nodes has to be assigned to each processor, respect to the number of ghost nodes. This is to ensure that the computation time is significantly larger than the time spent in the communication between processes.

The case considered is two-dimensional with a grid made of 67168 elements and 33965 nodes, which is enough refined for effective parallelization on a large number of processors. The computation has been performed till full convergence, starting from a single processor to 16 nodes.

The speed up obtained for the different number of processors is shown, as plot and table, in Fig. 2 (a) and (c). The results relative to 2 and 4 processors are reasonable, but they start to tail off for larger numbers, as easily predictable. On Fig. 2-(b) the speed up with Nproc relative to Nproc/2 processors is reported: it shows how, increasing the number of

(12)

Number of Processors P ar al le lS pe ed U p 0 4 8 12 16 0 4 8 12 16 Actual Speed Up Linear Speed Up (a) Nproc 1 2 4 8 16 Rel. Speed Up - 1.91 1.83 1.78 1.58 (b)

Nproc Nnod/Nproc Speed Up Efficiency

1 33965 1.00 1.00 2 16982 1.91 0.95 4 8491 3.50 0.87 8 4245 6.22 0.78 16 2122 9.80 0.61 (c)

Figure 2: Parallelization - plot of the actual speed up (a), and tables of relative (c) and absolute speed up and efficiency (c).

6 NUMERICAL RESULTS

In this section, the results of the numerical simulation of the two-phase, laminar, steady flows in a channel and in a T-junction, already done with a serial code in [16], but here done with a parallel version, are presented.

6.1 Two-Phase Flow in a Channel

The first test case concerns with the two-dimensional two-phase laminar flow in a channel. Nevertheless this example presents a relatively simple geometry, the presence of the two phases renders the flow much more complex than the single phase one. In the present computations, no interactions between the two phases are considered (i.e. zero drag force).

The simulation is done by giving the velocity at the inlet and setting uniform pressure at the outlet. The pressure at the inlet comes from the computation. The other boundaries are treated as no-slip walls. The chosen inlet velocity profile is set to be uniform. The geometry is shown in Fig. 3. The Reynolds number is defined as

Re = ud

ν (43)

(13)

     

Inlet

Outlet

3d d

Figure 3: Two-phase flow in a channel - geometry.

Reynolds Number Re1 = 100 Re2 = 100

Kinematic Viscosity µ1 = 0.01 µ2 = 0.005

Density ρ1 = 1.0 ρ2 = 0.5

Inlet Volume Fraction α1 = 0.5 α2 = 0.5

Table 1: Two-phase flow in a channel - physical properties.

Different grids are considered: the coarsest grid consists of 1699 nodes and 3236 ele-ments, and the finest one consists of 33965 nodes and 67168 elements. The grids shows a boundary layer refinement.

The comparison with the results given in ref. [17] is done for the horizontal velocity profiles of both phases along the center-line of the channel. The results, as seen in Fig. 4(a), show a quite good agreement with the reference solution. In Fig. 4(b) the depen-dency of the solution from the grid is also shown. Further comparisons are made for the pressure and the volume fraction. Figure 5(a) shows the static pressure along the centerline of the channel for the two different solutions. Regarding the volume fraction, the comparison is made through the values obtained along a vertical cut at x = 2.5d. The results are shown in Fig. 5(b).

The contour plots of the horizontal velocity for both the phases, and of the volume frac-tion of the secondary phase along the channel are presented (Figures 6-7), in order to assure a fair level of stabilization has been reached in the solution.

6.2 Two-Phase Flow in a T-Junction

The aim of this test case is to demonstrate the correctness of the implementation of the model and its accuracy for relatively complex flow patterns due to phase separation and mixing. The solution obtained is again compared with the one presented in [17]. The geometry of the problem is shown in Fig. 8.

(14)

X X XX XX XX XX XX X XX X X XX X X X XX X X X X X X XX X X X X X X X X X Horizontal distance H or iz on ta lv el oc ity 0 0.5 1 1.5 2 2.5 3 1 1.1 1.2 1.3 1.4 1.5 1.6 1.7 X phase 1 present phase 2 present phase 2 reference phase 1 reference (a) H H H H H H H H H H HH HH HH HH HH HH H HH H H HH H H XX X X X X X X X X XX XX XX XX XXX X X XX X X XX X Horizontal distance H or iz on ta lv el oc ity 0 0.5 1 1.5 2 2.5 3 1 1.1 1.2 1.3 1.4 1.5 1.6 1.7 H X phase 1 67168 phase 2 67168 phase 1 32876 phase 2 32876 phase 1 8350 phase 2 8350 phase 1 3236 phase 2 3236 (b)

Figure 4: Two-phase flow in a channel - comparison for horizontal velocity profiles along y=0.5d between [17] and the present solution (a), and with different grids (b).

Horizontal distance P re ss ur e 0 0.5 1 1.5 2 2.5 3 0 0.1 0.2 0.3

0.4 present solutionreference solution - own code reference solution - CFX (a) Vertical distance P rim ar y ph as e vo lu m e fr ac tio n 0 0.25 0.5 0.75 1 0.5 0.6 0.7 0.8 0.9 1 present solution reference solution (b)

(15)

ag: 0.05 0.08 0.11 0.14 0.18 0.21 0.24 0.28 0.31 0.34 0.37 0.41 0.44 0.47 0.51

Figure 6: Two-phase flow in a channel - contour plot for the secondary phase volume fraction.

ul: 0.08 0.17 0.25 0.33 0.41 0.50 0.58 0.66 0.75 0.83 0.91 1.00 1.08 1.16 1.24

(a)

ug: 0.11 0.21 0.32 0.43 0.53 0.64 0.75 0.86 0.96 1.07 1.18 1.28 1.39 1.50 1.60

(b)

(16)

4d d x=3.5d x=6.5d

Inlet

Outlet

2d y=0.5d origin d

Inlet

Figure 8: Two-phase flow in a T-junction - geometry of the problem.

Again the Reynolds number is defined as

Re = ud

ν (44)

On Tab. 2 the values of the physical properties of both phases are given.

Reynolds Number Re1 = 100 Re2 = 75

Kinematic Viscosity µ1 = 0.01 µ2 = 0.0066

Density ρ1 = 1.0 ρ2 = 0.5

Inlet Volume Fraction α1 = 0.5 α2 = 0.5

Table 2: Two-phase flow in a T-junction - physical properties.

Several unstructured grids are considered for the simulation. The coarsest grid consists of 1676 nodes and 3158 elements, and the finest one consists of 9981 nodes and 19468 ele-ments. The grids present a boundary layer refinement, to better reproduce the behaviour of the flow near the corners. In order to reproduce the results given in [17], the same drag force parameters are used. In particular

CD = 1 and dg = 0.1 (45)

(17)

X X X X X X X X XX X XX XX X X X X X X X X X X X XX X X X X X X X X Horizontal distance V el oc ity 0 1 2 3 4 5 6 7 0 0.5 1 1.5 2 2.5 3 X x-velocity present y-velocity present x-velocity reference y-velocity reference (a) X X X X X X X XX XX X XXX X X X X X X X X X X X X X X X X X H H H H H H H HH H H HH H H H H H H H H H H H H H H H H H H H Horizontal distance V el oc ity 0 1 2 3 4 5 6 7 0 0.5 1 1.5 2 2.5 3 X H x-velocity 19468 y-velocity 19468 x-velocity 12862 y-velocity 12862 x-velocity 3158 y-velocity 3158 (b)

Figure 9: Two-phase flow in a T-junction - comparison for the velocity profiles along y=0.5d between [17] and the present solution (a), and with different grids (b).

Vertical distance V ol um e fr ac tio n 0 0.25 0.5 0.75 1 0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 phase 1 x=3.5d phase 1 x=6.5d (a) Vertical distance V ol um e fr ac tio n 0 0.25 0.5 0.75 1 0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 phase 1 x=3.5d phase 1 x=6.5d (b)

(18)

solutions is less good respect to the one obtained for the velocity profiles. Nevertheless, the maximum value is still comparable. The major differences are located especially near the walls.

Further plots are presented for the contour line of the pressure and the volume fraction along the all T-junction (see Figures 11-12). Regarding the volume fraction plot, the secondary phase accumulates near the lower wall after the junction, and the primary phase at the middle of the channel and at the top wall (see Figure 12). The secondary phase, having lower inertia, can better follow the geometry of the T-junction, and that is why it accumulates in the bottom wall.

7 CONCLUSIONS

In this paper a parallel Streamline Upwind Petrov-Galerkin finite element formulation for two phase-flows has been shown.

The mathematical formulation of the two-phase flow model has been given, together with the strategy to achieve the discretization and the stabilization of the set of the resulting equations. The system of equations has been discretized as an advective-diffusive set of equations and a SUPG stabilization has been performed by considering the advective matrix contributions. The parallelization issues and the advantage in term of speed up have been presented. The accuracy of the method has been proved by comparing the results, in the case of multiple meshes, for the channel and the T-junction flow problems with the ones given in ref. [17].

The results highlight that the choice of this approach is very promising to simulate two-phase flows. The results also suggest a better stabilization is needed in the boundary layer region, thus leading to the improvement of the discontinuity capturing operator acting in this region. Then, the parallel implementation suggests the computation of future more complex problems to test the stability and efficiency of the adopted algorithm.

REFERENCES

[1] Ishii M., Thermo-Fluid Dynamic Theory of Two-Phase Flow, Eyrolles, Paris, 1975. [2] Stewart H. B. and Wendroff B., Two-phase flow: models and methods, Journal of

Computational Physics, Vol.56, 1984, pp. 363-409.

[3] Drew D. A., Mathematical modeling of two-phase flow, Annual Review on Fluid Mechanics, Vol.15, 1983, pp. 261-291.

[4] Ishii M., Two-fluid model for two-phase flow. In Multiphase Science and Technology, volume 5, pages 1-64. Hemisphere Publishing Corporation, 1990.

(19)

p: -1.53-1.20-0.87-0.53-0.20 0.14 0.47 0.81 1.14 1.47 1.81 2.14 2.48 2.81 3.15

Figure 11: Two-phase flow in a T-junction - contour plot for the pressure.

ag: 0.33 0.38 0.42 0.47 0.51 0.56 0.60 0.64 0.69 0.73 0.78 0.82 0.87 0.91 0.96

(20)

interpolations, Computer Methods in Applied Mechanics and Engineering, Vol.59, 1986, pp. 85-99.

[6] Hughes T. J. R., Mallet M. and Mizukami A., A new finite element formulation for computational fluid dynamics: II. Beyond SUPG, Computer Methods in Applied Mechanics and Engineering, Vol.54, 1986, pp. 341-355.

[7] Mizukami A., An implementation of the Streamline-Upwind/Petrov-Galerkin method for linear triangular elements, Computer Methods in Applied Mechanics and Engi-neering, Vol.49, No.3, 1985, pp. 357-364.

[8] Balay S., Gropp W. D., McInnes L. C. and Smith B., PETSc home page,

http://www.mcs.anl.gov/petsc, 2001.

[9] Oliveira P. J. and Issa R. I., Numerical aspects of an algorithm for the Eulerian simulation of two-phase flow, International Journal for Numerical Methods in Fluids, Vol.43, 2003, pp. 1177-1198.

[10] Chorin A. J., A numerical method for solving incompressible viscous flow problems. Journal of Computational Physics, Vol.2, 1967, pp.12-26.

[11] Tezduyar T. E., Mittal S., Ray S. E. and Shih R., Incompressible flow computa-tions with bilinear and linear equal-order interpolation velocity- pressure elements, Computer Methods in Applied Mechanics and Engineering, Vol.95, 1992, pp. 221-242. [12] Codina R., On stabilized finite element methods for linear systems of convection-diffusion-reaction equations, Computer Methods in Applied Mechanics and Engineer-ing, Vol.188, 2000, pp. 61-88.

[13] Babu´ska I., Error bounds for finite element methods, Numerische Mathematik, Vol.16, 1971, pp. 322-333.

[14] Brezzi F., On the existence, uniqueness and approximation of saddle-point problems arising from Lagrange multipliers, R.A.I.R.O., S´erie Rouge Analyse Num´erique, Vol.8(R-2), 1974, pp. 129-151.

[15] Hauke G. and Hughes T. J. R., A comparative study of different sets of variable for solving compressible and incompressible flows, Computer Methods in Applied Mechanics and Engineering, Vol.153, 1988, pp. 1-44.

[16] Giordano M. and Magi V., Petrov-Galerkin finite element stabilization for two-phase flows. International Journal for Numerical Methods in Fluids, in press.

Cytaty

Powiązane dokumenty

100 Chapter 5 of the MCLS Level-Set correction procedure: Distance function values are still prescribed from the volume fraction equation (5.8) in interface cells, but the dis-

Classical molecular dynamics simulations were performed to study the effect of pore width and surface charge in carbon mesoporous materials on adsorption and diffusion selectivities

Autorka omówiła genezę żeńskiego ru- chu harcerskiego na tym terenie, ukształtowa- nie się struktury organizacyjnej, metody pracy, kształcenie instruktorek i drużynowych, formy

defined as follows: he- is the forced oscillation frequency of the cylinder, S,, = lila is the vortex, shedding frequency and Si is the Strouhal number, computed to be equal to 0.155

Heidegger remarks in Being and Time that Dasein may exist “in the way of scientific research” and that the existential conception of sci- ence “understands science as a way

A second strategy, without the above restriction, are coarse space projection–based VMS methods, presented in Section 4: standard finite element spaces are chosen for all

(2016) to trace the perception of Dutch and Turkish vowels by the three groups of Polish learners of Dutch, French and English. An iden- tical L2 sound is produced authentically due

Absorbed energy distributions (10 4 W/ ␮ m 3 ) halfway in the PC layer for a TM-polarized spot that is incident on the grooved multilayer for the Blu-ray Disc (stack is shown in