• 검색 결과가 없습니다.

Non-Graded Adaptive Grid Approaches to the Incompressible Navier-Stokes Equations

N/A
N/A
Protected

Academic year: 2022

Share "Non-Graded Adaptive Grid Approaches to the Incompressible Navier-Stokes Equations"

Copied!
12
0
0

로드 중.... (전체 텍스트 보기)

전체 글

(1)

Proo

f

Non-Graded Adaptive Grid Approaches to the Incompressible Navier-Stokes Equations

Frédéric Gibou1, Chohong Min2, Hector D. Ceniceros3

Abstract: We describe two finite difference schemes for simulating incompressible flows on nonuniform meshes using quadtree/octree data structures. The first one uses a cell-centered Pois- son solver that yields first-order accurate solu- tions, while producing symmetric linear systems.

The second uses a node-based Poisson solver that produces second-order accurate solutions and second-order accurate gradients, while producing nonsymmetric linear systems as the basis for a second-order accurate Navier-Stokes solver. The grids considered can be non-graded, i.e. the dif- ference of level between two adjacent cells can be arbitrary. In both cases semi-Lagrangian methods are used to update the intermediate fluid velocity in a standard projection framework. Numerical results are presented in two and three spatial di- mensions.

Communicated by John Lowengrub (GuestEdi- tor) and Mark Sussman

1 Introduction

Incompressible flows are at the center of count- less applications in physical and biological sci- ences. Uniform Cartesian grids used in numerical simulations are limited in their ability to resolve small scale details and as a consequence nonuni- form meshes are often desirable in practice. Since the work of Berger and Oliger (4) on compress- ible flows, adaptive mesh refinement techniques have been widely used, see e.g the approach of Almgren et al. (1) (and the references therein)

1Mechanical Engineering Department & Computer Sci- ence Department, University of California, Santa Barbara, CA 93106.

2Mathematics Department, University of California, Santa Barbara, CA 93106.

3Mathematics Department, University of California, Santa Barbara, CA 93106.

for the Navier-Stokes equations on block struc- tured grids. In the case of incompressible flows, adaptive mesh strategies are quite common (see e.g. (13; 31; 7; 32; 33; 34; 2; 9) and the refer- ences therein), but implementations based on the optimal quadtree/octree data structure is less com- mon.

In the case of a standard projection method (see e.g. (8; 6)), the most computationally expensive part comes from solving a Poisson equation for the pressure. This is also the limiting part in terms of accuracy, since high order accurate (and unconditionally stable) semi-Lagrangian methods exist for the convective part. In (26), Popinet proposed a second-order nonsymmetric numeri- cal method to study the incompressible Navier- Stokes equations using an octree data structure.

In (22), Losasso et al. proposed a symmetric solu- tion of the Poisson equation for non-graded adap- tive grids, i.e. grids for which the size’s ratio be- tween adjacent cells is not constrained. This work relies on the observation that, in the case of the Poisson equation, first-order perturbations in the location of the solution yield consistent schemes (see Gibou et al. (12)). Losasso et al. then ex- tended the work of Lipnikov et al. (19) to the case of arbitrary grids to propose a second-order accu- rate symmetric discretization of the Poisson equa- tion (21). In (25), Min et al. proposed a second- order accurate scheme for the Poisson equation that also yields second-order accurate gradients.

In this case the linear system is nonsymmetric, but diagonally dominant, i.e. for each row the diago- nal element is greater or equal to the sum of the nondiagonal elements. This Poisson solver was used for solving the Navier-Stokes equations to second-order accuracy in Min and Gibou (24) us- ing the projection methods described in Brown, Cortez and Minion (6). In this paper, we describe

(2)

Proo

f

two finite difference schemes for simulating in- compressible flows on nonuniform meshes using quadtree/octree data structures. The first one uses a cell-centered Poisson solver that yields first- order accurate solutions, while producing sym- metric linear systems (see Losasso, Gibou and Fedkiw (22)). The second uses a node-based Poisson solver that produces second-order accu- rate solutions and second-order accurate gradi- ents, while producing nonsymmetric linear sys- tems (see Min, Gibou and Ceniceros (25) for a supra-convergent Poisson solver and Min and Gibou (24) for a second-order accurate Navier- Stokes solver). The grids considered can be non- graded, i.e. the difference of level between two adjacent cells can be arbitrary. In both cases semi- Lagrangian methods are used to update the in- termediate fluid velocity in a standard projection framework. We present numerical results in two and three spatial dimensions to complement the analysis of (22; 25; 24).

