characteristic-based algorithms for flows in thermochemical nonequilibrium

10
AIAA JOURNAL Vol. 30, No. 5, May 1992 Characteristic-Based Algorithms for Flows in Thermochemical Nonequilibrium Robert W. Walters,* Pasquale Cinnella,t and David C. Slack! Virginia Polytechnic Institute and State University, Blacksburg, Virginia 24061 and David Halt§ McDonnell Douglas Corporation, St. Louis, Missouri 63166 Novel numerical techniques based upon Steger-Warming, Van Leer, and Roe-type flux splittings are presented in three-dimensional generalized coordinates for the Navier-Stokes equations governing flows out of chemical and thermal equilibrium. Attention is placed on convergence to steady-state solutions with fully coupled chem- istry. Time integration schemes including explicit m-stage Runge-Kutta, implicit approximate-factorization, relaxation, and LU decomposition are investigated and compared in terms of residual reduction per unit of CPU time. Practical issues such as code vectorization and memory usage on modern supercomputers are discussed. Introduction T HE development of algorithms for the Euler and Navier- Stokes equations with thermochemical nonequilibrium effects has been spurred to a large extent by the desire to build the National Aerospace Plane (NASP) and other hy- personic vehicles. The gas dynamic models required to span the flight envelope for such a vehicle range from perfect gas to chemical nonequilibrium and, in some instances, thermal nonequilibrium models. Candler, 1 ' 2 Liu and Vinokur, 3 Gross- man and Cinnella, 4 and Wada et al. 5 are among those authors who have dealt with both thermal and chemical nonequili- brium flows, and several investigators have developed com- puter codes with the capability for simulating portions of this wide range of flight conditions. 6 " 11 The purpose of this paper is to present a unified formulation for solving the three-dimensional Navier-Stokes equations in generalized coordinates, when arbitrary mixtures of thermally perfect gases are considered and allowed to be in any local thermochemical state, namely full nonequilibrium, chemical nonequilibrium, chemical equilibrium, or frozen. Conse- quently, the whole flight envelope of a typical hypersonic vehicle can be efficiently studied using only one code. To this end, flux-split techniques of the Steger-Warming, Van Leer, and Roe types are derived and applied to the simulation of physically challenging flow problems. The three-dimensional, finite volume computer code that has been developed under this effort has been named GASP (General Aerodynamic Simulation Program). It is highly modular and, like SPARK, 9 incorporates a generalized chemistry package. The thermal and chemical nonequilibrium model is the one proposed by Grossman and Cinnella. 4 Similar to the codes described by Presented as Paper 90-0393 at the AIAA 28th Aerospace Sciences Meeting, Reno, NV, Jan. 8-11, 1990; received Nov. 28, 1990; re- vision received Aug. 16,1991; accepted for publication Aug. 19,1991. Copyright © 1990 by the American Institute of Aeronautics and Astronautics, Inc. All rights reserved. *Associate Professor, Aerospace and Ocean Engineering, 215 Randolph Hall. Senior Member AIAA. tResearch Assistant; currently, Assistant Professor, Mississippi State Univ., Aerospace Engineering, P.O. Drawer 6176, Mississippi State Univ., MS 39762. Member AIAA. ^Research Assistant; currently, Research Scientist, AeroSoft, Inc., P.O. Box 11334, Blackburg, VA 24062. §Research Assistant, Mail Code 0341260, P.O. Box 516. Senior Member AIAA. Palaniswamy, Chakravarthy, and Ota, 6 and Hoffman, 7 mem- ory allocation is performed dynamically. Through the input deck, the user can select the accuracy of the spatial approx- imation, the flux split scheme, the type of limiter, the time integration scheme (currently, this includes m-stage Runge- Kutta, hybrid AF/relaxation, and LU/relaxation with various options; e.g., frozen Jacobians), the boundary conditions, the dimensionality of the problem (two-dimensional, axisymmetric, or three-dimensional) along with other input options. The code is highly vectorized, particularly in j-k planes in an ijk logical coordinate system. A more thorough description of GASP can be found in Walters, Cinnella, and Slack 12 and in the GASP User's Guide. 13 In the following, a brief description of the chemistry and thermodynamics models employed in this study precedes the introduction of the Navier-Stokes equations, written in vector form. The thermochemical nonequilibrium flux-split schemes in three-dimensional generalized coordinates are presented, and followed by a discussion of the time integration schemes. Results for an axisymmetric diffuser with both air and hydrogen- air chemistry, a blunt body flow, and a hydrogen-air com- bustion problem are detailed to provide the reader with a flavor of the capabilities of the present algorithms. Gas Models Chemistry Models At high temperatures, chemical reactions will occur in gas flows resulting in changes in the amount of mass of each chemical species. In a general mixture of N species there will be / reactions taking place where the v- f and the v" Lj are the stoichiometric coefficients of the reactants and products of species i in the yth reaction, respectively. For nonequilibrium chemistry, the rate of pro- duction of species / may be written as: 1304 (2) Downloaded by UNIV OF TEXAS AUSTIN on September 16, 2013 | http://arc.aiaa.org | DOI: 10.2514/3.11065

Upload: david

Post on 14-Dec-2016

220 views

Category:

Documents


1 download

TRANSCRIPT

Page 1: Characteristic-based algorithms for flows in thermochemical nonequilibrium

AIAA JOURNALVol. 30, No. 5, May 1992

Characteristic-Based Algorithms for Flows inThermochemical Nonequilibrium

Robert W. Walters,* Pasquale Cinnella,t and David C. Slack!Virginia Polytechnic Institute and State University, Blacksburg, Virginia 24061

andDavid Halt§

McDonnell Douglas Corporation, St. Louis, Missouri 63166

Novel numerical techniques based upon Steger-Warming, Van Leer, and Roe-type flux splittings are presentedin three-dimensional generalized coordinates for the Navier-Stokes equations governing flows out of chemicaland thermal equilibrium. Attention is placed on convergence to steady-state solutions with fully coupled chem-istry. Time integration schemes including explicit m-stage Runge-Kutta, implicit approximate-factorization,relaxation, and LU decomposition are investigated and compared in terms of residual reduction per unit ofCPU time. Practical issues such as code vectorization and memory usage on modern supercomputers arediscussed.

