• 沒有找到結果。

6.3 Entropy and Monotone schemes

7.1.2 Other Examples for φ(θ)

1. φ(θ) = 1. This is the Lax-Wendroff scheme.

2. φ(θ) = θ. This is Beam-Warming.

3. Anyφ between φB−W andφL−W with0 ≤ φ ≤ 2, 0 ≤ φ(θ)θ ≤ 2 is second order.

4. Van Leer’s minmod

φ(θ) = θ + |θ|

1 + |θ|. It is a smooth limiter withφ(1) = 1.

5. Roe’s superbee

φ(θ) = max(0, min(1, 2θ), min(θ, 2))

7.1. FLUX SPLITTING METHODS 89

There are two kinds of extensions. One is thea < 0 case, and the other is the linear system case.

Fora < 0, we let

In the linear system case, our equation is

ut+ Aux= 0. (1.3)

We can decompose A so that A = RΛR−1 with Λ = diag(λ1, · · · , λn) constituting by A’s

7.2 High Order Godunov Methods

Algorithm

1. Reconstruction: start from cell averages{Ujn}, we reconstruct a piecewise polynomial func-tionu(x, t˜ n).

If 2. is an exact solver, using Z tn+1

7.2. HIGH ORDER GODUNOV METHODS 91 3’. Ujn+1= Ujn+∆x∆t( ˜fj−1

2 − ˜fj+1 2)

1. Reconstruction: We want to construct a polynomial in each cell. The main criterions are (1) high order in regions whereu is smooth and ux 6= 0

(2) total variation no increasing.

In other words, suppose we are given a functionu(x), let Uj = 1

∆x Z xj+ 1

2

xj− 1

2

u(x) dx

From {Uj}, we can use some reconstruct algorithm to construct a function ˜u(x). We want the reconstruction algorithm to satisfy

(1) |˜u(x) − u(x)| = O(∆x)r, whereu is smooth in Ij = (xj−1 2, xj+1

2) and ux 6= 0 near Ij. (2) T.V.˜u(x) ≤ T.V.u(x)(1 + O(∆x))

7.2.1 Piecewise-constant reconstruction

Our equation is

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

Following the algorithm, we have

(1) approximate u(t, x) by piecewise constant function, i.e., {Ujn} represents the cell average of u(x, tn) over (xj−1

2, xj+1 2).

xj−1

2 xj+1

2

∆x

(2) solve Riemann problem (uj, uj+1) on the edge xj+1

2, its solutionu(x˜ j+1

2, t),tn < t < tn+1can be found, which is a constant.

(3) integrate the equation (2.4) over(xj−1

Riemann problem givesu(x, t) =˜

( uj ifx − xj+12 < at, tn < t < tn+1 This is precisely the upwind scheme.

Example 2 Linear system

7.2. HIGH ORDER GODUNOV METHODS 93

Therefore the structure of the solution of Riemann problem is composed ofn waves ℓ1(Uj+1− Uj)r1, · · · , ℓn(Uj+1− Uj)rnwith left stateUj and right stateUj+1. Each wave propagate at

7.2.2 piecewise-linear reconstruction

a) high order approximation in smooth regions.

b) TVD or TVB or ENO Whenu has discontinuities or uxchanges sign, we need to put a “limiter” to avoid oscillation ofu.˜

Example of limiters

7.2. HIGH ORDER GODUNOV METHODS 95 (2) Exact solver for small time step

Consider the linear advection equation

ut+ aux = 0.

Its graph is shown in Fig.(7.3).

Ifa < 0, then

0

Figure 7.3: The limiter of second order Godunov method

For System Case

ut+ Aux= 0 (2.5)

(1) Reconstruction

Constructu(x, t˜ n) to be a piecewise linear function.

˜

We trace back along the characteristic curve to getu in half time step.

un+

7.3. MULTIDIMENSION 97

In another viewpoint, letun+12