2 The Navier-Stokes Equations

The motion of fluids is described by the incom- pressible Navier-Stokes equations for the conser- vation of momentum and mass:

ut+u ·∇u= −∇p+f +μΔu, (1)

· u = 0, (2)

where u= (u,v,w) is the velocity field, f accounts for the external forces such as gravity and where the spatially constant density of the fluid has been absorbed in the pressure p. We assume the vis- cosity parameterμ to be constant.

3 First-Order Accurate Symmetric Navier- Stokes Solver on Octrees

3.1 Cell-Centered Arrangement

In (22), Losasso et al. proposed a solver for the incompressible Euler equations on non-graded adaptive grids. The domain is tiled with cells as depicted in figure 1 and the mesh is refined auto- matically in order to capture the local details crit- ical to realistic simulations and coarsened else- where. An octree data structure is used (see (27))

for efficient processing and the different variables are stored as depicted in figure 1: The velocity components u, v and w are stored at the cell faces while the pressure is stored at the center of the cell. This is the standard MAC grid arrangement used in previous works (see e.g. (14)). However, in the case of nonuniform meshes it is more con- venient to store the other scalar quantities such as the densityρat the nodes of each cell. This stems from the fact that interpolations are more difficult with cell-centered data as discussed in (30).

Δx Δy

ui+1/2,j,k vi,j+1/2,k

(i,j,k)

Δz

i,j,k−1/2

w p

T,

*

u u

u

u 5

3 2 u1*

*

*

*

*

4

ρ, Φ

Figure 1: Left: the domain is tiled with cells of sizes varying according to the refinement crite- rion. Right: Zoom of one computational cell. The velocity components u, v and w are defined on the cell faces while the pressure p is defined at the center of the cell. The other scalar quantities are stored at the nodes.

3.2 Projection Method

A standard first-order accurate projection method (8) (see also (6)) is used to solve equations (1) and (2): First an intermediate velocity uis computed over a time stept, ignoring the pressure term

u−u

t +u ·∇u = f. (3)

This step, accounting for the convection and the external forces, is followed by a projection step to account for incompressibility and boils down to solving the Poisson equation

2p= 1

t· u. (4)

Finally, the new velocity field u is defined as:

u= uΔt∇p. (5)

(3)

Proo

f

The reader is referred to (22) and the references therein for the application of this scheme to the simulations of free surface flows.

3.2.1 Computing the Intermediate Velocity The intermediate velocity u is found by solv- ing equation (3) using a first-order accurate semi- Lagrangian method. In the case of nonuniform grids, the standard high order accurate upwind methods (see e.g. (15; 28; 20)) traditionally used in the case of uniform grids are not well suited due to their stringent time step restrictions and the complexity of their implementations. On the other hand, semi-Lagrangian methods (see e.g.

(29)) are unconditionally stable and are straight- forward to implement.

Δy

Δx

p p

p p

1 10

6 p 2

a px

^ py

px

Cell 1 Cell 2 Cell 10

Cell 6

Figure 2: Discretization of the pressure gradient.

The pressure values p1, p2, p6, and p10 are de- fined at the center of the cells. pa represents a weighted average pressure value. py defines the y component of the pressure gradient between Cell 1 and Cell 10 defined by standard central differ- encing. ˆpx represents the discretization of the x component of the pressure gradient between Cell 1 and Cell 2, whereas pxis a O(x) perturbation of ˆpx.

3.2.2 The Intermediate Velocity Divergence Equation (14) is solved by first evaluating the right hand side at every grid point in the domain.

Then, a linear system for the pressure is con- structed and inverted. Consider the discretization of equation (14) for a large cell with dimensions

x, y and z neighboring small cells as de- picted in figure 1 (left). Since the discretization

is closely related to the second vector form of Green’s theorem that relates a volume integral to a surface integral, we first rescale equation (14) by the volume of the large cell to obtain

Vcellt∇2p= Vcell· u. (6) The right hand side of equation (6) now represents the quantity of mass flowing in and out of the large cell within a time stept in m3s−1. This can be further rewritten as