Introduction

T HE development of algorithms for the Euler and Navier-Stokes equations with thermochemical nonequilibrium

effects has been spurred to a large extent by the desire tobuild the National Aerospace Plane (NASP) and other hy-personic vehicles. The gas dynamic models required to spanthe flight envelope for such a vehicle range from perfect gasto chemical nonequilibrium and, in some instances, thermalnonequilibrium models. Candler,1'2 Liu and Vinokur,3 Gross-man and Cinnella,4 and Wada et al.5 are among those authorswho have dealt with both thermal and chemical nonequili-brium flows, and several investigators have developed com-puter codes with the capability for simulating portions of thiswide range of flight conditions.6"11

The purpose of this paper is to present a unified formulationfor solving the three-dimensional Navier-Stokes equations ingeneralized coordinates, when arbitrary mixtures of thermallyperfect gases are considered and allowed to be in any localthermochemical state, namely full nonequilibrium, chemicalnonequilibrium, chemical equilibrium, or frozen. Conse-quently, the whole flight envelope of a typical hypersonicvehicle can be efficiently studied using only one code. To thisend, flux-split techniques of the Steger-Warming, Van Leer,and Roe types are derived and applied to the simulation ofphysically challenging flow problems. The three-dimensional,finite volume computer code that has been developed underthis effort has been named GASP (General AerodynamicSimulation Program). It is highly modular and, like SPARK,9incorporates a generalized chemistry package. The thermaland chemical nonequilibrium model is the one proposed byGrossman and Cinnella.4 Similar to the codes described by

Presented as Paper 90-0393 at the AIAA 28th Aerospace SciencesMeeting, Reno, NV, Jan. 8-11, 1990; received Nov. 28, 1990; re-vision received Aug. 16,1991; accepted for publication Aug. 19,1991.Copyright © 1990 by the American Institute of Aeronautics andAstronautics, Inc. All rights reserved.

* Associate Professor, Aerospace and Ocean Engineering, 215Randolph Hall. Senior Member AIAA.

tResearch Assistant; currently, Assistant Professor, Mississippi StateUniv., Aerospace Engineering, P.O. Drawer 6176, Mississippi StateUniv., MS 39762. Member AIAA.

^Research Assistant; currently, Research Scientist, AeroSoft, Inc.,P.O. Box 11334, Blackburg, VA 24062.

§Research Assistant, Mail Code 0341260, P.O. Box 516. SeniorMember AIAA.

Palaniswamy, Chakravarthy, and Ota,6 and Hoffman,7 mem-ory allocation is performed dynamically. Through the inputdeck, the user can select the accuracy of the spatial approx-imation, the flux split scheme, the type of limiter, the timeintegration scheme (currently, this includes m-stage Runge-Kutta, hybrid AF/relaxation, and LU/relaxation with variousoptions; e.g., frozen Jacobians), the boundary conditions, thedimensionality of the problem (two-dimensional, axisymmetric,or three-dimensional) along with other input options. Thecode is highly vectorized, particularly in j-k planes in an ijklogical coordinate system. A more thorough description ofGASP can be found in Walters, Cinnella, and Slack12 and inthe GASP User's Guide.13

In the following, a brief description of the chemistry andthermodynamics models employed in this study precedes theintroduction of the Navier-Stokes equations, written in vectorform. The thermochemical nonequilibrium flux-split schemesin three-dimensional generalized coordinates are presented,and followed by a discussion of the time integration schemes.Results for an axisymmetric diffuser with both air and hydrogen-air chemistry, a blunt body flow, and a hydrogen-air com-bustion problem are detailed to provide the reader with aflavor of the capabilities of the present algorithms.

Gas ModelsChemistry Models

At high temperatures, chemical reactions will occur in gasflows resulting in changes in the amount of mass of eachchemical species. In a general mixture of N species there willbe / reactions taking place

where the v-f and the v"Lj are the stoichiometric coefficientsof the reactants and products of species i in the yth reaction,respectively. For nonequilibrium chemistry, the rate of pro-duction of species / may be written as:

1304(2)

Dow

nloa

ded

by U

NIV

OF

TE

XA

S A

UST

IN o

n Se

ptem

ber

16, 2

013

| http

://ar

c.ai

aa.o

rg |

DO

I: 1

0.25

14/3

.110

65

Page 2: Characteristic-based algorithms for flows in thermochemical nonequilibrium

WALTERS, CINNELLA, SLACK, AND HALT: THERMOCHEMICAL NONEQUILIBRIUM 1305

where pl is the mass density and M,t is the mass per mole(molecular weight) of species /, and for the y'th reaction theforward and backward reactions rates kfj and kbj9 are as-sumed to be known functions of temperature.

The frozen chemistry model is obtained from the previousone in the limit of zero rates of reaction, which amounts tozero species rates of production. The equilibrium model isobtained in the limit of infinite rates of reaction, which isaccomplished in practice by multiplying the nonequilibriumvalues by a factor of 106. There are more efficient ways ofperforming calculations using a local chemical equilibriumassumption,14 and some of them are being considered forimplementation in GASP.

Thermodynamic ModelsFollowing the work of Grossman and Cinnella,4 at high

temperatures the internal energy per unit mass of each speciesis assumed to be the sum of two portions, one in thermody-namic equilibrium and one in a nonequilibrium state, thelatter being modeled by appropriate production rates. Con-sequently, for a generic species /

p — p \T\ -\- P \^\\^i &i\L ) ' Cni \3)

where et is the known equilibrium portion of the energy, T isthe translational temperature, and eni is the portion of theinternal energy that is not in thermodynamic equilibrium. Amore general formulation would include a portion of the en-ergy as a function of the electron temperature.3

It is convenient to express et in terms of the specific heatat constant volume, cv. = deildT9 as follows:

-/;• hi (4)

where hfi is the heat of formation of species /.If the first M out of N species in a gas mixture are assumed

to contain a nonequilibrium energy contribution, the internalenergy per unit mass of the mixture becomes:

,-=i p 1=1 p (5)

Then, the mixture reduced specific heats and gas constant canbe defined by means of the usual mixture rule, as follows:

^1=1 P

^1 = 1 P

= X - R>? = cp ~ cv (6a,b,c)i=i p

and it is possible to define

(7)

A thermodynamic equilibrium model is easily obtained fromthe previous relations when the nonequilibrium contributionsare set to zero. The usual perfect gas model is just a particularexample of an equilibrium model, obtained when all of thespecies specific heats are constant (in addition to the as-sumption of no chemical activity).

The models that are utilized in the simulations presentedin this study include the Simplified Vibrational Nonequili-brium (SVNE) and the Simplified Vibrational Equilibrium(SVE) models, which employ harmonic oscillators to accountfor the vibrational contribution to the species internal energy.4Moreover, another equilibrium model based upon a poly-nomial curve fit cvi will be utilized,15 and denoted by CF.Equations of State

For conditions in which each individual species behaves asa thermally perfect gas, the thermal equation of state will

relate pressure to translational temperature, in agreement\x/ith Daltnn'Q lawwith Dalton's law:

P =

where the density of the mixture is:

p =

(8)

(9)

The state relationship of the pressure to the specific internalenergy occurs implicitly through the temperature. For a givenchemical composition, internal energy, and nonequilibriumenergy, the temperature must be evaluated from the caloricequation of state:

(10)

Iterative procedures are then used to solve for T. Once T isfound, the pressure is determined from Eq. (8).

Frozen Speed of SoundThe frozen speed of sound has been shown to play a key

role in the establishment of the basic gasdynamic propertiesof flows in thermochemical nonequilibrium.4 It is defined as:

(11)where s is the entropy per unit mass. Clarke and McChesney16

showed that:

(12)= yRT = yP.

where the featured y is the ratio of specific heats correspond-ing to the equilibrium portion of the internal energy, definedin Eq. (7).

Governing EquationsThe governing equations for a three-dimensional flow with

nonequilibrium chemistry and nonequilibrium internal energycan be written in vector conservation form and generalizedcoordinates, as follows:

dtQ

drj

d(H - Hv) WJ (13)

where Q is the vector of conserved variables and 'W is thevector of production rates

PiP2

Q =PNpupvpw

(14a)

Dow

nloa

ded

by U

NIV

OF

TE

XA

S A

UST

IN o

n Se

ptem

ber

16, 2

013

| http

://ar

c.ai

aa.o

rg |

DO

I: 1

0.25

14/3

.110

65

Page 3: Characteristic-based algorithms for flows in thermochemical nonequilibrium

1306 WALTERS, CINNELLA, SLACK, AND HALT: THERMOCHEMICAL NONEQUILIBRIUM

w =

W2

WN

000

(14b)

and the inviscid flux vectors are F, G, H, with F given as:

F =

Pl"p2u

puupvupwu

LPIP (15)

puh0

and G, // given by similar expressions, once the appropriatecontravariant velocity components and generalized coordi-nates are chosen. In the above, u, v, w are the Cartesianvelocity components, hQ is the stagnation enthalpy per unitmass, eni is the species nonequilibrium portion of the internalenergy, and eni is its relaxation rate, which depends upon thespecific nonequilibrium model.4 Also, / is the Jacobian of thetransformation

(16)d(x,y,z)

and M, v, w are the contravariant velocity components

(17).

where the normalized gradients in the £, 17, £ directions havebeen utilized. The viscous flux vectors Fv, Gv> Hv for the fullNavier-Stokes equations, along with more details on the mod-eling of the viscous terms, are given by Walters et al.13-17

Equation (13) represents N + M + 4 conservation equa-tions, with the first TV corresponding to species continuity,followed by momentum conservation, M nonequilibrium en-ergy conservation equations, and the total energy conserva-tion equation. The system is completed by the density defi-nition, Eq. (9), and the equations of state, Eqs. (8) and (10).

It is important to point out that the equations presentedcan be utilized for the study of many flowfields that are phys-ically less challenging than a full thermochemical nonequili-brium situation. In particular, thermodynamic equilibrium isobtained by setting M to zero and dropping the nonequili-brium energy equations. Frozen flows for cases where dif-fusion is important can be modeled by dropping the vectorof source terms. The "usual" Navier-Stokes equations for a

perfect gas flow can be recovered by setting N = 1, M = 0and simplifying the thermochemical model correspondingly.

Flux SplittingIn the following, some novel characteristic-based algo-

rithms for the accurate numerical simulation of flows in ther-mochemical nonequilibrium are presented. They representthe extension to three space dimensions and generalized co-ordinates of the techniques derived by Grossman and Cinnella4

in a one-dimensional context.Although fully general, the schemes proposed reduce nicely

to the simpler forms necessary for the computation of flowsin thermodynamic equilibrium or even for frozen and perfect-gas-type flows, following the same guidelines outlined in theprevious section.Steger-Warming Flux Vector Splitting

Using the homogeneity property of the governing equa-tions, Steger and Warming18 developed a flux-vector splittingfor perfect gases. This approach was extended to equilibriumflows by several authors,19-21 and, more recently, to one-dimensional flows in thermochemical nonequilibrium.4

The essential feature of this approach is to diagonalize theJacobian matrices. After some algebraic rearrangement, thefinal result is obtained:.

y -+ + (18)

where:

P2/P

uVw

hQ -

(19a)

FKf- = ̂

Pi/PP2/P

PN/Pu ± l_xaV ± lyCL

w ± lza

(19b)

and:

u ± \u\

u + a ± \u + a\

u - a ± \u — a\

(20a)

(20b)

(20c)

Dow

nloa

ded

by U

NIV

OF

TE

XA

S A

UST

IN o

n Se

ptem

ber

16, 2

013

| http

://ar

c.ai

aa.o

rg |

DO

I: 1

0.25

14/3

.110

65

Page 4: Characteristic-based algorithms for flows in thermochemical nonequilibrium

WALTERS, CINNELLA, SLACK, AND HALT: THERMOCHEMICAL NONEQUILIBRIUM 1307

