20
Finite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J. F¨ urst, M. Janda, and K. Kozel Abstract. This contribution deals with the modern finite volume schemes solving the Euler and Navier-Stokes equations for transonic flow problems. We will mention the TVD theory for first order and higher order schemes and some numerical examples obtained by 2D central and upwind schemes for 2D transonic flows in the GAMM channel or through the SE 1050 turbine cascade of ˇ Skoda Plzeˇ n. In the next part two new 2D finite volume schemes are presented. Ex- plicit composite scheme on a structured triangular mesh and implicit scheme realized on a general unstructured mesh. Both schemes are used for the solu- tion of inviscid transonic flows in the GAMM channel and the implicit scheme also for the flows through the SE 1050 turbine cascade using both triangu- lar and quadrilateral meshes. For the case of the flows through the SE 1050 turbine we compare the numerical results with the experiment. The TVD MacCormack method as well as a finite volume composite scheme are extended to a 3D method for solving flows through channels and turbine cascades. 1. Mathematical model We consider the system of 2D Navier-Stokes equations for compressible medium in conservative form: W t + F x + G y = R x + S y , W =[ρ, ρu, ρv, e], p =(γ - 1) ( e - 1 2 ρ(u 2 + v 2 ) ) , F =[ρu, ρu 2 + p, ρuv, (e + p)u], G =[ρv, ρuv, ρv 2 + p, (e + p)v], R = [011 12 , uτ 11 + 12 + kT x ], S = [021 22 , uτ 21 + 22 + kT y ], (1) where ρ is the density, (u, v) the velocity vector, e the total energy per unit volume, μ the viscosity coefficient, k is the heat conductivity, p is the pressure, γ is the adiabatic coefficient, and the components of the stress tensor τ are τ 11 = μ 4 3 u x - 2 3 v y , τ 21 = τ 12 = μ (u y + v x ) , τ 22 = μ - 2 3 u x + 4 3 v y . (2) The 2D Euler equations are obtained from the Navier-Stokes equations by setting μ = k = 0.

Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

  • Upload
    others

  • View
    10

  • Download
    0

Embed Size (px)

Citation preview

Page 1: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

Finite Volume Solution of 2D and 3D Euler and

Navier-Stokes Equations

J. Furst, M. Janda, and K. Kozel

Abstract. This contribution deals with the modern finite volume schemessolving the Euler and Navier-Stokes equations for transonic flow problems.We will mention the TVD theory for first order and higher order schemesand some numerical examples obtained by 2D central and upwind schemesfor 2D transonic flows in the GAMM channel or through the SE 1050 turbinecascade of Skoda Plzen.

In the next part two new 2D finite volume schemes are presented. Ex-plicit composite scheme on a structured triangular mesh and implicit schemerealized on a general unstructured mesh. Both schemes are used for the solu-tion of inviscid transonic flows in the GAMM channel and the implicit schemealso for the flows through the SE 1050 turbine cascade using both triangu-lar and quadrilateral meshes. For the case of the flows through the SE 1050turbine we compare the numerical results with the experiment.

The TVD MacCormack method as well as a finite volume compositescheme are extended to a 3D method for solving flows through channels andturbine cascades.

1. Mathematical model

We consider the system of 2D Navier-Stokes equations for compressible mediumin conservative form:

Wt + Fx +Gy = Rx + Sy,W = [ρ, ρu, ρv, e], p = (γ − 1)

(e− 1

2ρ(u2 + v2)

),

F = [ρu, ρu2 + p, ρuv, (e+ p)u], G = [ρv, ρuv, ρv2 + p, (e+ p)v],R = [0, τ11, τ12, uτ11 + vτ12 + kTx], S = [0, τ21, τ22, uτ21 + vτ22 + kTy],

(1)

where ρ is the density, (u, v) the velocity vector, e the total energy per unit volume,µ the viscosity coefficient, k is the heat conductivity, p is the pressure, γ is theadiabatic coefficient, and the components of the stress tensor τ are

τ11 = µ

(4

3ux −

2

3vy

)

, τ21 = τ12 = µ (uy + vx) , τ22 = µ

(

−2

3ux +

4

3vy

)

. (2)

The 2D Euler equations are obtained from the Navier-Stokes equations bysetting µ = k = 0.

Page 2: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

174 J. Furst, M. Janda, and K. Kozel

The system of 3D Euler equations is written also in conservative form (herew is the third component of the velocity vector):

Wt + Fx +Gy +Hz = 0, W = [ρ, ρu, ρv, ρw, e],p = (γ − 1)

(e− 1

2ρ(u2 + v2 + w2)

), F = [ρu, ρu2 + p, ρuv, ρuw, (e+ p)u],

G = [ρv, ρuv, ρv2 + p, ρvw, (e+ p)v], H = [ρw, ρuw, ρvw, ρw2 + p, (e+ p)w].(3)

The system of Euler equations is a set of first order PDE of hyperbolic typewhereas the system of Navier-Stokes equations is a set of second order PDE ofparabolic type.

1.1. Boundary conditions

We assume four types of boundary conditions for the case of Euler equations:

Inlet:: At the inlet we prescribe the direction of the velocity (by the inletangle for the 2D case and by 2 angles for the 3D case), the value of thestagnation density ρ0 and the stagnation pressure p0. We extrapolate thestatic pressure p from inside and compute the other required quantitiesusing the following relations between the stagnation and the static quan-tities:

p0 = p

(

1 +γ − 1

2M2

) γγ−1

ρ0 = ρ

(

1 +γ − 1

2M2

) 1γ−1

where M is the local Mach number defined by M =√u2 + v2 + w2/a

where the local speed of sound is a =√

γp/ρ. For the Navier-Stokesequations we assume ∂T/∂~n = 0 and W∞ given.