Vcell· (u−t∇p) = 0. (7) This equation implies that the term ∇p is most naturally evaluated at the same location as u, namely at the cell faces, and that there is a di- rect correspondence between the components of the vectors ∇p and u. That is, there is a direct correspondence between px and u, py and v, pz and w, which live on the right and left faces, top and bottom faces, front and back faces, respec- tively. Moreover, substituting equation (15) into equation (7) implies Vcell· u = 0 or· u = 0 as desired.

Invoking the second vector form of Green’s theo- rem, one can write

Vcell· u=

faces

(uface· n)Aface, (8)

where n is the outward unit normal of the large cell and where Aface represents the area of a cell face. In the case of figure 1 (left), the discretiza- tion of the x-derivative of the x-component uof the velocity field ureads

xyzu

x =

u2A2+u3A3+u4A4+u5A5−u1A1, (9) where the minus sign in front of u1A1 accounts for the fact that the unit normal points to the left. In this example, the discretization of∂u/∂x amounts to

u

x = 1

x

u2+u3+u4+u5

4 −u1



. (10)

The y- and z- directions are treated similarly.

(4)

Proo

f

3.2.3 Defining the Pressure Derivative to Ob- tain a Symmetric Linear System

Once, the divergence is computed at the grid nodes, equation (14) is used to construct a lin- ear system of equations for the pressure. Invoking again the second vector form of Green’s theorem, one can write

Vcell· (t∇p) =

faces

((t∇p)face· n)Aface. (11)

Therefore, once the pressure gradient is computed at every face, we can carry out the computation in a similar manner as for the divergence of the velocity described above.

In Gibou et al. (12), we showed that O(x) per- turbations in the location of the solution sampling still yield consistent approximations. This was then exploited in (22) to define ∇p in order to construct a symmetric linear system. We simply define

px= p2− p1

 ,

where can be defined as  = x, which is the size of the large cell or  = 12x, which is the size of the small cell, or as the Euclidean distance between the locations of p1 and p2 or as the dis- tance along the x direction between the locations of p1and p2etc. We have used the distance along the x direction between the locations of p1and p2. 4 Second-Order Accurate Navier-Stokes

Solver on Octrees 4.1 Projection Method

In this case, we choose to store all the variable at the grid nodes in order to develop a simple supra-convergent scheme for the Poisson equation as well as a second-order accurate Navier-Stokes solver. Backward differentiation formulas offer a convenient choice to obtain second-order accu- racy in time. In this case, the discretization of the momentum equation is written as:

1 Δt

3

2un+1−2und+1 2und−1



+∇pn+1=

μΔun+1+ fn+1, (12)

where ud is the velocity at the "departure" point found by tracing back the characteristic curves and interpolated using quadratic interpolation procedures. Equation (12) can be solved using the pressure-free three-step projection method ap- proach of Brown (6): In this method, the interme- diate velocity uis first computed by ignoring the pressure component:

1 Δt

3

2u−2und+1 2und−1



=μΔhu+fn+1. (13) Second, a potential function φn+1 satisfying the Poisson equation:

Δhφn+1= 1

Δt(∇h· u). (14) is computed to project uonto the divergence free field:

un+1= uΔtα∇hφn+1, (15) where

α= u·hφn+1

hφn+1·hφn+1

guarantees that the projection step is an Hodge de- composition at the discrete level (24). The inner product of two functions f and g is computed cell- wise by multiplying the average value for f× g using the cell’s nodes with the volume of the cell.

Taking the divergence of equation (15) and using the relation given by equation (14) yields a veloc- ity field un+1 that is indeed divergence free (up to the accuracy of the scheme). The relation between φn+1and the pn+1is given by:

∇pn+1=3

2∇φn+1ΔtμΔ∇φn+1. The boundary conditions on u:

n· u|Ω = n · un+1|Ω,

t· u|Ω = t · un+1|Ω+Δt· t ·∇φn,

∇φ· n|Ω = 0,

where n and t denote the normal and tangent vec- tors at the boundary, respectively are sufficient to ensure second-order accuracy for the velocity field (see (6; 17)).

(5)

Proo

f

Figure 3: Example of refinement in two spatial dimensions. The total number of cells increases quadratically whereas the number of locally nonuniform cells (shaded) increases linearly. The contribution of nonuniform cells decreases relatively to that of uniform cells.

4.2 Supra-Convergent Poisson Solver