This represents a Steger-Warming-type flux vector splittingfor a thermochemically active flow. The perfect gas form isobtained by setting pjp = 1, the remaining pjp = 0, andeni = 0. The remaining space dimensions proceed in a similarfashion.Van Leer Flux Vector Splitting

An alternate flux vector splitting has been developed forperfect gases by Van Leer.22 His formulation has continuouslydifferentiable flux contributions and has been shown to resultin smoother solutions near sonic points.23 Van Leer-type split-tings have been developed for equilibrium chemistry19'21 andfor nonequilibrium in one space dimension.4 The final resultin three-dimensional generalized coordinates is:

PI/Pp2/p

P* =^fZ u + IJ-M ± 2a]/yv + ly[-u ± 2a]/yw + |z[-w ± 2a]/y

(21)

where:

1m = ±P<*±M + 1

ff = h0- m(-u

(22a)

(22b)

(22c)

Similar results hold for the other space dimensions. The abovesplittings are consistent with those developed by Liu andVinokur.3

Preliminary calculations do not show any significant effecton the value of the parameter m in the energy equation. Also,as discussed for the Steger-Warming-type splitting, the methodabove can be shown to reduce to the perfect gas form.

Roe Flux Difference SplittingThe essential features of flux difference split algorithms

involve the solution of local Riemann problems arising fromthe consideration of discontinuous states at cell interfaces onan initial data line. The scheme developed for perfect gasesby Roe24 falls into this category, and has produced excellentresults for both inviscid and viscous flow simulations.25 Anextension of the Roe splitting for equilibrium chemistry hasbeen made by several investigators. 19~21-26 This approach hasbeen extended for the present nonequilibrium thermodynamicand chemistry model by Grossman and Cinnella4 for one spacedimension.

In the following, the arithmetic average of a quantity / willbe denoted by:

</> = (23)

with the subscript / indicating the left state and the subscriptr the right state, respectively. Also, the jump of a quantity/will be defined as:

I/I = /,-/, (24)

The solution of the approximate Riemann problem involvesthe determination of the cell interfaces fluxes as a summationover wave speeds:

+ I*], + (25)

where the absolute value of the wave speeds must be substi-tuted in the formulas for the jumps in the fluxes:

Here, the IFIA term corresponds to the repeated eigenvalueA, = & and may be written as:

PiP2

PNuv

pu