Outlet:: At the outlet we prescribe the value of the static pressure p andextrapolate the values of the density ρ and of the velocity vector from theflow field. For the viscous flows we assume again ∂T/∂~n = 0.

Solid wall:: Here we prescribe the non-permeability condition (~u · ~n = 0) forthe inviscid case or ~u = 0 for the case of viscous flows. Here we assumealso the adiabatic walls (i.e. ∂T/∂~n = 0 where T is the temperature).

Periodicity:: Here we prescribe the periodical condition for all componentsof the vector of unknowns W .

2. Numerical methods

2.1. TVD schemes for one-dimensional scalar case

The theory for full nonlinear systems is very complicated and we restrict theanalysis of the numerical method only to the scalar case. We assume the initialvalue problem for the one-dimensional scalar equation

ut + f(u)x = 0 (4)

with the initial condition u(x, 0) = u0(x). This initial value problem is solved for(x, t) ∈ R×R+.

Page 3: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

Solution of 2D and 3D Euler and Navier-Stokes Equations 175

However the theoretical results are not straightforward applicable to non-linear systems and to bounded domains, the simple model case is still importantfor understanding some properties of the numerical methods and as a hint forconstructing good numerical methods for systems.

We approximate the weak solution to (4) by a piecewise constant functionU(x, t) = uni for (i− 1)∆x < x ≤ i∆x and (n− 1)∆t < t ≤ n∆t where ∆x and ∆tare the mesh spacings in the space and time variables. The initial condition u0 iscomputed as

u0i =1

∆x

∫ i∆x

(i−1)∆x

u0(x) dx. (5)

The values uni are computed for n > 0 using the following explicit numericalscheme written in so the called conservation form:

un+1i = uni −∆t

∆x

[

f(uni−p, uni−p+1, ..., u

ni+q)− f(uni−p−1, u

ni−p, ..., u

ni+q−1)

]

(6)

where f is a continuous function of p+ q+1 parameters called the numerical fluxfunction which approximates the physical flux function f in the following sense:

∀v :: f(v, v, ..., v) = f(v). (7)

The analysis of the above mentioned method is complicated even in the one-dimensional scalar case because of the nonlinearity of the flux function f (and

consequently f). Nevertheless, there exist good theoretical backgrounds for certainsubclasses of the general method. Namely, the following facts have been proved:

• the convergence towards the unique (so called viscosity vanishing1) weaksolution of (4) for the class of monotone methods,

• the convergence towards the unique weak solution (4) for the class ofweakly TV bounded methods (see [3] for details),

• the convergence towards the set of all weak solutions 2 of (4) for the classof TVD methods (see [15], [13]).

However the theory of the monotone methods is very strong and is easilyextensible to the multidimensional case, the monotone methods are at most of thefirst order of accuracy. Therefore we prefer the class of TVD methods which isdefined as follows:

Definition 2.1. The numerical method (6) is called total variation diminishing (orsimply TVD), if and only if for each numerical approximation U

TV (un+1) ≤ TV (un) =

+∞∑

i=−∞

|uni+1 − uni |. (8)

1The viscosity vanishing solution is obtained as a limit of solutions to the problems given by theequation uε

t + f(uε)x = εuεxx for ε → 0+.

2The uniqueness of the solution follows from Coquel’s-LeFloch’s theorem for the weakly TV

bounded methods.

Page 4: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

176 J. Furst, M. Janda, and K. Kozel

Let us consider a general one-dimensional method of the form

un+1i = uni − Ci− 12(uni − uni−1) +Di+ 1

2(uni+1 − uni ), (9)

then the following theorem of Harten [15] can be used to check the TVD property.

Lemma 2.2 (Harten,1983). Let the following conditions be fulfilled ∀i ∈ Z:

Ci− 12≥ 0, Di+ 1

2≥ 0, Ci+ 1

2+Di+ 1

2≤ 1. (10)

Then the numerical method (9) is TVD.

This lemma gives some hints how to correct some classical high order methodsin order to be TVD. Unfortunately, this lemma is valid only for the one-dimensionalcase. In fact, Goodman and LeVeque show in [12], that the TVD property in themultidimensional case implies only a first order accuracy.

In spite of their result, many methods based on one-dimensional high orderTVD methods have been constructed for practical multidimensional problems.Although they are not TVD, they remain high order for smooth solutions andusually do not generate oscillations near discontinuities.

For practical computations we use the MacCormack predictor-corrector schemebecause of its simple implementation especially for nonlinear systems. The TVDMacCormack scheme has for one-dimensional scalar problem the following form:

un+ 1

2

i = uni −∆t

∆x

(f(uni )− f(uni−1)

), (11)

un+1i =1

2

[

uni + un+ 1

2

i − ∆t

∆x

(

f(un+ 1

2

i+1 )− f(un+ 1

2

i ))]

, (12)

un+1i = un+1i +[G+(r+i ) +G−(r−i+1)

](uni+1 − uni )−

−[G+(r+i−1) +G−(r−i )

](uni − uni−1) (13)

with G± defined by

G±(r±i ) =|f ′(uni )|∆t

2∆x(1− |f

′(uni )|∆t

∆x)[1− Φ(r±i )

](14)

and

Φ(r±i ) = max(0,min(2r±i , 1)

). (15)

2.2. Extension to the 2D scalar case

The scalar initial value problem for the 2D problem is given by the equationut + f(u)x + g(u)y = 0 with the initial condition u(x, y, 0) = u0(x, y). We againsolve this problem in the unbounded domain (x, y, t) ∈ R×R×R+.

For a two-dimensional scalar case we analyzed in [9] a class of monotoneschemes (especially the so called l1-contractive schemes) and published in [11] thefollowing lemma:

Page 5: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

Solution of 2D and 3D Euler and Navier-Stokes Equations 177

Lemma 2.3. Let there exist functions fk of 2(p+ q + 1) parameters such that

f(uni−p, ..., uni+q)− f(vni−p, ..., v

ni+q) =

=

q∑

k=−p

fk(uni−p, ..., u

ni+q, v

ni−p, ..., v

ni+q)(u

ni+k − vni+k) (16)

for arbitrary u and v. If the functions fk satisfy the conditions

f0(uni−p, ..., u

ni+q, v

ni−p, ..., v

ni+q)− f1(u

ni−p−1, ..., u

ni+q−1, v

ni−p−1, ..., v

ni+q−1) ≤

∆x

∆t(17)

and for each k 6= 0 (we set fk = 0 for k < −p and k > q) the relations

fk(uni−p, ..., u

ni+q, v

ni−p, ..., v

ni+q) ≤ fk+1(u

ni−p−1, ..., u

ni+q−1, v

ni−p−1, ..., v

ni+q−1)

(18)are valid, then the scheme (6) is monotone (and hence TVD).

This lemma (as well as its multidimensional variant) is proved for examplein [9].

A similar lemma is valid also for multidimensional problems. Let us consideronly the two-dimensional case. The total variation is defined in the this case by:

TV (un) = ∆y∑

i,j

|uni+1,j − uni,j |+∆x∑

i,j

|uni,j+1 − uni,j |. (19)

Let the mesh steps be the same for both coordinates i.e. ∆x = ∆y. The weaksolution is approximated by a piecewise constant function U(x, y, t) = uni,j for(i − 1)∆x < x ≤ i∆x, (j − 1)∆y < y ≤ j∆y, and (n − 1)∆t < t ≤ n∆t.

The functions fk and gk depend in a similar way as in the one-dimensionalproblem on 2(p + q + 1) parameters uni−p,j ,...,u

ni+q,j , vni−p,j ,...,v

ni+q,j for fk and

uni,j−p, ..., uni,j+q, v

ni,j−p, ..., v

ni,j+q for gk.

Lemma 2.4. Let there exist functions fk and gk of 2(p + q + 1) parameters suchthat

f(uni−p,j , ..., uni+q,j)−f(vni−p,j , ..., v

ni+q,j) =

q∑

k=−p

fk(uni−p,j , ..., v

ni+q,j)(u

ni+k,j−vni+k,j)

(20)

g(uni,j−p, ..., uni,j+q)−g(vni,j−p,, ..., v

ni,j+q) =

q∑

k=−p

gk(uni,j−p, ..., v

ni,j+q)(u

ni,j+k−vni,j+k)

(21)

for each arbitrary u and v. If the functions fk and gk satisfy the conditions

f0(uni−p,j , ..., v

ni+q,j) − f1(u

ni−p−1,j , ..., v

ni+q−1,j) + (22)

g0(uni,j−p, ..., v

ni,j+q) − g1(u

ni,j−p−1, ..., v

ni,j+q−1) ≤

∆x

∆t

Page 6: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

178 J. Furst, M. Janda, and K. Kozel

and for each k 6= 0 (we set fk = 0 and fk = 0 for k < −p and k > q)

fk(uni−p,j , ..., v

ni+q,j) ≤ fk+1(u

ni−p−1,j , ..., v

ni+q−1,j), (23)

gk(uni,j−p, ..., v

ni,j+q) ≤ gk+1(u

ni,j−p−1, ..., v

ni,j+q−1) (24)

then the scheme

un+1i,j = uni,j −∆t

∆x

(

fni+ 12,j − fni− 1

2,j

)

− ∆t

∆y

(

gni,j+ 12

− gni,j− 12

)

, (25)

fni+ 12,j = f(uni−p,j , u

ni−p+1,j , ..., u

ni+q,j), gni,j+ 1

2

= g(uni,j−p, uni,j−p+1, ..., u

ni,j+q)

is monotone (and hence TVD).

Unfortunately it is not possible to construct a high order TVD scheme formultidimensional problem [12]. The uniform TVD bound is too restrictive andtherefore one should consider following approach analyzed for example by Coqueland LeFloch in [4, 3]. Let us assume a two-dimensional conservative scheme of theform:

un+1i,j = uni,j −∆t

∆x

(

fni+ 12,j − fni− 1

2,j

)

− ∆t

∆y

(

gni,j+ 12

− gni,j− 12

)

, (26)

with ∆x = ∆y = const.∆t and consistent with the equation ut+f(u)x+g(u)y = 0.

Theorem 2.5 (Coquel, LeFloch 1991). Let the numerical fluxes fni+ 1

2,jand gn

i,j+ 12

can be split onto two parts fni+ 1

2,j

= pni+ 1

2,j+ ∆x∆t a

ni+ 1

2,jand gn

i,j+ 12

= qni,j+ 1

2

+∆y∆t b

ni,j+ 1

2

with p and q being monotone fluxes (e.g. first order Lax-Friedrichs type)

and a and b being antidiffusive high order corrections. If there exist for a finitetime T > 0 constants C > 0 and M > 0 independent of ∆t (and consequentlyindependent of ∆x and ∆y) such that

||uni,j ||∞ < C, |ani+ 12,j | < M∆xα, |bni,j+ 1

2

| < M∆yα, (27)

with n∆t < T and α ∈ ( 23 , 1), then the piecewise constant function with the valuesgiven by uni,j converges to the unique entropy solution when ∆t→ 0.

Example 2.6 (2D version of the scheme proposed by Davis). Let us suppose the 2Dscheme for the two-dimensional linear equation proposed by Davis ut+cux+duy =0 :