The Poisson solver presented in section 3.2.3 is globally first-order accurate (consistent), even though the discretization at nonuniform mesh points is inconsistent. In fact, the different ap- proximations of the pressure gradients in (22) re- sult in consistent schemes, regardless of how the distance between the two adjacent cells involved in the discretization of the pressure gradients is accounted for. In this case, the scheme is there- fore locally inconsistent on nonuniform meshes but still leads consistent solutions. This was ex- plained by the fact that first-order perturbations in the location produce a consistent method as demonstrated in (11; 12). This can be related to the work of Johansen and Colella (16) who pro- vided a heuristic argument based on potential the- ory as to why schemes that are only first-order ac- curate at locally nonuniform grid nodes can be globally second-order accurate (see also the re- lated work by Manteufell et al. (23) as well as Kreiss et al. (18)). One of the basic reason is that the set of locally non-uniform cells is one- dimension lower than the set of locally uniform cells (see figure 3). Here, we say that a cell is lo- cally nonuniform if its size is different from the size of at least one of its neighbors whereas a cell is locally uniform if its size is equal to that of all of its neighbors. In turn, the influence of nonuni- form cells is absorbed by that of the uniform one through the inversion of the elliptic solver, yield- ing a second-order accurate scheme. Based on

this argument and on numerical evidence, Min et al. hypothesized in (25) that a strategy for deriv- ing pthorder accurate finite difference schemes in the L norm, is to focus on designing schemes that are(p−1)thorder accurate at locally nonuni- form cells, which reduce to at least pth order ac- curate schemes at locally uniform cells. In par- ticular, in order to derive second-order accurate schemes, it is enough to focus on finding a con- sistent approximation at non-uniform cells.

Figure 4: Local structure around a node v0 in a quadtree mesh: At most one node in the two Cartesian directions might not exist. In this case, we define a ghost node (here v4) to be used in the discretizations.

Consider a Cartesian domainΩ∈ Rnwith bound- ary ∂Ω and the variable Poisson equation ∇· (ρ∇u) = f onΩwith Dirichlet boundary condi- tion u|Ω= g. We assume that the variable coeffi-

(6)

Proo

f

cientρ is bounded from below by a positive con- stant. In one spatial dimension, standard central differencing formulaes read:



ui−1−ui

si1

2

·ρi−1i

2 +ui+1−ui

si+1

2

·ρi+1i

2



· 2

si1 2+si+1

2

= fi,

where si−1/2 is the distance between nodes i− 1 and i. This discretization is second-order accu- rate and can be applied in a dimension by dimen- sion framework. However, special care needs to be taken when vertices are no longer aligned (see, e.g. figure 4). In this case, (25) proposed to use the truncation error in linear interpolation in the transverse direction as part of the stencil for the derivative in the other direction, leading to a more compact stencil, and an M-matrix. For example, referring to figure 4 the discretizations for(ρux)x

and (ρuy)y along with their Taylor analysis are given respectively by

u1−u0

s1 ·ρ10

2 +s6D5+s5D6 s5+s6



· 2 s1+s4

= (ρux)x+ s5s6 (s1+s4)s4

uy)y+O(h), (16) and

u2−u0

s2 ·ρ20

2 +u3−u0

s3 ·ρ30

2



· 2 s2+s3

= (ρuy)y+ O(h), (17) with

D5 = u5−u0

s4 ·ρ50

2 ,

D6 = u6−u0

s4 ·ρ60

2 .

The spurious term (ss5s6

1+s4)s4uy)y is cancelled by weighting appropriately equations (16) and (17) as

u1−u0

s1 ·ρ10

2 +s6a5+s5a6

s5+s6



· 2 s1+s4

+

u2−u0

s2 ·ρ20

2 +u3−u0

s3 ·ρ30

2



· 2 s2+s3·



1 s5s6 (s1+s4)s4



= f0+O(h).

The discretization obtained is now first-order ac- curate at locally nonuniform points and second- order accurate at locally uniform points, hence yields a globally second-order accurate scheme in the maximum norm.

5 Numerical Results

We report numerical evidences that confirm the schemes described in section 4 yield second-order accuracy in the L1 and L norms, on highly ir- regular grids. In particular the difference of level between cells can be greater that one, illustrating that the method preserves its second-order accu- racy on non-graded adaptive meshes. In the case of the Poisson scheme derived in section 4.2, we demonstrate that both the solution and its gradi- ents are second-order accurate. The linear sys- tems of equations are solved using a bi-conjugate gradient method with an incomplete Cholesky preconditioner.