j+12,Lbe the solution of (2.5) with initial data = Then we solve (2.5) with(un+

1

There are two kinds of methods.

1. Splitting method.

2. Unsplitting method.

We consider two-dimensional case.

7.3.1 Splitting Method

We start from

ut+ Aux+ Buy = 0. (3.6)

This equation can be viewed as

ut= (−A∂x− B∂y)u.

Then the solution operator is:

e−t(A∂x+B∂y),

which can be approximate bye−tA∂xe−tB∂y for smallt. Let A = −A∂x, B = −B∂y, we have u = et(A+B)u0.

Consideret(A+B),

et(A+B) = 1 + t(A + B) +t2

2(A2+ B2+ AB + BA) + · · · etB· etA = (1 + tB +t2

2B2+ · · · )(1 + tA + t2

2A2+ · · · )

= 1 + t(A + B) +t2

2(A2+ B2) + t2BA + · · · .·.et(A+B)− etB· etA= t2(AB − BA

2 ) + O(t3).

Now we can design splitting method as:

Given{Ui,jn},

1. For eachj, solve ut+ Aux= 0 with data {Ujn} for ∆t step. This gives ¯Ui,jn. U¯i,jn = Ui,jn + ∆t

∆x(F (Ui−1,jn , Ui,jn) − F (Ui,jn, Ui+1,jn )) whereF (U, V ) is the numerical flux for ut+ Aux = 0.

2. For eachi, solve ut+ Buy = 0 for ∆t step with data { ¯Ui,jn}. This gives Ui,jn+1. Ui,jn+1= ¯Ui,jn + ∆t

∆y(G( ¯Ui,j−1n , ¯Ui,jn) − G( ¯Ui,jn, ¯Ui,j+1n )) The error is first order in timen(∆t)2 = O(∆t).

To reach higher order time splitting, we may approximateet(A+B)by polynomialsP (etA, etB) or rationalsR(etA, etB). For example, the Trotter product (or strang splitting) is given by

et(A+B)= e12tAetBe12tA+ O(t3).

Fort = n∆t,

et(A+B)u0 = (e12∆tAe∆tBe12∆tA) · · · (e12∆tAe∆tBe12∆tA)(e12∆tAe∆tBe12∆tA)u0

= e12∆tAe∆tBe∆tAe∆tBe∆tA· · · e∆tAe∆tBe12∆tAu0 Trotter product is second order.

7.3. MULTIDIMENSION 99 7.3.2 Unsplitting Methods

The PDE is

ut+ f (u)x+ g(u)y = 0 (3.7)

Integrate this equation over(xi−1 2, xi+1 We consider Godunov type method.

1. Reconstruction

Finally, solve Riemann problemut+ Aux= 0 with data



 Un+

1 2

i+12,L,j

Un+

1 2

i+12,R,j

.·.Un+12

i+12,j = Un+12

i+12,L,j+ X

λxk≥0

k· δUi+1

2,jrk

Chapter 8

Systems of Hyperbolic Conservation Laws

8.1 General Theory

We consider

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



 u1 u2 . ..

un



 f :Rn→ Rnthe flux (1.1)

The system (1.1) is called hyperbolic if ∀u, the n × n matrix f(u) is diagonalizable with real eigenvaluesλ1(u) ≤ λ2(u) ≤ · · · ≤ λn(u). Let us denote its left/right eigenvectors by ℓi(u)/ri(u), respectively.

It is important to notice that the system is Galilean invariant, that is , the equation is unchanged under the transform:

t −→ λt, x −→ λx, ∀λ > 0.

This suggests we can look for special solution of the formu(xt).

We plugu(xt) into (1.1) to yield u· (−x

t2) + f(u)u·1 t = 0

=⇒ f(u)u = x tu

This implies that there existsi such that u = ri(u) and xt = λi(u(xt)). To find such a solution, we first construct the integral curve ofri(u): u = ri(u). Let Ri(u0, s) be the integral curve of ri(u) passing throughu0, and parameterized by its arclength. AlongRi, the speedλihas the variation:

d

dsλi(Ri(u0, s)) = ∇λi· Ri = ∇λi· ri. 101

We have the following definition.

Definition 1.15. Thei-th characteristic field is called 1. genuinely nonlinear if∇λi(u) · ri(u) 6= 0∀u.

2. linearly degenerate if∇λi(u) · ri(u) ≡ 0

3. nongenuinely nonlinear if∇λi(u) · ri(u) = 0 on isolated hypersurface inRn.

For scalar equation, the genuine nonlinearity is equivalent to the convexity( or concavity) of the fluxf , linear degeneracy is f (u) = au, while nongenuine nonlinearity is nonconvexity of f . 8.1.1 Rarefaction Waves

When thei-th field is genuiely nonlinear, we define

R+i (u0) = {u ∈ Ri(u0)|λi(u) ≥ λi(u0)}.

Now supposeu1 ∈ R+i (u0), we construct the centered rarefaction wave, denoted by (u0, u1):

(u0, u1)(x t) =



u0 if xt ≤ λi(u0) u1 if xt ≥ λi(u1)

u ifλi(u0) ≤ xt ≤ λi(u1)andλi(u) = xt It is easy to check this is a solution. We call(u0, u1) an i-rarefaction wave.

t

x λi(u0) λi(u1)

u0 u1

λi(u) = xt

λi

u0

λi(u1) u1

λi(u0)

Figure 8.1: The integral curve ofu = ri(u) and the rarefaction wave.

8.1.2 Shock Waves

The shock wave is expressed by:

u(x t) =

 u0 for xt < σ u1 for xt > σ Then(u0, u1, σ) need to satisfy the jump condition:

f (u1) − f (u0) = σ(u1− u0). (1.2)

8.1. GENERAL THEORY 103 Lemma 8.3. (Local structure of shock waves)

1. The solution of (1.2) for (u, σ) consists of n algebraic curves passing through u0 locally, named them bySi(u0), i = 1, · · · , n.

2. Si(u0) is tangent to Ri(u0) up to second order. i.e., Si(k)(u0) = R(k)i (u0), k = 0, 1, 2, here the derivatives are arclength derivatives.

3. σi(u0, u) −→ λi(u0) as u −→ u0, andσi(u0, u0) = 12λi(u0)

Proof. 1. LetS(u0) = {u|f (u)−f (u0) = σ(u −u0) for some σ ∈ R}. We claim that S(u0) = Sn

i=1

Si(u0), where Si(u0) is a smooth curve passing through u0 with tangent ri(u0) at u0. Whenu is on S(u0), rewrite the jump condition as

f (u) − f (u0) = [ Z 1

0

f(u0+ t(u − u0) dt](u − u0)

= A(u˜ 0, u)(u − u0)

= σ(u − u0)

.·. u ∈ S(u0) ⇐⇒ (u − u0) is an eigenvector of ˜A(u0, u).

AssumeA(u) = f(u) has real and distinct eigenvalues λ1(u) < · · · λn(u), ˜A(u0, u) also has real and distinct eigenvalues ˜λ1(u0, u) < · · · < ˜λn(u0, u), with left/right eigenvectors ℓ˜i(u0, u) and ˜ri(u0, u), respectively, and they converge to λi(u0), ℓi(u0), ri(u0) as u → u0

respectively. Normalize the eigenvectors: k˜rik = 1, ˜ℓij = δij. The vector which is parallel torican be determined by

ℓ˜k(u0, u)(u − u0) = 0 for k 6= i, k = 1, · · · , n.

Now we define

Si(u0) = {u|˜ℓk(u0, u)(u − u0) = 0, k 6= i, k = 1, · · · , n}

We claim this is a smooth curve passing throughu0. Choose coordinate systemr1(u0), · · · , rn(u0).

Differential this equation ˜ℓk(u0, u)(u − u0) = 0 in rj(u0).

∂rj

u=u0

(˜ℓk(u0, u)(u − u0)) = ˜ℓk(u0, u0) · rj(u0) = δjk,

which is a full rank matrix. By implicit function theorem, there exists unique free parameter smooth curveSi(u0) passing through u0. ThereforeS(u0) = Sn

i=1

Si(u0).

2,3. Ri(u0) = u0 = Si(u0)

f (u) − f (u0) = σi(u0, u)(u − u0) ∀u ∈ Si(u0) Take arclength derivative alongSi(u0)

f(u)u = σi(u − u0) + σiuandu = Si. Whenu −→ u0

f(u0)Si(u0) = σi(u0, u0)Si(u0)

=⇒ Si(u0) = ri(u0) and σi(u0, u0) = λi(u0).

Consider the second derivative.

(f′′(u)u, u) + f(u)u′′ = σi′′(u − u0) + 2σi· u+ σiu′′

Atu = u0,u = Si(u0) = Ri(u0) = ri(u0) and u′′= Si′′(u0),

=⇒ (f′′ri, ri) + fSi′′= 2σiri+ σiSi′′

On the other hand, we take derivative off(u)ri(u) = λi(u)ri(u) along Ri(u0), then evaluate atu = u0.

(f′′ri, ri) + f(∇ri· ri) = λiri+ λi∇ri· ri, where∇ri· ri = R′′i.

=⇒ (f − λi)(Si′′− R′′i) = (2σi− λi)ri

=⇒ 2σi = λi

LetS′′i − Ri′′=P

k

αkrk(u0) = αiri P

k6=ik− λikrk = 0

=⇒ αk= 0 ∀k 6= i andλi = 2σiatu0

·.· (Ri, Ri) = 1 (Si, Si) = 1 and (R′′i, Ri) = 0 (Si′′, Si) = 0

.·. (R′′i − Si′′)⊥ri

.·. αi= 0 HenceR′′i = Si′′atu0.

8.1. GENERAL THEORY 105

Let Si(u0) = {u ∈ Si(u0)|λi(u) ≤ λi(u0)}.

Ifu1 ∈ S −i(u0), define (u0, u1) =

 u0 for xt < σi(u0, u1) u1 for xt > σi(u0, u1) (u0, u1) is a weak solution.

u0

Si

Ri+

Ri Si

We propose the following entropy condition: (Lax entropy condition)

λi(u0) > σi(u0, u1) > λi(u1) (1.3) If thei-th characteristic field is genuinely nonlinear, then for u1 ∈ Si(u0), and u1 ∼ u0, (1.3) is always valid. This follows easily fromλi = 2σi andσi(u0, u0) = λi(u0). For u1 ∈ Si(u0), we call the solution(u0, u1) i-shock or Lax-shock.

8.1.3 Contact Discontinuity (Linear Wave)

If∇λi(u) · ri(u) ≡ 0, we call the i-th characteristic field linearly degenerate (ℓ. dg.). In the case of scalar equation, this correspondf′′= 0. We claim

Ri(u0) = Si(u0) and σi(u0, u) = λi(u0) for u ∈ Si(u0) or Ri(u0).

Indeed, alongRi(u0), we have

f(u)u = λi(u)u.

andλi(u) is a constant λi(u0) from the linear degeneracy. We integrate the above equation from u0 tou along Ri(u0), we get

f (u) − f (u0) = λi(u0)(u − u0).

This gives the shock condition. Thus,Si(u0) ≡ Ri(u0) and σ(u, u0) ≡ λi(u0).

Homeworks.

(u0, u1) =

 u0 xt < σi(u0, u1) u1 xt > σi(u0, u1)

LetTi(u0) = R+i (u0) ∪ Si(u0) be called the i-th wave curve. For u1 ∈ Ti(u0), (u0, u1) is either a rarefaction wave, a shock, or a contact discontinuity.

Theorem 8.8. (Lax) For strictly hyperbolic system (1.1), if each field is either genuinely nonlin-ear or linnonlin-ear degenerate, then for uL ∼ uR, the Riemann problem with two end states (ul, uR) has unique self-similar solution which consists ofn elementary waves. Namely, there exist u0 = uL, · · · , un= uRsuch that(ui−1, ui) is an i-wave.

Proof. Given (α1, · · · , αn) ∈ Rn, define ui inductively ui ∈ Ti(ui−1), and the arclength of (ui−1, ui) on Ti= αi.

ui = f (u0, α1, · · · , αi) We want to findα1, · · · , αnsuch that

uR= f (uL, α1, · · · , αn).

u0

u1

T1 T2(u1) α2

α1

FirstuL= f (uL, 0, · · · , 0), as uR= uL, (α1, · · · , αn) = (0, · · · , 0) is a solution. When uR ∼ uL and{ri(u0)} are independent,

∂αi

α=0

f (uL, 0, · · · , 0) = ri(u0)andf ∈ C2

By Inverse function theorem, foruR∼ uL, there exists uniqueα such that uR= f (uL, α). Unique-ness leaves as an exercise.

8.2 Physical Examples

8.2.1 Gas dynamics

The equations of gas dynamics are derived based on conservation of mass, momentum and energy.

Before we derive these equations, let us review some thermodynamics. First, the basic thermo variables are pressure (p), specific volume (τ ), called state variables. The internal energy (e) is a function ofp and τ . Such a relation is called a constitutive equation. The basic assumption are

∂e

∂p

τ

> 0, ∂e

∂τ

p

> 0 Sometimes, it is convinient to expressp as a function of (τ, e).

1-wave

2-wave

n-wave t

x

u0 = uL un= uR

u1 u2 un−1

8.2. PHYSICAL EXAMPLES 107 In an adiabetic process (no heat enters or losses), the first law of thermodynamics (conservation of energy) reads

de + pdτ = 0. (2.4)

This is called a Pfaffian equation mathematically. A functionσ(e, τ ) is called an integral of (2.4) if there exists a functionµ(e, τ ) such that

dσ = µ · (de + pdτ).

Thus, σ = constant represents a specific adiabetic process. For Pfaffian equation with only two independent variables, one can always find its integral. First, one can derive equation forµ: from

σe= µ and στ = µp and usingσ = στ e, we obtain the equation forµ:

µτ = (µp)e.

This is a linear first-order equation for µ. It can be solved by the method of characteristics in the region τ > 0 and e > 0. The solutions of µ and σ are not unique. If σ is a solution, so doesσ with d¯¯ σ = ν(σ)dσ for any function ν(σ). We can choose µ such that if two systems are in thermo-equilibrium, then they have the same value µ. In other words, µ is only a function of emperical temperature. We shall denote it by1/T . Such T is called the absolute temperature. The correspondingσ is called the physical entropy S. The relation dσ = µ(de + pdτ ) is re-expressed as

de = T dS − pdτ. (2.5)

For ideal gas, which satisfies the laws of Boyle and Gay-Lussac:

pτ = RT, (2.6)

whereR is the universal gas constant. From this and (2.5), treating S and τ as independent variables, one obtains

ReS(S, τ ) + τ eτ(S, τ ) = 0.

We can solve this linear first-order equation by the method of characteristics. We rewrite this equa-tion as a direcequa-tional differentiaequa-tion:

 R ∂

∂S + τ ∂

∂τ

 e = 0.

This means thate is constant along the characteristic curves Rdτ

dS = τ.

These characteristics can be integrated as

τ e−S/R= φ.

Hereφ is a positive constant. The energy e(τ, S) is constant when τ e−S/R is a constant. That is, e = h(φ) for some function h. We notice that h < 0 because p = −(∂τ∂e)S= −e−S/Rh(τ H) > 0.

FromT = (∂S∂e)τ = −R1h(φ) · φ, we see that T is a function of φ. In most cases, T is a decreasing function ofφ. We shall make this as an assumption. With this, we can invert the relation between T and φ and treat φ as a decreasing function of T . Thus, we can also view e as a function of T , say

Hence, we can choose two of as independent thermo variables and treat the rest three as dependent variables.

For instance,e is a linear function of T , i.e. e = cvT , where cv is a constant called specfic heat at constant volume. Such a gas is called polytropic gas. We can obtain

pτ = RT and e = cvT = pτ

γ − 1 (2.7)

or in terms of entropy,

p = A(S)τ−γ

8.2. PHYSICAL EXAMPLES 109 In general,cp > cv. Becausecpis the amount of heat added to a system per unit mass at constant pressure. In order to maintain constant pressure, the volume has to expand (otherwise, pressure will increase), the extra amount of work due to expansion is supplied by the extra amount of heatcp−cv. Next, we derive the equation of gas dynamics. Let us consider an arbitrary domain Ω ⊂ R3. The mass flux from outside to inside per unit time per unit areadS is −ρv·, where n is the outer normal ofΩ. Thus, the conservation of mass can be read as

d This holds for arbitraryΩ, hence we have

ρt+ div(ρ v) = 0. (2.8)

This is called the continuity equation.

Now, we derive momentum equation. Let us suppose the only surface force is from pressure (no viscous force). Then the momentum change inΩ is due to (i) the momentum carried in through boundary, (ii) the pressure force exerted on the surface, (iii) the body force. The first term is−ρvv·n, the second term is−pn. Thus, we have

d

Here, the notation∇ · ρv ⊗ v stands for a vector whoes ith component isP

jj(ρvivj). The energy per unit volume isE = 12ρ v2 + ρe. The energy change in Ω per unit time is due to (i) the energy carried in through boundary (ii) the work done by the pressure from boundary, and (iii) the work done by the body force. The first term is−Ev · n. The second term is −pv · n. The third term is F · v. The conservation of energy can be read as

d By applying divergence theorem, we obtain the energy equation:

Et+ div[(E + p)v] = ρF · v. (2.10)

In one dimension, the equations are (without body force)

ρt+ (ρu)x = 0 (ρu)t+ (ρu2+ p)x = 0 (1

2ρu2+ e)t+ [(1

2ρu2+ e + p)u]x = 0.

Here, the unknowns are two thermo variable ρ and e, and one kinetic variable u. Other thermo variablep is given by the constitutive equation p(ρ, e).

8.2.2 Riemann Problem of Gas Dynamics We use(ρ, u, S) as our variables.

S. The eigenvalues and corresponding eigenvectors are

8.2. PHYSICAL EXAMPLES 111

Figure 8.2: The integral curve of the first and the third field on the(u, P ) phase plane.

OnR2, which is a contact discontinuity,du = 0, dP = 0. Therefore u = u0, P = P0.

Let

m = ρ0v0= ρv

which is from the first jump condition. The second jump condition says that ρ0v02+ P0 = ρv2+ P

mv0+ P0 = mv + P

m = −P − P0

v − v0

= − P − P0

mτ − mτ0

whereτ = ρ1 is the specific volume.

.·. m2 = −P −Pτ −τ00 v − v0 = −P −Pm 0

(u − u0)2 = (v − v0)2 = −(P − P0)(τ − τ0) The third one is

(1

0v20+ ρ0e0+ P0)v0 = (1

2ρv2+ ρe + P )v

=⇒ 1

2v02+ e0+ P0τ0 = 1

2v2+ e + P τ Byv20 = m2τ02, v2 = m2τ2, m2= −P −Pτ −τ00,

=⇒ H(P, τ ) = e − e0+ P + P0

2 (τ − τ0) = 0 Recalle = γ−1P τ . FromH(P, τ ) = 0,

P τ

γ − 1− P0τ0

γ − 1+ (P + P0

2 )(τ − τ0) = 0.

Solve fotτ in terms of P, P0, τ0, then plug into

(u − u0)2 = −(P − P0)(τ − τ0)

Setφ(P ) = (P − P0) vu

ut γ+12 τ0 P +γ−1γ+1P0

Then

S1 : u = u0− φ0(P ) S3 : u = u0+ φ0(P )

8.2. PHYSICAL EXAMPLES 113 Therefore,

T1(ℓ): u =

 u0− ψ0(P ) P < P0

u0− φ0(P ) P ≥ P0

T3(ℓ): u =

 u0+ ψ0(P ) P > P0 u0+ φ0(P ) P ≤ P0

T1(r): u =

 u0− ψ0(P ) P > P0 u0− φ0(P ) P ≤ P0

T3(r): u =

 u0+ ψ0(P ) P < P0

u0+ φ0(P ) P ≥ P0

P

u (ℓ)

S1

R+3

R+1 S3

P

u S1+

S3+ R1

R3 (r)

Figure 8.3: The rarefaction waves ans shocks of 1,3 field on(u, P ) phase plane at left/right state.

Now we are ready to solve Riemann Problem with initial states(ρL, PL, uL) and (ρR, PR, uR).

Recall that in the second field,[P ] = [u] = 0.

ρI, PI, uI ρI, PII, uII

ρL, PL, uL ρR, PR, uR

PI = PII = P uI = uII = u

u S1

S3

P R1

R3 r

S3 S1

R1 R3

ρL, PL, uL ρR, PR, uR ρI ρII

P, u

The vaccum state P

u ℓ

r Solution must satisfyP > 0. If u+ ℓ is less thanur−ℓr, there is no solution.

For numerical, Godunov gives a procedure, ”Godunove iteration”. The algorithm to findP: u− f(P ) = uI = uII = ur+ fr(P )

f0(P ) =

 ψ0(P ) P < P0 φ0(P ) P ≥ P0

We can solve this equation.

Godunov iteration is 

ZR(u− uR) = P− PR

−ZL(u− uL) = P− PL. Where

ZR =

rPR τRΦ(P

PR) ZL =

rPL τLΦ(P

PL)

8.2. PHYSICAL EXAMPLES 115 and

Φ(w) =



 qγ+1

2 w +γ−12 w > 1

2√γγ−1 1−w

1−wγ−1 w ≤ 1 This can be solved by Newton’s method.

Approximate Riemann SolverOur equation isut+f (u)x = 0 with Riemann data (uL, uR).

We look for middle state. SupposeuL∼ uR, the original equation can be replaced by ut+ f(u)ux = 0

ut+ A(u)ux = 0 Chooseu =¯ uL+ uR

2 , solveut+ A(¯u)ux = 0 with Riemann data u(x, 0) =

 uL x < 0 uR x > 0 Let λi, ℓi, ribe eigenvalues and eigenvectors ofA. Then

u(x

t) = uL+ X

λi<xt

(ℓi· (uR− uL)) · ri.

One severe error in this approximate Riemann solver is that rarefaction waves are approximated by discontinuities. This will produce nonentropy shocks. To cure this problem, we expand such a linear discontinuity by a linear fan. Precisely, supposeλi(ui−1) < 0, λi(ui) > 0, this suggests that there exists rarefaction fan crossing xt = 0. We then expand this discontinuity by a linear fan. At x/t = 0, we thus choose

um = (1 − α)ui−1+ αui, α = −λi(ui−1)

λi(ui) − λi(ui−1).

Chapter 9

Kinetic Theory and Kinetic Schemes

9.1 Kinetic Theory of Gases 9.2 Kinetic scheme

Assume the equilibrium distribution isg0(ξ). It should satisfy (i) momentum conditions, (ii) equa-tion of states (or flux condiequa-tion), (iii) positivity. That is, the moment condiequa-tion:

Z

g0ψα(ξ) dξ = Uα

and flux condition: Z

g0ξψα(ξ) dξ = Fα(U ).

For non-convex casef ,

117

相關文件