un+1i,j = uni,j − c∆t

2∆x(uni+1,j − uni−1,j) + c2

∆t2

2∆x2(uni+1,j − 2uni,j + uni−1,j) +

+ K(r+i,j , r−i+1,j)(u

ni+1,j − uni,j)−K(r+i−1,j , r

−i,j)(u

ni,j − uni−1,j)− (28)

− d∆t

2∆y(uni,j+1 − uni,j−1) + d2

∆t2

2∆y2(uni,j+1 − 2uni,j + uni,j−1) +

+ K(s+i,j , s−i,j+1)(u

ni,j+1 − uni,j)−K(s+i,j−1, s

−i,j)(u

ni,j − uni,j−1) (29)

Page 7: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

Solution of 2D and 3D Euler and Navier-Stokes Equations 179

where

K(r+i,j , r−i+1,j) =

|c|∆t

2∆x(1− |c|∆t

∆x)[

1− Φ(r+i,j , r−i+1,j)

]

(30)

K(s+i,j , s−i,j+1) =

|c|∆t

2∆y(1− |c|∆t

∆y)[

1− Φ(s+i,j , s−i,j+1)

]

(31)

Φ(r+i,j , r−i+1,j) = max

(0,min(2r+i,j , r

−i+1,j , 1),min(r+i,j , 2r

−i+1,j , 1)

)(32)

Φ(s+i,j , s−i,j+1) = max

(0,min(2s+i,j , s

−i,j+1, 1),min(p+i,j , 2p

−i,j+1, 1)

)(33)

r+i,j = (uni,j − uni−1,j)/(uni+1,j − uni,j) (34)

r−i,j = (uni+1,j − uni,j)/(uni,j − uni−1,j) (35)

s+i,j = (uni,j − uni,j−1)/(uni,j+1 − uni,j) (36)

s−i,j = (uni,j+1 − uni,j)/(uni,j − uni,j−1). (37)

Let us replace Φ by the new limiter:

Φ(r+i,j , r−i+1,j) = min

(

Φ(r+i,j , r−i+1,j),

M ′∆xα

|uni+1,j − uni,j |

)

(38)

Φ(s+i,j , s−i,j+1) = min

(

Φ(s+i,j , s−i,j+1),

M ′∆yα

|uni,j+1 − uni,j |

)

. (39)

Then the antidiffusive fluxes a and b are bounded by M ′∆xα and M ′∆yα respec-tively and the modification of the two-dimensional scheme is convergent.

Similar theorem is valid also for three-dimensional case.

2.3. TVD schemes for hyperbolic systems

Let us consider a linear system

Wt +AWx = 0. (40)

The solution is now a vector-valued function W : R × R+ → R

m (m is thenumber of equations) and A is an m×m constant matrix. The system (40) is calledhyperbolic if the matrix A has m real eigenvalues and m linearly independent righteigenvectors. In that case, we can decompose the matrix A into

A = RΛR−1 (41)

where R is the regular matrix composed of the eigenvectors of A and Λ is thediagonal matrix containing the eigenvalues of A (Λ = diag(a(1), ..., a(m))).

Let us define a new set of variables by V = R−1W (we call it the characteristicvariables). Multiplying the original system (40) by R−1 one gets

R−1Wt +R−1AWx = 0 (42)

and hence, using the characteristic variables,

Vt + ΛVx = 0 (43)

Page 8: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

180 J. Furst, M. Janda, and K. Kozel

which is a set of m independent scalar problems. For each component we can usethe TVD MacCormack scheme defined in the previous section. In order to get theTVD MacCormack scheme for the original variables W , we multiply the schemewritten for the characteristic variables V by the matrix R. Finally, we get

Wn+ 1

2

i = Wni −

∆t

∆x

(AWn

i −AWni−1

), (44)

Wn+1i =

1

2

[

Wni +W

n+ 12

i − ∆t

∆x

(

AWn+ 1

2

i+1 −AWn+ 1

2

i

)]

, (45)

Wn+1i = Wn+1

i +R[

G+(r+i ) + G−(r−i+1)]

R−1(Wni+1 −Wn

i )−

−R[

G+(r+i−1) + G−(r−i )]

R−1(Wni −Wn

i−1). (46)

Here r±i are vectors with m components

(r+i )(l) =

(R−1(Wn

i −Wni−1)

)(l)/(R−1(Wn

i+1 −Wni ))(l)

, (47)

(r−i )(l) =

(R−1(Wn

i+1 −Wni ))(l)

/(R−1(Wn

i −Wni−1)

)(l), (48)

where r(l) denotes the l-th component of the vector r.The viscosity coefficients G are m ×m diagonal matrices with the elements

given by

G±(r±i )(l,l) =

1

2

|a(l)|∆t

∆x(1− |a

(l)|∆t

∆x)[1− Φ((r±i )

(l))]. (49)

In order to avoid the evaluation of eigenvectors of the Jacobian matrix A weuse the so called simplified TVD scheme proposed by D. M. Causon in [2] whichis for the case of the one-dimensional nonlinear system written as:

Wn+ 1

2

i = Wni −

∆t

∆x

(F (Wn

i )− F (Wni−1)

), (50)

Wn+1i =

1

2

[

Wni +W

n+ 12

i − ∆t

∆x

(

F (Wn+ 1

2

i+1 )− F (Wn+ 1

2

i ))]

, (51)

Wn+1i = Wn+1

i +[

G+(r+i ) +G

−(r−i+1)

]

(Wni+1 −Wn

i )−

−[

G+(r+i−1) +G

−(r−i )

]

(Wni −Wn

i−1) (52)

with G±

and r± given by the formulas

r+i =<Wn

i −Wni−1,W

ni+1−W

ni >

<Wni+1−W