Figure 5: Original mesh used in example 5.1 il- lustrating high size ratios between adjacent cells.

5.1 Accuracy for the Supra-Convergent Pois- son Solver

Consider a domainΩ= [0,2] × [0,1] and a grid depicted in figure 5 andΔu= f with an exact solu- tion of u(x,y) = sin(x)cos(y). Dirichlet boundary conditions are imposed on the boundary. Tables 1 and 2 demonstrate second-order accuracy in the L1and Lnorms for the solution and its gradient, respectively.

(7)

Proo

f

Finest Resolution Lerror on u rate L1error on u rate 642 2.73 ×10−3 3.75 ×10−2 1282 6.99 ×10−4 1.91 4.18 ×10−4 2.33 2562 1.76 ×10−4 1.97 2.75 ×10−5 1.89 5122 4.38 ×10−5 1.98 6.87 ×10−6 2.05 10242 1.09 ×10−5 2.00 1.71 ×10−6 2.00

Table 1: Convergence rate of u for example 5.1.

Finest Resolution Lerror on∇u rate L1error on∇u rate

642 2.28 ×10−1 5.04 ×10−2

1282 7.63 ×10−2 1.58 1.07 ×10−2 1.24 2562 2.05 ×10−2 1.89 2.71 ×10−3 1.99 5122 5.21 ×10−3 1.98 6.06 ×10−4 2.16 10242 1.31 ×10−3 1.99 1.46 ×10−4 2.04

Table 2: Convergence rate of∇u for example 5.1.

Figure 6: Original mesh used in example 5.2.

5.2 Accuracy for the Navier-Stokes Equation 5.2.1 Unconditional Stability

Unconditional schemes are not bound to re- spect the CFL condition Δt <Δxs, which can lead to very severe time step restriction. Here, we demonstrate that our solver allows uncon- strained time steps. Consider a domain Ω = [−π/2,π/2] ×[−π/2,π/2] and a grid depicted in figure 6. We consider the Navier-Stokes equations

with an exact solution of:

u(x,y,t) = −cos(t) ∗ cos(x) ∗ sin(y), v(x,y,t) = cos(t) ∗ sin(x) ∗ cos(y),

p(x,y,t) = sin(x) ∗ sin(y) ∗ (sin(t) −2 ∗ cos(t)).

The viscosity is set toμ= 1 and Dirichlet bound- ary conditions are imposed on the boundary. Ta- bles 3 and 4 demonstrate second-order accuracy in the L1and Lnorms for the solution when the time step is given byΔt=ΔxsandΔt= 3Δxs, re- spectively, whereΔxsrefers to the size of the most refined grid cell.

5.2.2 Lid-Driven Cavity

We test our Navier-Stokes solver on the well- known lid-driven cavity problem studied exten- sively by Ghia et al. (10): Consider a domain Ω= [0,1]2, with the top wall moving with unit velocity. We impose no-slip boundary conditions on the four walls. In this example, we take a Reynolds number Re= 1000, i.e. a viscosity co- efficientμ= 1/1000. For the refinement criteria, there exist various choices including a posteriori error control based on Richardson extrapolation (3), or a simple criteria based on the magnitude of local vorticity (26; 24). The criterion for mesh re- finement we use is that proposed in (5), i.e. a cell

(8)

Proo

f

Finest Resolution Lerror on u rate L1error on u rate 642 1.49 ×10−1 2.71 ×10−2 1282 1.91 ×10−2 2.96 3.57 ×10−3 2.92 2562 3.86 ×10−3 2.31 7.58 ×10−4 2.23 5122 2.81 ×10−4 3.78 7.92 ×10−5 3.25

Table 3: Convergence rate of the x-component u of the velocity field u for example 5.2.1 in the case of a time stepΔt=Δxs.

Finest Resolution Lerror on u rate L1error on u rate 642 7.10 ×10−2 1.89 ×10−2 1282 1.30 ×10−2 2.44 2.33 ×10−3 3.02 2562 4.98 ×10−3 1.38 6.72 ×10−4 1.79 5122 1.29 ×10−3 1.98 1.94 ×10−4 2.26