[PI/PI[P2/PI

M - I

e

(27)

where:

e = (aiui + vM + vvM

+ 1 H - i *j;i=i IL p Jl ••=! ILp(28)

Similarly the [FIB and [Flc correspond to the eigenvalues& + a and & — a, and are found to be:

± a)

PiP2

PNu±lv ± jw ± l

A

± ud J

(29)

Dow

nloa

ded

by U

NIV

OF

TE

XA

S A

UST

IN o

n Se

ptem

ber

16, 2

013

| http

://ar

c.ai

aa.o

rg |

DO

I: 1

0.25

14/3

.110

65

Page 5: Characteristic-based algorithms for flows in thermochemical nonequilibrium

1308 WALTERS, CINNELLA, SLACK, AND HALT: THERMOCHEMICAL NONEQUILIBRIUM

We also have:

where:

and

The appropriate averaged values of the flow variables p, u,v, w, p^ enp ^0, ^ are found to be:

(30)

(31a)

(31b)

(31c)

(32a)

(32b)

(33a)

where:

((Pi/p)V~p}

(V~p)

ho = -7T

* = 5^T - *' + 2

f — (V~P)

~™ (V~p)= a2 + v2 + w2

v-^e*

C" " J71 Jn 1-'i'

(34a)

(34b)

(34c)

(35)

(36a)

(36b)

(37)

The averaged contravariant velocity components are givenby:

(38)

(39)

Also, we may determine a as:

*2 = (f - f

The other space dimensions can be treated in a similar fashion.

Numerical FormulationThe governing equations presented in a previous section

are discretized in space using a finite-volume approach. The

inviscid fluxes at the volume boundaries are evaluated usingupwind differences in conjunction with the algorithms justintroduced. The viscous fluxes are determined from a stan-dard central difference approach. More details are given byWalters et al.13

Time IntegrationIn order to obtain a steady-state solution, the spatially dis-

cretized Navier Stokes equations must be integrated in time.Three time integration methods are compared: an m-stageexplicit Runge-Kutta method, an implicit LU decompositionin a plane, and an implicit Approximate Factorization (AF)in a plane.

The Runge-Kutta scheme advances the solution in timeusing:

G(0) = Q(n)

G<i> = e (o )-«i

(40)

where:

with the standard weighting coefficients:

a< = m - ; + 1

(41)

(42)

and Vis the cell volume (V - I//). Convergence to the steady-state is also accelerated by using the maximum permissibletime-step for each individual cell in the flowfield, as dictatedby local stability analysis.

The two implicit methods considered are based upon theEuler implicit time integration scheme. Both of these schemesuse relaxation in the remaining direction, and have the abilityto reuse the factored Jacobian matrix.13'27

Storage and Vectorization for LU and AFThe LU decomposition and the AF methods utilize a highly

vectorized banded solver( in order to save storage and CPUtime. The solver stores a matrix A(j,k) with ndiag super/sub

Fig. 1 Geometry of the axisymmetric nozzle and qualitative repre-sentation of the mesh.

Dow

nloa

ded

by U

NIV

OF

TE

XA

S A

UST

IN o

n Se

ptem

ber

16, 2

013

| http

://ar

c.ai

aa.o

rg |

DO

I: 1

0.25

14/3

.110

65

Page 6: Characteristic-based algorithms for flows in thermochemical nonequilibrium

WALTERS, CINNELLA, SLACK, AND HALT: THERMOCHEMICAL NONEQUILIBRIUM 1309

diagonals in an array D by the rule A{j,k) is stored in£>(ndiag + 1 + j - 'k,k): that is, the/th column of A goesto ;th column of D and the main diagonal of A is then thendiag + 1 row of D with each super and subdiagonal on therows above and below that one in D.

For LU in a plane of dimension jdim x kdim with (N +M + 4) conserved variables, this results in a matrix thatrequires storage of (2 * ndiag + 1) * (jdim * kdim) * (N +M + 4) where ndiag = (jdim + 1) * (N + M + 4) - 1 forthe jdim bandwidth case, or ndiag = (kdim + 1) * (N + M+ 4) — 1 for the kdim bandwidth case.

For AF in a plane, the first step of the solution is donewith a jdim bandwidth, and the second is done with a kdimbandwidth. In both cases, the matrix is in block tridiagonalform and requires the amount of storage given for the LUmethod but with ndiag = 2*(7V + M + 4 ) - l . Hence, forlarge jdim and kdim, AF in a plane requires far less storagethan LU in a plane.

In terms of vectorization, the banded matrix solver vec-torizes over the length of the dot product involved in the LUdecomposition phase and the forward/backward substitutionphases. In addition, for the AF algorithm, since the 77 and gdirections are decoupled, both steps in the solution processcan be divided into independent sections of length jdim andkdim, respectively. The algorithm can then be further vec-torized over these sections resulting in substantial CPU savings.

Numerical ResultsA few numerical examples of flow computations are in-

cluded, in order to illustrate the accuracy and efficiency ofthe methodology presented. The test cases include the invis-cid, steady flow in a supersonic nozzle, a hypersonic, laminarflow over an axisymmetric blunt body with air chemistry, anda turbulent, hydrogen-air combustion problem.

The numerical results presented here have been obtainedusing the flux-vector and flux-difference splitting techniquespreviously summarized. For the supersonic cases, all splittingsyield the same predictions within plotting accuracy. However,this is not always the case, especially when in the presence ofcontact discontinuities and shear layers, where Roe's techniqueyields more accurate results for perfect gas calculations.25

Nozzle with Air ChemistryThe axisymmetric nozzle shown in Fig. 1 has a geometry

defined by the radius r = 0.125L[1 + sin(7TJt/2L)], with alength L = 2 m and 0 < x < L.

Using the chemical model for high-temperature air de-scribed by Park,28 numerical solutions have been obtained forthe following inlet conditions: p = 1.95256 105 N/m2, T =9000 K, u = 4000 m/s, v = w = 0, and an equilibrium massfraction distribution. Results are presented for an axisym-metric 2 x 6 x 41 grid, using Steger-Warming, Van Leer,

9000*-

8000

7000

5000

4000

3000

20000.0 0.4 0.8 1.2 1.6 2.0

x (m)Fig. 2 Finite-rate, frozen, and equilibrium results for the air chem-istry model. Area-averaged values of temperature are compared withone-dimensional results.

and Roe algorithms. The predictions from the different al-gorithms coincide within plotting accuracy for this fully super-sonic case. At each axial location, the values have been area-averaged in the transverse direction. The resulting curvescompare very well with the one-dimensional results of Gross-man and Cinnella.4 For this problem, there are non-negligiblegradients of chemical and flow properties in the transversedirection.

The effect of assuming a frozen chemistry or a local chem-ical equilibrium for the same problem is investigated in Fig.2, where the SVE thermodynamic model was used. The tem-perature predictions vary significantly, with the finite-rate cal-culations lying in the middle of the two limiting cases. Someof the mechanical quantities, such as pressure and velocity,are hardly affected by the differences in the chemical behav-iour. The mass fractions, however, which are constant forfrozen calculations, are significantly changed by the assump-tion of local chemical equilibrium. As already discussed in aprevious section, the equilibrium predictions were obtainedby multiplying the rate constants by a factor of 106 and runningthe finite-rate code. It may be useful to point out that acalculation with a factor of 1012 did not change the results.

A plot of the normalized residual vs CPU time for the airchemistry case and different time integration algorithms ispresented in Fig. 3. All computations have been performed

0 100 200 300 400CPU Time, sec

Fig. 3 Convergence history for the air chemistry model on a Cray-YMP machine.

0.10r

0.08

c 0.06

0.04

0.02

O.OOd

tYXYffiffffff^^

« Surface 3D

x Centerline 3D

• Average 3D

- 161 pts 1D

0.0 0.4 0.8 1.2x (m)

1.6 2.0

Fig. 4 Results for the hydrogen-air chemistry model. Surface, cen-terline, and area-averaged values of H2O are compared.

Dow

nloa

ded

by U

NIV

OF

TE

XA

S A

UST

IN o

n Se

ptem

ber

16, 2

013

| http

://ar

c.ai

aa.o

rg |

DO

I: 1

0.25

14/3

.110

65

Page 7: Characteristic-based algorithms for flows in thermochemical nonequilibrium

1310 WALTERS, CINNELLA, SLACK, AND HALT: THERMOCHEMICAL NONEQUILIBRIUM

b)2.0

Fig. 5 Comparison of several thermodynamic models for the hydrogen-air chemistry model, st. mech = Equilibrium vibrational energy (SVE);curve fit = Curve fit cvi (CF); n.e. evib = Nonequilibrium vibrationalenergy (SVNE); ID n.e. = Quasi-one-dimensional result with SVNE.a) Temperature; b) Mass fraction OH.

on a Cray-YMP machine, with a residual reduction of 10~10

as a convergence criterion. The explicit second-order Runge-Kutta algorithm turned out to be completely inadequate, dueto the severe restrictions on its stability brought about by thechemical stiffness. The curve shown has been obtained witha CFL number of 0.1. A CFL number of 100 has been usedfor both the LU decomposition and AF methods. A furtherreduction of CPU time has been obtained by means of a reuseof the decomposition elements for both implicit schemes, be-ginning after a residual reduction of two orders of magnitude.

Nozzle with Hydrogen-Air ChemistryUsing the Rogers and Chinitz hydrogen-air chemistry

model,29 numerical solutions have been obtained for the samenozzle and the following inlet conditions: p = 0.8026 105 N/m2, T = 1884.3 K, u = 1245 m/s, v = w = 0. The initialcomposition of the flow consists of an equivalence ratio <3>,the ratio of the mass fraction of H2 to the mass fraction ofO2, normalized by the stoichiometric ratio, of <1> = 0.29841.This composition causes very steep concentration gradientsnear the inlet of the duct. The results are presented in Fig. 4for the same axisymmetric grid. Once again, the averagedvalues compare very well with the one-dimensional results.

A comparison between different thermodynamic models isshown in Fig. 5. Results obtained using the SVE model areplotted along with the predictions of the CF and SVNE models.In addition, the SVNE results obtained with a quasi-one-dimensional code are shown. It can be noticed that there isa noticeable freezing of vibrational energy in the nonequili-brium predictions. Both equilibrium models are in excellentagreement, due to the moderate temperatures. The discrep-ancy in the temperature prediction affects the intermediate

step of the combustion, the production of OH, but does notalter the final level of water mass fraction.

A plot of the normalized residual versus number of itera-tions and CPU time for the hydrogen-air chemistry case anddifferent time integration algorithms is presented in Fig. 6.Here, the Runge-Kutta algorithm was limited to a CFL num-

10

10-io

a)

b)

41x6 grid

400 800 1200 1600 2000Iterations

41 x6 grid

RK (explicit)

AF no reuse

400 800CPU Time, sec

Fig. 6 Convergence history for the hydrogen-air chemistry model ona Cray-YMP machine, a) Residual reduction vs iteration number,b) Residual reduction vs CPU time.

Dow

nloa

ded

by U

NIV

OF

TE

XA

S A

UST

IN o

n Se

ptem

ber

16, 2

013

| http

://ar

c.ai

aa.o

rg |

DO

I: 1

0.25

14/3

.110

65

Page 8: Characteristic-based algorithms for flows in thermochemical nonequilibrium

WALTERS, CINNELLA, SLACK, AND HALT: THERMOCHEMICAL NONEQUILIBRIUM 1311

her of 10~4, due to the extreme stiffness of the two-reactionmodel. The LU and AF algorithms, as well as the reuse strat-egies discussed, used a CFL of 100. Examination of the plotof residual vs iteration number in Fig. 6 shows little differencebetween the AF and LU algorithms. This is likely due to thepredominance of the diagonal terms in the algebraic problem,associated with the chemical source terms Jacobians for thesetest cases.

RAM-C II Test CaseIn the late sixties, the Radio Attenuation Measurement

(RAM) tests were conducted in order to obtain data in avelocity regime in which ionization could not be neglected.Probes were instrumented in order to obtain electron numberdensities. Details of these tests can be found in Jones andCross.30 The second in the series of flights, referred to as theRAM-C II test, has become a popular test case for moderncomputational fluid dynamics algorithms31-33 because no abla-tion products were produced.

The geometry consists of a sphere-cone with a 15.24 cmnose radius and a 9 deg cone half-angle. A grid containing31 points along the body and 41 points radially was generated.This grid was then rotated through an angle of Tr/40 in orderto yield an appropriate grid for an axisymmetric calculation.The case considered here corresponds to a flight altitude of61 km with freestream conditions: Tx = 254 K, Ux = 7650m/s, and a Reynolds number based on the nose radius Ren —19,500. These conditions correspond to a flight Mach numberM^ = 23.9. A laminar calculation was performed with a cellReynolds number based on the minimum mesh spacing Rec ~4. The wall temperature was held fixed at 1500 K. Park airchemistry with 7 species (N2, O2, NO, NO + , N, O, e~) and18 reactions was used as the chemistry model.28

Fig. 7 shows computed Mach number contours from thenumerical solution using the Van Leer type of flux vectorsplitting developed earlier. Peak electron number densitiesobtained with both the Van Leer and the Roe flux formulasare compared to experiment in Fig. 8. On this mesh, bothmethods overpredict the data on the aft portion of the body.It is interesting to note that nonphysical behavior and con-vergence problems were observed if the flowfield was ini-tialized to the freestream Mach number of 23.9. In this case,the shock wave forms on the body and then moves outwardinto the field, resulting in a severe transient that limited the

4.500005.000005.5OOOO6.000006.500007.000007.50000

8.500009.000009.500001 0.000001 D.500001 1 .00000

.50000

.00000

.5OOOO

.50000

.0000050000.00000

.00000

.50000

.00000

.50000

.000000000oooo

oooo

0000oooolOOO

Fig. 7 Mach number contours for the RAM-C II at 61 km.

time-step. However, by initializing the flow to a low Machnumber (0.1, in this case) and enforcing freestream conditionsat the outer boundary, the shock moves inward toward thebody, which results in much better numerical behavior. Themaximum Courant number achieved during this simulationwas 66. This problem is referred to as GASP Test Case 13,and like all other GASP test cases, is available on-line atNASA Langley and Ames.

Hydrogen-Air ExampleAs a final demonstration of the characteristic-based, ther-

mochemical nonequilibrium algorithms developed in this pa-per, a problem involving the chemical kinetics of a hydrogen-air combustion process is considered in which turbulent mix-ing plans an important role. A sketch of the problem is shownin Fig. 9 in which a Mach 2.44 vitiated air stream at 1270 Kmixes with a sonic jet of H2 at 254 K. The mass fractions ofthe vitiated air stream at the entrance were taken to be 0.486,0.258, and 0.256 for N2, O2, and H2O respectively. The walltemperature was held fixed at 298 K and the Baldwin andLomax algebraic turbulence model was employed. Details ofthe experimental investigation of this problem are reportedby Burrows and Kurkov.34

RAM C-ll at 61 km

#/cm3

2 3

x/r

Fig. 8 Comparison of computed and experimental peak electron number density.

Dow

nloa

ded

by U

NIV

OF

TE

XA

S A

UST

IN o

n Se

ptem

ber

16, 2

013

| http

://ar

c.ai

aa.o

rg |

DO

I: 1

0.25

14/3

.110

65

Page 9: Characteristic-based algorithms for flows in thermochemical nonequilibrium

1312 WALTERS, CINNELLA, SLACK, AND HALT: THERMOCHEMICAL NONEQUILIBRIUM

In all of the computations, 81 points were used in the normaldirection. In the streamwise direction, both 21 and 41 pointswere used in order to assess the effect of any streamwisegradients on the numerical solution. Two different chemicalmodels were used; the Evans and Schexnayder (labeled E&S)model,35 which contains 12 species and 25 reactions and theDrummond model36 with nine species and 18 reactions. Figs.10 and 11 show the water mole fraction and total temperatureprofiles in the exit plane compared to the experiment. Thecomputed results are very similar to the results of Kamath37

in that the location of the peaks from the numerical solutionsare closer to the lower wall than the experimental data. Thisis probably due to the fact that uniform profiles of all quan-tities were specified at the inflow in lieu of accounting forturbulent boundary layer profiles at that station.

The only noticable effect of the streamwise grid refinementis a sharpening of the profile peaks in the exit plane, althoughthe location of the peaks is unchanged. These calculationswere performed with GASP in PNS mode with the implicitLU scheme. On the 21 x 81 x 2 mesh, it is noted that theEvans and Schexnayder model runs to completion in 224 sec-onds at a CFL equal to 10 on the NAS Cray-YMP, whereas

Station 1 : H 2 O + Air, M^s 2.44,1^= 1270 ° K

Station 2 : H2, M =1.0, 7^= 254 ° K

Station 1

L = 0.356 m 'Fig. 9 Sketch of the Burrows and Kurkov hydrogen-air combustionproblem.

H O

0 1 2 3 4 5 6

Fig. 10 Computed and experimental H2O mole fraction profiles atx = 0.356 m.

T K0 1500

0 1 2 3 4 5 6

Fig. 11 Computed and experimental total temperature profiles atx = 0.356 m.

the Drummond model required 374 seconds due to the factthat the maximum CFL was 4 (without user intervention).These two calculations are referred to as GASP Test Case12a (E&S) and Test Case 12b (Drummond) in the on-linedocumentation.

Concluding RemarksThe development of flux-split techniques for the numerical

simulation of multidimensional flowfields in thermochemicalnonequilibrium has been described. The approach undertakenis fully general and may be used to investigate virtually anyproblem involving mixtures of thermally perfect gases at hightemperature and/or high velocity.

AcknowledgmentsNASA Langley Research Center sponsored the work of

R. W. Walters, P. Cinnella, and D. C. Slack under NASAGrant NAGl-776. The advice and assistance of B. Grossmanwere instrumental to this research effort.

ReferencesHandler, G., "On the Computation of Shock Shapes in Non-

equilibrium Hypersonic Flows," AIAA Paper 89-0312, Reno, NV,1989.

2Candler, G., "The Computation of Weakly lonzied HypersonicFlows in Thermo-Chemical Nonequilibrium," Ph.D. Dissertation,Stanford Univ., Stanford, CA, 1988.

3Liu, Y., and Vinokur, M., "Nonequilibrium Flow Computations:I. An Analysis of Numerical Formulations of Conservation Laws,"NASA CR 177489, June 1988.

4Grossman, B., and Cinnella, P., "Flux-Split Algorithms for Flowswith Nonequilibrium Chemistry and Vibrational Relaxation," Journalof Computational Physics, Vol. 88, No. 1, May 1990, pp. 131-168.

^Wada, Y., Kubota, H., Ogawa, S., and Ishiguro, T., "A Gen-eralized Roe's Approximate Riemann Solver for Chemically ReactingFlows," AIAA Paper 89-0202, Reno, NV, 1989.

6Palaniswamy, S., Chakravarthy, S. R., and Ota, D. K., "FiniteRate Chemistry for USA-Series Codes: Formulation and Applica-tions," AIAA Paper 89-0200, Reno, NV, 1989.

7Hoffman, J. J., "Development of an Algorithm for the Three-Dimensional Fully-Coupled Navier Stokes Equations with Finite RateChemistry," AIAA Paper 89-0670, Reno, NV, 1989.

8Drummond, J. P., Rogers, R. C., and Hussaini, M. Y., "A De-tailed Numerical Model of a Supersonic Reacting Mixing Layer,"AIAA Paper 86-1427, Huntsville, AL, 1986.

9Carpenter, M., "A Generalized Chemistry Version of SPARK,"NASA CR 4196, 1988.

10Molvik, G. A., and Merkle, C. L., "A Set of Strongly Coupled,Upwind Algorithms for Computing Flows in Chemical Nonequi-librium," AIAA Paper 89-0199, Reno, NV, 1989.

1 Crispin, J., and Anderson, J. D., "Accelerating the Computationof Steady State Solutions for Nonequilibrium, Chemically ReactingFlow Fields," AIAA Paper 88-0513, Reno, NV, 1988.

12Walters, R. W., Cinnella, P., and Slack, D. C., "A Status Reporton GASP—A General Aerodynamic Simulation Program," SeventhNational Aero-Space Plane Symposium, Paper 9, NASA Lewis,Cleveland, OH, 1989.

13Walters, R. W., Slack, D. C., Cinnella, P., Applebaum, M., andFrost, C., "A User's Guide to GASP," NASA Langley ResearchCenter, Hampton, VA, Nov. 1991.

14Liu, Y., and Vinokur, M., "Equilibrium Gas Flow Computa-tions. I. Accurate and Efficient Calculations of Equilibrium Gas Prop-erties," AIAA Paper 89-1736, Buffalo, NY, 1989.

15McBride, G. J., Heimel, S., Ehlers, J. G., and Gordon, S.,"Thermpdynamic Properties to 6000 K for 210 Substances Involvingthe First 18 Elements," NASA SP-3001, 1963.

16Clarke, J. F., and McChesney, M.,The Dynamics of Real Gases,Butterworth, London, 1964, p. 179.

17Walters, R. W., Cinnella, P., Slack, D. C., and Halt, D.,"Characteristic-Based Algorithms for Flows in Thermo-ChemicalNonequilibrium," AIAA Paper 90-0393, Reno, NV, 1990.

18Steger, J. L., and Warming, R. F., "Flux Vector Splitting ofthe Inviscid Gasdynamics Equations with Application to Finite-Difference Methods," Journal of Computational Physics, Vol. 40,1981, pp. 263-293.

19Grossman, B., and Walters, R. W., "Analysis of Flux-Split Al-

Dow

nloa

ded

by U

NIV

OF

TE

XA

S A

UST

IN o

n Se

ptem

ber

16, 2

013

| http

://ar

c.ai

aa.o

rg |

DO

I: 1

0.25

14/3

.110

65

Page 10: Characteristic-based algorithms for flows in thermochemical nonequilibrium

WALTERS, CINNELLA, SLACK, AND HALT: THERMOCHEMICAL NONEQUILIBRIUM 1313

gorithms for Euler's Equations with Real Gases," AIAA Journal,Vol. 27, No. 5, 1989, pp. 524-531.

20Vinokur, M., and Liu, Y., "Equilibrium Gas Flow ComputationsII: An Analysis of Numerical Formulations of Conservation Laws,"AIAA Paper 88-0127, Reno, NV, 1988.

21Liou, M.-S., Van Leer, B., and Shuen, J.-S., "Splitting of InviscidFluxes for Real Gases," NASA TM 1Q0856, 1988.

22Van Leer, B., "Flux-Vector Splitting for the Euler Equations,"Lecture Notes in Physics, Vol. 170, Springer-Verlag, Berlin, 1982,pp. 507-512.

23Anderson, W. K., Thomas, J. L., and Van Leer, B., "Compar-ison of Finite Volume Flux Vector Splittings for the Euler Equa-tions," AIAA Journal, Vol. 24, No. 9, 1986, pp. 1453-1460.

24Roe, P. L., "Approximate Riemann Solvers, Parameter Vectors,and Difference Schemes," Journal of Computational Physics, Vol.43, 1981, pp. 357-372.

25Van Leer, B., Thomas, J. L., Roe, P. L., and Newsome, R. W.,"A Comparison of Numerical Flux Formulas for the Euler andNavier-Stokes Equations," AIAA Paper 87-1104-CP, Honolulu, HI,1987.

26Glaister, P., "An Approximate Linearised Riemann Solver forthe Euler Equations for Real Gases," Journal of Computational Phys-ics, Vol. 74, 1988, pp. 382-408.

27Walters, R. W., Reu, T., McGrory, W. D., Thomas, J. L., andRichardson, P. F., "A Longitudinally-Patched Grid Approach withApplications to High Speed Flows," AIAA Paper 88-0715, Reno,NV, 1988.

28Park, C., "On Convergence of Computation of Chemically Re-

acting Flows," AIAA Paper 85-0247, Reno, NV, 1985.29Rogers, R. C., and Chinitz, W., "Using a Global Hydrogen-Air

Combustion Model in Turbulent Reacting Flow Calculations," AIAAJournal, Vol. 21, No. 4, 1983, pp. 586-592.

30Jones, W. L., and Cross, A. E., "Electrostatic-Probe Measure-ments of Plasma Parameters For Two Reentry Flight Experiments at25,000 Feet Per Second," NASA TN D-6617, 1972.

31Candler, G. V., and MacCormack, R. W., "The Computationof Hypersonic Ionized Flows in Chemical and Thermal Nonequi-librium," AIAA Paper 88-0511, Reno, NV, 1988.

32Palmer, G., "The Development of an Explicit ThermochemicalNonequilibrium Algorithm and Its Application to Compute ThreeDimensional AFE Flowfields," AIAA Paper 89-1701, Buffalo, NY,1989.

33Kang, S., Dunn, M. G., and Jones, W. L., "Theoretical andMeasured Electron-Density Distributions for the RAM Vehicle atHigh Altitudes," AIAA Paper 72-689, Boston, MA, 1972.

34Burrows, M. C., and Kurkov, A. P., "Analytical and Experi-mental Study of Supersonic Combustion of Hydrogen in a VitiatedAirstfeam," NASA TM X-2828, 1973.

35Evans, J. S., and Schexnayder, C. J., Jr., "Influence of ChemicalKinetics and Unmixedness on Burning in Supersonic HydrogenFlames," AIAA Journal, Vol. 18, No. 2, 1979, pp. 188-193.

36Drummond, J. P., and Hussaini, M. Y., "Numerical Simulationof a Supersonic Reacting Mixing Layer," AIAA Paper 87-1325, Hon-olulu, HI, 1987.

37Kamath, H., "Parabolized .Navier-Stokes Algorithm for Chem-ically Reacting Flows," AIAA Paper 89-0386, Reno, NV, 1989.

Recommended Reading from the AIAA Education Series

Critical Technologies forNational Defense

J. S. Przemieniecki, Editor-In-ChiefPrepared by Air Force Institute of Technology (AFIT)

Critical Technologies for National Defense dis-cusses the underlying physical and engineeringprinciples governing the development of our futuredefense systems as they relate to the 20 critical tech-nologies that have been identified in the 1990 DoDCritical Technologies Plan. Physical and EngineeringPrinciples, Description of Technology, and Impacton Future Weapon Systems are discussed for eachcritical technology.

This text is recommended reading for seniormanagers who direct the development of defenseand weapon systems. Topics include: ComputationalFluid Dynamics; Simulation and Modeling; Compos-ite Materials; Signature Control; Software Producibility;Biotechnology Materials and Processes; and more.

1991, 318 pp, illus, HardcoverISBN 1-56347-009-8

AIAA Members $36.50 • Nonmembers $46.95Order #• 09-8 (830)

Place your order today! Call 1-800/682-AIAA

&ASAAAmerican Institute of Aeronautics and AstronauticsPublications Customer Service, 9 Jay Could Ct., P.O. Box 753, Waldorf, MD 20604Phone 301/645-5643, Dept. 415, FAX 301/843-0159

Sales Tax: CA residents, 8.25%; DC, 6%. For shipping and handling add $4.75 for 1-4 books (callfor rates for higher quantities). Orders under $50.00 must be prepaid. Please allow 4 weeks fordelivery. Prices are subject to change without notice. Returns will be accepted within 15 days.

Dow

nloa

ded

by U

NIV

OF

TE

XA

S A

UST

IN o

n Se

ptem

ber

16, 2

013

| http

://ar

c.ai

aa.o

rg |

DO

I: 1

0.25

14/3

.110

65