ni ,W

ni+1−W

ni >

, r−i =<Wn

i −Wni−1,W

ni+1−W

ni >

<Wni −W

ni−1,W

ni −W

ni−1>

,

G±(r±i ) = 1

2C(νi)[1− Φ(r±i )

], C(νi) =

νi(1− νi), νi ≤ 0.50.25, νi > 0.5,

νi = ρAi

∆t∆x .

(53)Here < ., . > denotes the standard inner (scalar) product in R

m and ρAiis the

spectral radius of the Jacobi matrix ∂F/∂W at the point Wi (for the case of the

Page 9: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

Solution of 2D and 3D Euler and Navier-Stokes Equations 181

Euler equations, ρAi= |ui|+ ci where ui is the local flow speed and ci is the local

sound speed.

3. Composite schemes

In the simplest 1D case there exist two forms of Lax-Friedrichs (LF) scheme:

1. standard one-step version (non-staggered scheme):

Wn+1i =

1

2(Wn

i+1 +Wni−1)−

∆t

2∆x(Fni+1 − Fn

i−1), (54)

2. two-step version (staggered scheme):

W ∗i+1/2 =

1

2(Wn

i+1 +Wni )−

∆t

2∆x(Fni+1 − Fn

i ), (55)

Wn+1i =

1

2(W ∗

i+1/2 +W ∗i−1/2)−

∆t

2∆x(F ∗i+1/2 − F ∗i−1/2). (56)

The two-step Lax-Wendroff (LW) scheme can be written as:

1. non-staggered scheme:

W ∗i = Wn

i −∆t

4∆x(Fni+1 − Fn

i−1) + ε(Wni+1 − 2Wn

i +Wni−1), (57)

Wn+1i = Wn

i −∆t

2∆x(F ∗i+1 − F ∗i−1), (58)

2. or staggered scheme:

W ∗i+1/2 =

1

2(Wn

i+1 +Wni )−

∆t

2∆x(Fni+1 − Fn

i ), (59)

Wn+1i = Wn

i+1 −∆t

∆x(F ∗i+1/2 − F ∗i−1/2). (60)

The one-dimensional composite scheme LWLFN is given by (N-1) LW stepsfollowed by one LF step:

Wn+N = LF LW LW ... LW︸ ︷︷ ︸

N−1

Wn. (61)

The extension for two-dimensional case is done using the finite volume ap-proach. Let us assume a triangular mesh with triangles denoted by Ti. The cell-centered LF scheme corresponding to the one-dimensional LF non-staggered sche-me is given by:

Wn+1i =

1

3

3∑

k=1

Wnk −

∆t

µi

3∑

k=1

(Fnk,i∆yk −Gn

k,i∆xk) (62)

where µi =∫ ∫

Tidx dy, Fn

k,i = (Fnk + Fn

i )/2, Gnk,i = (Gn

k + Gni )/2 and Wn

k is the

value of W at the one of three neighboring triangles Tk of the triangle Ti.

Page 10: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

182 J. Furst, M. Janda, and K. Kozel

For the two-step LW scheme one has:

Wn+1/2i =

1

3

3∑

k=1

Wnk −

∆t

2µi

3∑

k=1

(Fnk,i∆yk −Gn

k,i∆xk), (63)

Wn+1i = Wn

i −∆t

µi

3∑

k=1

(Fn+1/2k,i ∆yk −G

n+1/2k,i ∆xk). (64)

The cell-vertex corresponding to the one-dimensional staggered version hasthe following form (assuming for simplicity that six triangles meet at each vertex):

LF:

W ∗i =

1

3

3∑

k=1

Wn0,k −

∆t

2µi

3∑

k=1

(Fk∆yk − Gk∆xk), (65)

Fk =1

2(F0,k+1 − F0,k), Gk =

1

2(G0,k+1 −G0,k),

Wn+10,k =

1

6

6∑

i=1

W ∗i −

∆t

2µ0,k

6∑

i=1

(F ∗i ∆yi − G∗i∆xy), (66)

F ∗i =1

2(F ∗i+1 − F ∗i ), G∗i =

1

2(G∗i+1 −G∗i ).

LW scheme uses the same first step as the above described LF scheme and thesecond step is of the form:

Wn+10,k = Wn

0,k −∆t

2µ0,k

6∑

i=1

(F ∗i ∆yi − G∗i∆xy). (67)

Here W0,k are located at the vertices V0,k of the triangle Ti and W ∗i are located

at the centers of gravity Pi of triangles Ti.

The composite scheme consists again as N − 1 steps of LW scheme followedby one LF step. The value of N is determined by numerical testing. The cell vertexscheme was also extended to three-dimensional case.

Remark: Composite schemes were introduced by R. Liska and B. Wendroff fora 2D nonlinear hyperbolic problem solved by finite difference methods on an or-thogonal grid. The idea is following: in many high order schemes one has to addsome artificial viscosity terms in order to achieve solution without oscillations nearshock waves or steep gradients. Composite schemes use certain number of a highorder scheme (with low value of artificial viscosity) and the arising oscillations arethen smeared by one step of a more dissipative scheme (for example Lax-Friedrichsscheme).

We extended the original finite difference schemes to 2D and 3D finite volumemethod of the cell centered or cell vertex form [14].

Page 11: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

Solution of 2D and 3D Euler and Navier-Stokes Equations 183

4. Implicit finite volume method for 2D inviscid flows

The numerical solution is again obtained by the finite volume approach: The do-main Ω is approximated by a polygonal domain Ωh and this polygonal domain isdivided into m polygonal convex cells3 Ci possess the following property:

Ωh =m⋃

i=1

Ci and Ci ∩ Cj = ∅ for i 6= j .

i2

i3

i4

i5 i1i1

i2

i3

i4

i5

i

S

S

S

S

S

Figure 1. Unstructured gridwith mixed type of cells.

Figure 1 shows a sample of such adomain divided into 13 triangular, quadri-lateral, and pentagonal cells. Let mi de-note the number of cells adjacent to Ci (i.e.number of cells that share an edge with thecell Ci) and let the set Ni = i1, i2, ..., imi

contain their indices (see Fig. 1 where mi =5). Next, let us denote by Binlet

i the set ofedges shared by the cell Ci and the inletboundary Γinleth of Ωh; similarly for Boutlet

i

and Bwalli .

The basic finite volume scheme is ob-tained in the usual way: integrating the conservation law in a cell Ci, applyingGreen’s theorem and approximating the integral over the boundary of Ci by thenumerical flux functions. The scheme is then

Wn+1i = Wn

i −∆tR1(Wn)i. (68)

Here Wni stands for the approximation of the solution in the cell Ci at a time

t = n∆t and R1(Wn)i is the component of the residual vector computed as

R1(Wn)i =1

µ(Ci)

j∈Ni

H(Wni ,Wn

j , ~Si,j) +∑

b

e∈Bbi

Hb(Wni , ~Se)

. (69)

The superscript 1 denotes the first order approximation, µ(Ci) is the volume of

the cell Ci, ~Si,j denotes the outer normal vector to the common edge between Ciand Cj , the function H is the numerical flux, b denotes the type of the boundaryconditions and belongs to the set b ∈ inlet, outlet, wall, Hb is the numerical flux

through the boundary and ~Se denotes the outer normal vector to the boundary

edge e. Both vectors ~Si,j and ~Se have the length equal to the length of the cor-

responding edge. The numerical flux H(W ni ,Wn

j , ~Si,j) in the previous formula isthe numerical approximation of the integral of the physical flux function over the

3Since the structured grid can be viewed from the mathematical point of view as a special case

of the unstructured grid, we present only the scheme for unstructured meshes.

Page 12: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

184 J. Furst, M. Janda, and K. Kozel

common edge ei,j shared between Ci and Cj :

H(Wni ,Wn

j , ~Si,j) ≈∫

ei,j

ρuρu2 + pρuv

(e+ p)u

nx +

ρvρuv

ρv2 + p(e+ p)v

ny

dS (70)

where nx and ny are the components of the unit normal vector to the edge ei,joriented as the outer normal for the cell Ci. Analogous, Hb(Wn

i , ~Se) is the approx-imation of the flux through the edge on the boundary.

4.1. First order implicit scheme

As a building block for the implicit scheme we choose the first order finite volumescheme based on Osher’s flux and the related approximate Riemann solver (see[16]). The advantage of the Osher flux is that one can evaluate simply the Jacobiansof the numerical flux function which are needed for the implicit scheme.

The usual explicit first order scheme is then

Wn+1 = Wn −∆tR1(Wn) (71)

and the implicit scheme is obtained from the explicit version (68) by replacingR1(Wn) by R1(Wn+1):

Wn+1i = Wn

i −∆tR1(Wn+1)i. (72)

The operator R is nonlinear, so we can’t solve this equation directly. Therefore welinearize the equation at the point W n:

Wn+1 = Wn −∆t

(

R1(Wn) +∂R1

∂W

(Wn+1 −Wn

))

, (73)

hence,(

I

∆t+

∂R1

∂W

)(Wn+1 −Wn

)= −R1(Wn). (74)

The matrix ∂R1

∂W is evaluated at the point W n using the expressions for the Ja-

cobian matrices of Osher’s flux functions ∂H(WL,WR,~S)∂WL

and ∂H(WL,WR,~S)∂WR

and theappropriate Jacobian matrices of boundary fluxes.

The resulting system of linearized equations is solved using a GMRES methodpreconditioned with the ILU decomposition.

4.2. Second order semi-implicit scheme

In order to improve the accuracy of the basic first order scheme we use a piecewiselinear reconstruction of the solution (for details see [10]). The second order semi-implicit scheme uses the high order residual R2 on the right hand side (explicitpart) and the matrix on the left hand side is computed from the low order residual:

(I

∆t+

∂R1

∂W

)(Wn+1 −Wn

)= −R2(Wn). (75)

Page 13: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

Solution of 2D and 3D Euler and Navier-Stokes Equations 185

The second order residual R2 is computed in the following way: we computefirst the approximation of the gradient of the solution gradW n in each cell 4 andthen using this gradient we define the second order residual vector by

WLi,j = Wn

i + (~xi,j − ~xi) · gradWni , (76)

WRi,j = Wn

j + (~xj,i − ~xj) · gradWnj ,

R2(Wn)i =1

µ(Ci)

j∈Ni

H(WLi,j ,W

Ri,j , ~Si,j) +

b

e∈Bbi

Hb(WLi,j , ~Se)

,

where ~xi is the center of gravity of the cell i and ~xi,j is the center of the commonedge between the cells i and j. The numerical fluxes H and Hb are computed inthe same way as for the first order scheme (i.e. using Osher’s Riemann solver) butinstead of Wi and Wj we use the interpolated values WR

i,j and WLi,j .

In the steady case one hasR2(Wn) = 0 and therefore the scheme is high order.Moreover, as the second order residual is of ENO type, the stationary solution isessentially non-oscillatory. In the unsteady case the scheme is only low order dueto replacing R2 by R1 in the implicit part.

5. 2D transonic inviscid flow through a channel and a turbine

cascade

5.1. Transonic flow through the 2D test channel with a bump

As a first test case we choose the transonic flow through the two-dimensional testchannel with a bump, i.e. the so-called Ron-Ho-Ni channel. This is a well-knowntest case and it was solved by many researchers. See for example [5], [6].

0.4

0.6

0.8

1

1.2

1.4

-1 -0.5 0 0.5 1 1.5 2

Mac

h nu

mbe

r

x

Causon’s schemeFull TVD scheme

(a) TVD MacCormack

scheme

0.4

0.6

0.8

1

1.2

1.4

-1 -0.5 0 0.5 1 1.5 2

Mac

h nu

mbe

r

x

Implicit scheme

(b) Implicit scheme (c) Composite scheme

Figure 2. Distribution of the Mach number along the lower andupper walls for the 2D channel.

4The evaluation of the gradients is described in in detail [10].

Page 14: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

186 J. Furst, M. Janda, and K. Kozel

We use the structured mesh with 120 × 30 quadrilateral cells for the TVDMacCormack scheme, an unstructured triangular mesh with 4424 triangles (withrefinement in the vicinity of the shock wave) for the implicit scheme and a struc-tured triangular mesh with 10800 triangles for the composite scheme. At the inlet(x = −1) we prescribe the stagnation pressure p0 = 1, the stagnation densityρ0 = 1 and the inlet angle α1 = 0. At the outlet we keep the pressure p2 = 0.737.The upper (y = 1) and lower part are solid walls.

Figure 2(a) shows the distribution of the Mach number along the upperand the lower wall after 30000 iterations of two above mentioned variants of theMacCormack scheme with CFL = 0.5 while figure 2(b) shows the results obtainedby the implicit scheme and figure 2(c) by the composite scheme.

We can see that the results obtained by the full TVD MacCormack schemeare quite good. Causon’s simplified scheme uses too much artificial dissipation.

5.2. Transonic flow through the 2D turbine cascade SE 1050

Next we solve the transonic flow through the 2D turbine cascade SE 1050 givenby Skoda Plzen. Figure 3 shows the results of the interferometric measurementobtained for the inlet Mach number M1 = 0.395 [17]. One can see the characteristicstructure of the shock waves emitted from the outlet edge and the reflected shockwaves. Moreover, one can notice the recompression zone on the suction side ofthe blade. Our computation was performed on a structured mesh with 200 × 40quadrilateral cells for the full TVD MacCormack scheme (see Fig. 4(a)) and on anunstructured mesh with 7892 triangles for the implicit scheme (Fig. 4(b)).

Figure 3. Interferometric measurement of SE 1050

5.3. Laminar viscous flow through a 2D turbine cascade

Next we solve the transonic viscous flow through the DCA 8% cascade. We considerthe flow with the non-dimensional viscosity µ = 10−4 which gives, for the inletconditions p0 = 1, ρ0 = 1, α1 = 2o and outlet pressure p2 = 0.48, the value of

Page 15: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

Solution of 2D and 3D Euler and Navier-Stokes Equations 187

(a) TVD MacCormack scheme,

structured grid

(b) Implicit scheme, unstructured

grid

Figure 4. Distribution of the Mach number in a 2D turbine cascade

the Reynolds number Re = 6450, inlet Mach number M1 = 0.76 and outlet Machnumber M2 = 1.03.

We use a simple structured mesh with 90 × 50 quadrilateral cells refinedin the vicinity of profiles. Figure 5 shows the results obtained by an improvedversion of Causon’s scheme 5 after 50000 and 50200 iterations. We can see thatthe solution is non-stationary (see the changes in the shape of the wake). Similarnon-stationary solution was obtained also by using a finite difference ENO scheme[1]. Let us mention that these flow conditions (it means relatively low Reynoldsnumber and high Mach number) are not interesting for practical applications. Wehave done this computation in order to show that the effects of artificial viscositycan be very important for a viscous flow calculation. As a matter of fact, a similarcase was formerly solved by M. Hunek and K. Kozel [8] using an implicit residualaveraging method. Their method gave stationary results whereas our computationleads to a non-stationary solution. This is probably due to the fact, that theresidual smoothing method uses too much artificial viscosity.

5The so called modified scheme which we published for example in [11].

Page 16: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

188 J. Furst, M. Janda, and K. Kozel

(a) 50000 time steps (b) 50200 time steps

Figure 5. Isolines of Mach number for the non-stationary lami-nar transonic flow through the DCA 8% cascade.

6. 3D inviscid transonic flows

6.1. 3D transonic flow through a channel

The 2D composite scheme of cell-vertex type was extended to 3D case using thefollowing finite volume mesh given by fig. 6. Figure 6(a) shows basic finite volume,fig. 6(b) shows the dual finite volume and fig. 6(c) shows the global 3D basic mesh.We used 180×30×12 mesh and 3D channel was changed by bump with the height

(a) Basic cell (b) Dual cell (c) Global mesh

Figure 6. 3D finite volume mesh for composite schemes.

equal to 0.18 at z = 0 decreasing to 0.10 at z = 1. Figure 7 shows Mach numberdistribution in the planes z = const.. Figure 7(a) shows the solution at the wallwith the bump (with the shock wave) and smooth solution at the upper wall.Figure 7(b) shows the change of the strength of the shock wave for z between 0and 1. Here we use 25 steps of LW scheme followed by 1 LF step.

6.2. 3D transonic flow through a turbine cascade

The three-dimensional Causon’s scheme and its improved variant are used for thecomputation of the transonic flow through the stator stage of the real 3D turbinegiven by Skoda Plzen company.

Page 17: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

Solution of 2D and 3D Euler and Navier-Stokes Equations 189

(a) Mach number along the walls (b) Mach number along

the lower wall (projec-

tions)

Figure 7. Mach number distribution in 3D channel

At the inlet we prescribe the stagnation pressure p0(r) = 0.38274, stagnationdensity ρ0(r) = 1. The direction of the velocity at the inlet is given by two anglesα1(r) and µ1(r).

We use a structured mesh with 90× 24× 17 hexahedral cells. Figure 8 showsdistribution of the Mach number obtained by the above mentioned modificationof 3D Causon’s scheme. Figures 9(a)-10(b) show the distribution of the Machnumber for different section and on the pressure and suction side of the blade.Similar results were obtained by J. Fort and J. Halama [7] by using a cell vertexscheme of Ni.

References

[1] Philippe Angot, Jirı Furst, and Karel Kozel. TVD and ENO schemes for multidimen-sional steady and unsteady flows. a comparative analysis. In Fayssal Benkhaldounand Roland Vilsmeier, editors, Finite Volumes for Complex Applications. Problems

and Perspectives, pages 283–290. Hermes, july 1996.

[2] D. M. Causon. High resolution finite volume schemes and computational aerody-namics. In Josef Ballmann and Rolf Jeltsch, editors, Nonlinear Hyperbolic Equations

- Theory, Computation Methods and Applications, volume 24 of Notes on Numerical

Fluid Mechanics, pages 63–74, Braunschweig, March 1989. Vieweg.

[3] Frederic Coquel and Philippe Le Floch. Convergence of finite difference schemesfor conservation laws in several space dimensions: the corrected antidiffusive fluxapproach. Mathematics of computation, 57(195):169–210, july 1991.

[4] Frederic Coquel and Philippe Le Floch. Convergence of finite difference schemes forconservation laws in several space dimensions: a general theory. SIAM J. Numer.

Anal., 30(3):675–700, June 1993.

[5] Vıt Dolejsı. Sur des methodes combinant des volumes finis et des elements finis pour

le calcul d’ecoulements compressibles sur des maillages non structures. PhD thesis,L’Universite Mediterranee Marseille et Univerzita Karlova Praha, 1998.

Page 18: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

190 J. Furst, M. Janda, and K. Kozel

XY

Z

Figure 8. Mach number distribution in the 3D turbine.

[6] Miloslav Feistauer, Jirı Felcman, and Maria Lukacova-Medvidova. Combined finiteelement-finite volume solution of compressible flow. Journal of Computational and

Applied Mathemetics, (63):179–199, 1995.

[7] J. Fort, J. Halama, A. Jirasek, M. Kladrubsky, and K. Kozel. Numerical solution ofseveral 2d and 3d internal and external flow problems. In R. Rannacher M. Feistauerand K. Kozel, editors, Numerical Modelling in Continuum Mechanics, pages 283–291,September 1997.

[8] Jaroslav Fort, Milos Hunek, Karel Kozel, J. Lain, Miroslav Sejna, and MiroslavaVavrincova. Numerical simulation of steady and unsteady flows through plane cas-cades. In S. M. Deshpande, S. S. Desai, and R. Narasimha, editors, Fourteenth In-

ternational Conference on Numerical Methods in Fluid Dynamics, Lecture Notes inPhysics, pages 461–465. Springer, 1994.

[9] Jirı Furst. Modern difference schemes for solving the system of Euler equations.Diploma thesis, Faculty of Nuclear Science and Physical Engineering, CTU Prague,1994. (in czech).

[10] Jirı Furst. Numerical modeling of the transonic flows using TVD and ENO schemes.PhD thesis, CVUT v Praze and l’Universit de la Mditerrane, Marseille, 2000. inpreparation.

[11] Jirı Furst and Karel Kozel. Using TVD and ENO schemes for numerical solutionof the multidimensional system of Euler and Navier-Stokes equations. In Pitman

Research Notes, number 388 in Mathematics Series, 1997. Conference on Navier-Stokes equations, Varenna 1997.

Page 19: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

Solution of 2D and 3D Euler and Navier-Stokes Equations 191

(a) Hub (k = 1) (b) Middle (k = 9)

(c) Tip (k = 18)

Figure 9. Distribution of Mach number for the sections k = const.

Page 20: Finite Volume Solution of 2D and 3D Euler and …marian.fsik.cvut.cz/~furst/reports/marseille.pdfFinite Volume Solution of 2D and 3D Euler and Navier-Stokes Equations J.Furst,˜ M.Janda,andK.Kozel

192 J. Furst, M. Janda, and K. Kozel

(a) Mach number distribution on

the pressure side of the blade (b) Mach number distribution on

the suction side of the blade

Figure 10. Distribution of Mach number on the blade

[12] J.B. Goodman and R.J. LeVeque. On the accuracy of stable schemes for 2D scalarconservation laws. Math. Comp., 45:503–520, 1988.

[13] Ami Harten. High resolution schemes for hyperbolic conservation laws. Journal ofComputational Physics, 49:357–393, 1983.

[14] Michal Janda, Karel Kozel, and Richard Liska. Composite schemes on triangularmeshes. In Proceedings of HYP 2000, Magdeburg, March 2000. to appear.

[15] Randall J. Le Veque. Numerical Methods for Conservation Laws. Birkhauser Verlag,Basel, 1990.

[16] Stanley Osher and Sukumar Chakravarthy. Upwind schemes and boundary condi-tions with applications to Euler equations in general geometries. J. Comp. Phys.,(50):447–481, 1983.

[17] M. Stastny and P. Safarık. Experimental analysis data on the transonic flow past aplane turbine cascade. ASME Paper, (91-GT-313), 1990.

Acknowledgment: This work was supported by grants No. 101/98/K001, 201/99/0267 of

GACR and by the Research Plan MSM 98/210000010.

Department of Technical Mathematics,Faculty of Mechanical Engineering,Czech Tecnical University,Karlovo nam. 13121 35, Praha, Czech RepublicE-mail address: [email protected]