Table 4: Convergence rate of the x-component u of the velocity field u for example 5.2.1 in the case of a time stepΔt= 3Δxs.

Size of the Finest Grid ||U −Uh|| Order ||U −Uh||1 order

322 6.92E −2 2.60E −2

642 2.64E −2 1.38 9.73E −3 1.41

1282 6.28E −3 2.07 2.49E −3 1.96 2562 1.07E −3 2.54 4.98E −4 2.32 5122 2.23E −4 2.26 3.94E −5 2.90 Table 5: Accuracy of the velocity field in the L1and Lnorms for example 5.2.3.

Size of the Finest Grid ||∇·Uh|| Order ||∇·Uh||1 order

322 3.56E −1 4.82E −2

642 1.36E −1 1.38 1.59E −2 1.60 1282 3.74E −2 1.87 2.30E −3 2.78 2562 9.55E −3 1.96 2.94E −4 2.96 5122 2.56E −3 1.90 3.94E −5 2.90

Table 6: Accuracy of the divergence free condition in the L1and Lnorms for example 5.2.3.

C is refined whenever min(x,y)2×max

x∈C (|uxx|,|uyy|,|vxx|,|vyy|) >τ, (18) whereτ is an empirically chosen threshold taken to be .01. More precisely, consider a grid struc- ture Gn at time tn on which the velocity field is updated from unto un+1. The grid Gn+1at tn+1is constructed in the following way: First, we com- pute the second-order derivatives at every nodes

of Gn. Second, starting from the root of Gn+1split the cell if (18) is satisfied. Finally, un+1is defined on the new grid Gn+1 from the values of un+1 on Gnusing the quadratic interpolation.

Figure 7 depicts the evolution of the streamlines and the evolution of the adaptive grid until steady state, while figure 8 demonstrates the convergence of the velocity at steady state to the benchmark solution of (10). We note that these simulation results are comparable to the results of (24) that

(9)

Proo

f

utilized a different refinement criteria, a different CFL number and a different level difference be- tween coarsest and finest cells.

Figure 7: Adaptive grids and streamlines for the driven cavity example 5.2.2. From top to bottom and left to right: t= 3.12, 7.50, 13.75 and 37.50.

The coarsest grid has level 6, and the finest has level 8.

5.2.3 Three Spatial Dimensions

In three spatial dimensions, we consider a domain Ω= [−π2,π2]3and a flow with viscosityμ= 1 and with an exact solution defined by:

u(x,y,z,t) = −2cos(t)cos(x)sin(y)sin(z) v(x,y,z,t) = cos(t)sin(x)cos(y)sin(z) w(x,y,z,t) = cos(t)sin(x)sin(y)cos(z) p(x,y,z,t) = 1

4cos2(t)

2 cos(2x) +cos(2y) +cos(2z) The time step is chosen as Δt= 5 ×Δxs, where Δxs is the size of the finest grid cell and we run the simulation up to a final time of t =π. Table 5 demonstrates the second-order accuracy of the velocity field in the L1 and L norms while table 6 demonstrates the second-order accuracy for the divergence free condition in the L1and Lnorms.

−0.40 −0.2 0 0.2 0.4 0.6 0.8 1 1.2

0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1

u

y

0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1

−0.6

−0.5

−0.4

−0.3

−0.2

−0.1 0 0.1 0.2 0.3 0.4

x

v

Figure 8: x- and y- components of the velocity field in the driven cavity example 5.2.2. The do- main is [0,1], Re = 1000 and the time step is

t = 5xs, where xs is the size of the small- est grid cell. The symbols are the experimen- tal results of (10), the dotted line depicts the nu- merical results obtained with an adaptive quadtree with levels ranging from 6 to 8, whereas the solid line depicts the numerical results obtained with an adaptive quadtree with levels ranging from 7 to 9.

6 Conclusion

We have described two finite difference schemes for simulating incompressible flows on nonuni- form meshes using quadtree/octree data struc- tures. The first one uses a cell-centered Poisson solver that yields first-order accurate solutions, while producing symmetric linear systems (see Losasso, Gibou and Fedkiw (22)). The second

(10)

Proo

f

Figure 9: From top to bottom and from left to right: Arbitrarily generated three dimensional grid used in example 5.2.3, its front view, side view and top view. In particular, note that the dif- ference of level between adjacent grid cells can exceed one.

uses a node-based Poisson solver that produces second-order accurate solutions and second-order accurate gradients, while producing nonsymmet- ric linear systems (see Min, Gibou and Ceniceros (25) for a supra-convergent Poisson solver and Min and Gibou (24) for a second-order accurate Navier-Stokes solver). The grids considered can be non-graded, i.e. the difference of level be- tween two adjacent cells can be arbitrary, which facilitates grid generations. In both cases semi- Lagrangian methods were used to update the in- termediate fluid velocity in a standard projection framework. Numerical results were reported in two and three spatial dimensions to demonstrate the accuracy of the methods.

Acknowledgement: The research of F. Gibou was supported in part by the Alfred P. Sloan Foun- dation through a research fellowship in Mathe- matics. The research of H. D. Ceniceros was sup- ported in part by NSF DMS-0311911.

References

[1]A. Almgren, J. Bell, P. Colella, L. How- ell, and M. Welcome. A conservative adap- tive projection method for the variable den- sity incompressible Navier-Stokes equations.

J. Comput. Phys., 142:1–46, 1998.

[2]A. Anderson, X. Zheng, and V. Cristini.

Adaptive unstructured volume remeshing i:

The method. J. Comput. Phys., 208:616–625, 2005.

[3]M. Berger and P. Colella. Local adaptive mesh refinement for shock hydrodynamics. J.

Comput. Phys., 82:64–84, 1989.

[4]M. Berger and J. Oliger. Adaptive mesh refinement for hyperbolic partial differential equations. J. Comput. Phys., 53:484–512, 1984.

[5]J.G. Blom, R.A. Trompert, and J.G. Verwer.

A vectorizable adaptive grid solver for pdes in 2d. ACM Trans. Math. Softw., 22:302–328, 1996.

[6]D. Brown, R. Cortez, and M. Minion. Accu- rate projection methods for the incompress- ible Navier-Stokes equations. J. Comput.

Phys., 168:464–499, 2001.

[7]H. D. Ceniceros and A. M. Roma. Study of long-time dynamics of a viscous vortex sheet with a fully adaptive non-stiff method. Phys.

Fluids, 16(12):4285–4318, 2004.

[8]A. Chorin. A Numerical Method for Solv- ing Incompressible Viscous Flow Problems.

J. Comput. Phys., 2:12–26, 1967.

[9]V. Cristini and Y. Renardy. Scalings for droplet sizes in shear-driven breakup: Non- microfluidic ways to monodisperse emul- sions. FDMP, 2:77–94, 2006.

[10]U. Ghia, K. N. Ghia, and C. T. Shin. High- re solutions for incompressible flow using the Navier-Stokes equations and a multigrid method. J. Comput. Phys., 48:387–411, 1982.

(11)

Proo

f

[11]F. Gibou and R. Fedkiw. A fourth order ac- curate discretization for the Laplace and heat equations on arbitrary domains, with applica- tions to the Stefan problem. J, Comput. Phys., 202:577–601, 2005.

[12]F. Gibou, R. Fedkiw, L.-T. Cheng, and M. Kang. A second–order–accurate sym- metric discretization of the Poisson equation on irregular domains. J. Comput. Phys., 176:205–227, 2002.

[13]F. Ham, F. Lien, and A. Strong. A fully conservative second-order finite difference scheme for incompressible flow on nonuni- form grids. J. Comput. Phys., 117:117–133, 2002.

[14]F. Harlow and J. Welch. Numerical calcu- lation of time-dependent viscous incompress- ible flow of fluid with free surface. Phys. Flu- ids, 8:2182–2189, 1965.

[15]A. Harten, B. Enquist, S. Osher, and S Chakravarthy. Uniformly high-order accu- rate essentially non-oscillatory schemes III. J.

Comput. Phys., 71:231–303, 1987.

[16]H. Johansen and P. Colella. A Cartesian grid embedded boundary method for Pois- son’s equation on irregular domains. J. Com- put. Phys., 147:60–85, 1998.

[17]J. Kim and P Moin. Application of a fractional-step method to incompressible Navier-Stokes equations. J. Comput. Phys., 59:308–323, 1985.

[18]H.O. Kreiss, H.-O. Manteuffel, T.A.

Schwartz, B. Wendroff, and A.B. White Jr. Supra-convergent schemes on irregular grids. Math. Comp., 47:537–554, 1986.

[19]K. Lipnikov, J. Morel, and M. Shashkov.

Mimetic finite difference methods for dif- fusion equations on non-orthogonal non- conformal meshes. J. Comput. Phys., 199:589–597, 2004.

[20]X.-D. Liu, S. Osher, and T. Chan. Weighted essentially non-oscillatory schemes. J. Com- put. Phys., 126:202–212, 1996.

[21]F. Losasso, R. Fedkiw, and S. Osher. Spatially adaptive techniques for level set methods and incompressible flow. Computers and Fluids (in press).

[22]F. Losasso, F. Gibou, and R. Fedkiw. Sim- ulating water and smoke with an octree data structure. ACM Trans. Graph. (SIGGRAPH Proc.), pages 457–462, 2004.

[23]T. Manteuffel and A. White. The numeri- cal solution of second-order boundary value problems on nonuniform meshes. Math.

Comput., 47 (176):511–535, 1986.

[24]C. Min and F. Gibou. A second order accu- rate projection method for the incompressible Navier-Stokes equation on non-graded adap- tive grids. J. Comput. Phys., 219:912–929, 2006.

[25]C. Min, F. Gibou, and H. Ceniceros. A supra- convergent finite difference scheme for the variable coefficient Poisson equation on non- graded grids. J. Comput. Phys., 218:123–140, 2006.

[26]S. Popinet. Gerris: A tree-based adaptive solver for the incompressible euler equations in complex geometries. J. Comput. Phys., 190:572–600, 2003.

[27]H. Samet. The Design and Analysis of Spatial Data Structures. Addison-Wesley, New York, 1989.

[28]C.-W. Shu and S. Osher. Efficient implemen- tation of essentially non-oscillatory shock capturing schemes II (two). J. Comput. Phys., 83:32–78, 1989.

[29]A. Staniforth and J. Cote. Semi-Lagrangian Integration Schemes for Atmospheric Mod- els: A Review. Monthly Weather Review, 119:2206–2223, 1991.

[30]J. Strain. Fast tree-based redistancing for level set computations. J. Comput. Phys., 152:664–686, 1999.

(12)

Proo

f

[31]M. Sussman, A. S. Algrem, J. B. Bell, P. Colella, L. H. Howell, and M. L. Welcome.

An adaptive level set approach for incom- pressible two-phase flow. J. Comput. Phys, 148:81–124, 1999.

[32]Cristini V, Blawzdziewicz J, and Lowenberg M. An adaptive mesh algorithm for evolving surfaces: simulations of drop breakup and co- alescence. J. Comput. Phys., 168:445–463, 2001.

[33]X. Yang, A. James, J. Lowengrub, X. Zheng, and V. Cristini. An adaptive coupled level-set/volume-of-fluid interface capturing method for unstructured triangular grids. J.

Comput. Phys., 217:364–394, 2006.

[34]X. Zheng, J. Lowengrub, A. Anderson, and V. Cristini. Adaptive unstructured volume remeshing ii: Application to two- and three- dimensional level-set simulations of multi- phase flow. J. Comput. Phys., 208:626–650, 2005.

참조

관련 문서

In this paper, we propose a second order accurate finite difference discretization for the variable coefficient Poisson equation on non-graded grids that also yields second

In this paper, we review a successful approach for solving the Poisson and the diffusion equations and the Stefan problem using (i) a level-set approach to capture the geometry

In this paper we propose a second order accurate nite dierence discretization for the variable coecient Poisson equation on fully adaptive grids that also yields

[22] to account for the incompressibility condition, a second order accurate semi-Lagrangian method to update the momentum equation, a stiffly stable backward difference scheme

The simulations such as the phase separation and the dendritic crystal growth numerically demonstrate the feasibility of the simple scheme as a stable and second order method for

In order to remove the time step constraint and guarantee the accuracy in time for a sufficiently large time step, we present a first and a second order semi-analytical

Also in surface reconstruction, there are some researches[13, 17] using the adaptive grid in order to generate high resolution.. We employ the octree which is a sort of

혼합제를 사용하여도 천식 조 절이 되지 않는 경우 경구 약제인 류코트리엔 조절제 그리 고 (또는) 테오필린을 추가하여 사용한다. 류코트리엔은 효 과 면에서는