8
VOL. 16, NO. 7, JULY 1978 AIAA JOURNAL 679 Implicit Finite-Difference Simulation of Flow about Arbitrary Two-Dimensional Geometries Joseph L. Steger* NA SA Ames Research Center, Moffett Field, Calif. Finite-difference procedures are used to solve either the Euler equations or the "thin-layer" Navier-Stokes equations subject to arbitrary boundary conditions. An automatic grid generation program is employed, and because an implicit finite-difference algorithm for the flow equations is used, time steps are not severely limited when grid points are finely distributed. Computational efficiency and compatibility to vectorized computer processors is maintained by use of approximate factorization techniques. Computed results for both inviscid and viscous flow about airfoils are described and compared to viscous known solutions. I. Introduction T HE current work is mainly concerned with two of the ingredients of computational fluid dynamics—the blending of an implicit finite-difference scheme with trans- formations that permit use of automatic grid generation techniques. The combination produces what should prove to be a good recipe for many practical flow calculations. Results in this paper are restricted to flow about airfoils, but the basic core routines apply to a variety of problems (e.g., internal flows, rotating machinery), and the extension of the algorithms to three dimensions is reasonably straightforward. II. Motivations In any numerical simulation the choice of numerical algorithm and flowfield model is dictated by considerations of computer cost, the type of problem being solved, the flow regime, and whether a very precise solution or an approximate solution is needed. These dictates have spawned a vast array of simulation techniques (e.g., finite differences, finite elements, particle in cell, integral methods), the use of special approximations (e.g., incompressible or compressible, steady or unsteady, rotational or irrotational, boundary-layer or Navier-Stokes), and a variety of ways to impose geometric boundaries (e.g., thin airfoil theory, special boundary operators, curvilinear and conformal coordinates, finite elements). It seems that, even if one has a definite problem to solve, it can be difficult or impossible to select a best or most efficient numerical method—for example, a procedure that runs very efficiently on a conventional serial computer processor may run poorly on a particular vector computer processor. However, as computer processors and numerical algorithms continue to improve, it is natural to try to develop general simulation routines that fit geometric boundaries exactly and make few physical approximations. The usual justification for a quite general simulation routine is that while it may be costly in comparison to a simplified algorithm, it can be readily adapted to a large class of problems. As a result a given solution might initially be obtained in fewer man hours, and of course, detailed solutions are needed as checkpoints for less expensive but more approximate solutions. A more pragmatic justification for a general routine is the suspicion that it may be easier in the long run to make a general program efficient than to make an efficient program more general. Presented as Paper 77-665 at the AIAA 10th Fluid and Plasmadynamics Conference, Albuquerque, N. Mex., June 27-29, 1977; submitted Aug. 18, 1977. Copyright © American Institute of Aeronautics and Astronautics, Inc., 1977. All rights reserved. Index categories: Computational Methods; Transonic Flow. * Research Scientist. Member AIAA. Inadequate knowledge of turbulence modeling and lack of a sufficiently powerful computer to handle three dimensions insure the continued use of approximate methods, but various developments have come to the forefront to make general formulations more attractive. These are more versatile grid generation routines, ! " 3 general transformations of the equations that maintain strong conservative form, 4 ' 9 and reliable implicit finite-difference schemes/ 10 ' 13 The thrust of the current work is toward combining general transformations, grid generation techniques, and implicit algorithms into a viable and versatile flow program. The use of implicit schemes removes much of the stiffness problem associated with locally refined grids, especially viscous grids, and of course, is ideally suited to the viscous terms them- selves. Transformations and grid generation schemes permit arbitrary geometries to be solved by conventional finite- difference methods and permit study of various unsteady motions as well. Thus, considerable flexibility exists along with the promise that the core programs developed can be readily adapted to a variety of problems without considerable special tailoring. The following sections detail the transformed equations, grid generation routines, and the implicit schemes. Finally, a variety of flowfields about airfoils are solved and are used to verify the numerical algorithm and illustrate its versatility. III. Transformation of Governing Equations The strong conservation law form of the Navier-Stokes equations in Cartesian coordinates can be written in non- dimensional form as (see Peyret and Viviand 14 ): (1) where P pu pv e pu pu 2 +p puv u(e+p) 0 TJ _ pv puv pv 2 +p v(e+p) , S=

Implicit Finite-Difference Simulation of Flow about ...history.arc.nasa.gov/hist_pdfs/awards/hjaa_1987.pdfFinite-difference procedures are used to solve either the Euler equations

  • Upload
    others

  • View
    6

  • Download
    1

Embed Size (px)

Citation preview

Page 1: Implicit Finite-Difference Simulation of Flow about ...history.arc.nasa.gov/hist_pdfs/awards/hjaa_1987.pdfFinite-difference procedures are used to solve either the Euler equations

VOL. 16, NO. 7, JULY 1978 AIAA JOURNAL 679

Implicit Finite-Difference Simulation of Flow aboutArbitrary Two-Dimensional Geometries

Joseph L. Steger*NA SA Ames Research Center, Moffett Field, Calif.

Finite-difference procedures are used to solve either the Euler equations or the "thin-layer" Navier-Stokesequations subject to arbitrary boundary conditions. An automatic grid generation program is employed, andbecause an implicit finite-difference algorithm for the flow equations is used, time steps are not severely limitedwhen grid points are finely distributed. Computational efficiency and compatibility to vectorized computerprocessors is maintained by use of approximate factorization techniques. Computed results for both inviscid andviscous flow about airfoils are described and compared to viscous known solutions.

I. Introduction

THE current work is mainly concerned with two of theingredients of computational fluid dynamics—the

blending of an implicit finite-difference scheme with trans-formations that permit use of automatic grid generationtechniques. The combination produces what should prove tobe a good recipe for many practical flow calculations. Resultsin this paper are restricted to flow about airfoils, but the basiccore routines apply to a variety of problems (e.g., internalflows, rotating machinery), and the extension of thealgorithms to three dimensions is reasonably straightforward.

II. MotivationsIn any numerical simulation the choice of numerical

algorithm and flowfield model is dictated by considerations ofcomputer cost, the type of problem being solved, the flowregime, and whether a very precise solution or an approximatesolution is needed. These dictates have spawned a vast arrayof simulation techniques (e.g., finite differences, finiteelements, particle in cell, integral methods), the use of specialapproximations (e.g., incompressible or compressible, steadyor unsteady, rotational or irrotational, boundary-layer orNavier-Stokes), and a variety of ways to impose geometricboundaries (e.g., thin airfoil theory, special boundaryoperators, curvilinear and conformal coordinates, finiteelements).

It seems that, even if one has a definite problem to solve, itcan be difficult or impossible to select a best or most efficientnumerical method—for example, a procedure that runs veryefficiently on a conventional serial computer processor mayrun poorly on a particular vector computer processor.However, as computer processors and numerical algorithmscontinue to improve, it is natural to try to develop generalsimulation routines that fit geometric boundaries exactly andmake few physical approximations. The usual justificationfor a quite general simulation routine is that while it may becostly in comparison to a simplified algorithm, it can bereadily adapted to a large class of problems. As a result agiven solution might initially be obtained in fewer man hours,and of course, detailed solutions are needed as checkpointsfor less expensive but more approximate solutions. A morepragmatic justification for a general routine is the suspicionthat it may be easier in the long run to make a generalprogram efficient than to make an efficient program moregeneral.

Presented as Paper 77-665 at the AIAA 10th Fluid andPlasmadynamics Conference, Albuquerque, N. Mex., June 27-29,1977; submitted Aug. 18, 1977. Copyright © American Institute ofAeronautics and Astronautics, Inc., 1977. All rights reserved.

Index categories: Computational Methods; Transonic Flow.* Research Scientist. Member AIAA.

Inadequate knowledge of turbulence modeling and lack of asufficiently powerful computer to handle three dimensionsinsure the continued use of approximate methods, but variousdevelopments have come to the forefront to make generalformulations more attractive. These are more versatile gridgeneration routines,!"3 general transformations of theequations that maintain strong conservative form,4'9 andreliable implicit finite-difference schemes/10'13

The thrust of the current work is toward combining generaltransformations, grid generation techniques, and implicitalgorithms into a viable and versatile flow program. The useof implicit schemes removes much of the stiffness problemassociated with locally refined grids, especially viscous grids,and of course, is ideally suited to the viscous terms them-selves. Transformations and grid generation schemes permitarbitrary geometries to be solved by conventional finite-difference methods and permit study of various unsteadymotions as well. Thus, considerable flexibility exists alongwith the promise that the core programs developed can bereadily adapted to a variety of problems without considerablespecial tailoring.

The following sections detail the transformed equations,grid generation routines, and the implicit schemes. Finally, avariety of flowfields about airfoils are solved and are used toverify the numerical algorithm and illustrate its versatility.

III. Transformation of Governing EquationsThe strong conservation law form of the Navier-Stokes

equations in Cartesian coordinates can be written in non-dimensional form as (see Peyret and Viviand14):

(1)

where

P

pu

pv

e

pu

pu2 +p

puv

u(e+p)

0

TJ _

pv

puv

pv2 +p

v(e+p)

, S=

Page 2: Implicit Finite-Difference Simulation of Flow about ...history.arc.nasa.gov/hist_pdfs/awards/hjaa_1987.pdfFinite-difference procedures are used to solve either the Euler equations

680 J. L. STEGER AIAA JOURNAL

with

!dxa2

S4 = urxy + VTyy ~!dya2

and

P=(y-l)(e-0.5p(u2 (2)

where/? is the pressure, a is the sound speed, and 7 is taken as-(2/3)/>t, the Stokes' hypothesis. Note that while the non-dimensional reference quantities are arbitrary, the Reynolds'number (Re) and Prandtl number (Pr) used in Eq. (1) aredefined in terms of those reference values.

If new independent variables are introduced, a strongconservation law form of Eq. (1) can be maintained as shown,for example, by Lapidus,4 Viviand,5 and Vinokur6 (see alsothe related finite volume methods7'9). Subject to the generaltransformation

r=t (3)

the equations can be written (see Refs. 5 and 14) as

(4)

where

= q/J, E=

and

etc., where derivatives such as ux are expanded by chain rule,ux = %xu + -rixU . Here J is the transformation Jacobian

(5)

The metrics £„£*, etc., are easily formed from thederivatives of xrt x% , etc., using the relations

It is also convenient to define the velocities

(6b)

(7a)

(7b)

which are the so-called contravariant velocities along the £and 77 coordinates. Using these defined velocities, Fand Fcanbe written in the compact form

E=J

PU

(8)

Note that once U and V are formed, the flux vectors E and Fare not much more complex than E and F.

One does not generally have sufficient computer power toresolve the viscous terms except in a thin layer near the body;consequently, a thin-layer approximation is used here.Viscous terms in £, which is the direction along the body (seeFig. 1), are neglected and only terms in r? are retained. For aboundary-layer-like coordinate system the viscous terms arethus simplified to

and Eq. (4) is rewritten

(9)

(10)

The thin layer model is not a necessary step in this develop-ment, but it is a useful simplification. Although similar (oridentical if £ is normal to 17) viscous terms are dropped inboundary-layer theory, the "normal momentum" equation isretained in the thin-layer model and pressure can vary throughthe viscous layer. Consequently, the thin-layer model isdevoid of the problems that would occur in matching aninviscid solution with a conventional boundary-layer solutionand the separation point is not a mathematical singularity.

Along the body surface rj(x,y,f) =0 (see Fig. 1), the con-dition of tangency in inviscid flow is

=0 or (")=/-'["'\vJ L -r)x

while in viscous flow U=Q as well. The pressure on the bodysurface can be obtained from the momentum equations andone such relation is found for inviscid flow by simplifying77* (£ - momentum) + 17 *(r / - momentum):

p[dTr]t + udTrjx + vdrrjy] -

(12)

where n is the direction normal to the body surface. The samerelation has been used in viscous flow with U= 0.

Jacobian matrices used in the time linearization of E, F,and S are needed for the implicit algorithm to be defined later.The flux vectors Eand Fare both linear combinations of q, E,andF

E or F=(k0q + k1E+k2F)J-1 with k0 = £t or i;,, etc.

(13)

so the Jacobian matrices^ =dE/dq and B = dF/dq are givenby

A or B = k0I+kfA+k2B (14)

where A = dE/dq and B = dF/dq are the usual Jacobianmatrices of the Cartesian flux vectors. The A or B matrix is

Page 3: Implicit Finite-Difference Simulation of Flow about ...history.arc.nasa.gov/hist_pdfs/awards/hjaa_1987.pdfFinite-difference procedures are used to solve either the Euler equations

JULY 1978 SIMULATION OF FLOW ABOUT TWO-DIMENSIONAL GEOMETRIES 681

— u(k}u + k2v) —(y — 2)k,u — (y — l)k}v

k0 + k]U + k2v +k2u

v -(y-2)k2v

(y-l)k2u + k0 + ,

$2}ki [y(e/p)-<j>2]k2

[-y(e/p)+2<j)2] -(y-l)(uk,+vk2)u - (y-1) (ukl +vk2)v + k0

(15)

where 02 - 0.5 (y - \)(u2 + v2).Warming et al.15 found the eigenvalues of kjA + k2B:

(16)

so the roots of A or B are real and are simply

o(A or B)=k0 + o(k]A+k2B) (17)

The eigenvalues a ( A ) , for example, are U, U, U+ a\l% * + £ y ,

The elements of 5 are of the general form [seeEq. (9)]

fi(xty9ttq)=ai(xfyfttq)d^i(xty9t>q) (18)

so each element linearizes in time (with the metrics fixed atn+ !/2)a$

(19a)

For simplicity, ^ and K will not be taken as functions of q (asthis would require numerical evaluation of the elements) andda/dq = Q. Furthermore, (3 is a vector that is homogenous in qof degree zero, and consequently

and the linearization drops to

Using this linearization in Eq. (9)

R-'d^S"*1 =R~Jd^ (Sn + (20)

^CONSTANT

where Mis defined by

~0 0

M= 21 GLl *^31 «2^(.

_m41 m42 m43

0

0

0

mA

(21)

a 2 d r i ( v / p )

m31 = -a2dr, ( u / p ) -oi3d^ ( v / p )

m41 =a4dn[- (e/p2 ) + ( u2 4- v2 ) /p] - a l d, ( u2 Ip )

-2^28^ ( u v / p ) -a3dr] ( u 2 / p )

m42 = -a^T, (u/p) -m21

m43= - o L 4 d ^ ( v / p ) -m31

m44=a4dri(p-1)

Fig. 1 Physical and transfomed computational planes.

and M differs from M insofar that it is formed using elementsof qnot q.

For practical calculations a turbulence model must also besupplied. In the present calculations a two layer algebraiceddy viscosity model patterned after that used by Cebeci16

was supplied by Barrett Baldwin Jr. of the Ames ResearchCenter. A detailed description of the model will be publishedseparately by Baldwin.

IV. Advantages of the Transformed Equations,Grid Generation, and Accuracy

The transformed equations are somewhat more com-plicated than the original Cartesian form but offer severalsignificant advantages. The main advantage is that boundarysurfaces in the physical plane can be mapped onto rectangularsurfaces in the transformed plane. Unsteady body motion hasalso been incorporated into the equations. Another significantaspect of the transformation is that grid points can be con-centrated in region that experience rapid change in theflowfield gradients, eventually allowing dynamic remeshing.

Grid GenerationTo take advantage of the generality of the transformed

equations, one need a fairly automatic method of generating

Page 4: Implicit Finite-Difference Simulation of Flow about ...history.arc.nasa.gov/hist_pdfs/awards/hjaa_1987.pdfFinite-difference procedures are used to solve either the Euler equations

682 J.L. STEGER AIAA JOURNAL

smoothly varying grids that fit arbitrary bodies and allow gridpoint clustering. While several automatic grid solvers havebeen developed1"3'17"20 one that is appealing for the presentapplication is the scheme advocated by Thompson et al. l andThames et al.2 In their method the grid in the physical planeis defined by the solution of a Laplace or a Poisson equation.Grid points are arbitrarily specified on the body boundaries,so even if the Laplace equation is used the generated grid isnot orthogonal. The capability to select the location ofboundary node points is one of the desirable features of thescheme and Eqs. (3) and (4) do not assume orthogonality.

To actually solve the grid generation equations, the Poissonequation is itself transformed to the specified transform planeand is solved on the same rectangular grid on which the flowequations are solved (see Fig. 1). In the grid generationmethod of Thompson et al. this entails finding values of x,yon the known £,17 grid by solution of

=-J2 (Px

+yyin = -J2 (Py± + Qy, ) (22)

where

/ — v-2

S-S/ifD

- IX

M

and where am, bn, cm and dn are arbitrary positive coef-ficients. Values of x and y on the £ and r; domain boundariesare known and correspond to the specified x,y grid points inthe physical domain. The transformed Poisson equation isnonlinear but it remains elliptic and is easily solved by con-ventional relaxation methods used, for example, for subsonicpotential flow.

The grid generated is smoothly continuous, and grid pointscan be clustered along the body as desired. Clustering of gridpoints to the body is seldom adequate if the Laplace equation(Pand 2 = 0) is used as the original grid generating equations.The problem that is encountered can be observed in Fig. 2,which illustrates a grid generated about an airfoil. In this casepoints are specified on the airfoil, a cut behind the airfoil, andall outer boundaries as indicated in the schematic illustrationshown in Fig. 1. For these boundary conditions the interiorpoints are poorly clustered in the radial-like rj direction, awayfrom the trailing edge. To obtain good clustering in thisdirection, one can adjust the P and Q source terms of Eq. (22)or perhaps some other terms. Alternately, the grid pointdistribution along a line of constant £ or 17 can be discardedand reclustered by simple stretching relations (see Ref. 21 fordetails). Because of its simplicity this is the approach takenhere. Figure 3 illustrates this clustering where the x,ydistribution of grid points along each line of constant £ shownin Fig. 2 is redistributed by means of a stretching relation. Anexpanded portion of the grid about the airfoil is detailed inFig. 4. Note that the highly skewed lines in the wake occurbecause x and y are specified on the cut ab and de (see Fig. 1).Floating these values removes this skewness, but the gridspacing along the cut must then be controlled in another way,for example, the source term P.

Fig. 2 Grid generated aboutan airfoil with P and Q = 0.

Fig. 3 Computational gridgenerated by combining simplestretching in 17 with theThompson, Thames, and Mast inmethod.

Fig. 4 Grid detail near body.

AccuracyOnce a grid is generated it is a simple matter to difference

the xy values in the transformed plane to form x%, x^, y%, y^and from this information form the metrics %x, £yt rix, riy, andJ using Eq. (6). The metrics themselves should be evaluatedwith sufficient accuracy that they correctly carry informationabout geometry; however, an exact evaluation of the metricswould not necessarily lead to the minimum error. Consider,for example, the continuity equation in steady freestream withf = 0. From Eq. (4)

or using Eq. (6) and taking p^u^ outside the operator

(23)

(24)

If the terms y^ and y% are exactly evaluated but the operatorsd^ and d^ are approximated by central differences, then Eq.(24) is not identically zero but is zero to second-order ac-curacy. In the far field, in which y may vary rapidly, this error

Page 5: Implicit Finite-Difference Simulation of Flow about ...history.arc.nasa.gov/hist_pdfs/awards/hjaa_1987.pdfFinite-difference procedures are used to solve either the Euler equations

JULY 1978 SIMULATION OF FLOW ABOUT TWO-DIMENSIONAL GEOMETRIES 683

can be appreciable. However, if y^ and y$. are also centrallydifferenced, the difference equations cancel identically forconstant values of pu for any grid stretching.

In fact, the transformed differenced equations are exactlybalanced on any deformed rectangular grid for constantvalues of p, pu, pv, and e if identical central differenceoperators are used to evaluate both the metric terms and thespatial derivatives of the governing equations. Such differenceoperators are used throughout this work. Once the dependentvariables depart from constant or freestream values, the gridin the physical plane must meet additional constraints if goodsolution accuracy is to be obtained. In particular, thedependent variables should vary smoothly with £ and rj andthe metrics should be evaluated with sufficient accuracy.

V. Implicit AlgorithmA time-implicit numerical algorithm is used to solve the

equations because in many flowfield problems it is desirableto take a larger time step than that permitted by a con-ventional explicit scheme. Such a situation may occur if thedependent variables experience a more rapid variation withspace than with time or if the time accuracy is controlled byboundary conditions which act as forcing functions.

In the Beam-Warming10'11 delta-form approximate-factorization (AF) algorithm, which is used here, the maincomputational work is contained in the solution of blocktridiagonal systems of equations. As a consequence, the trans-formed flowfield equations (including the viscous terms) arenot much more costly to solve than the equations in Cartesiancoordinates. The Beam-Warming implicit algorithm has beendescribed elsewhere in various applications10'11'13'22 and ispresented here without elaboration. For either trapezoidal orEuler temporal implicit differencing the delta-form algorithmis given by

n + I -qn)

2}Jq" (25)

where for the convection terms 5^ and d^ are second-ordercentral difference operators, h = At or At/2 for first-order orsecond-order two-level time differencing, and for conveniencethe spatial indices are deleted throughout. For second-orderaccuracy all of the metric terms should be evaluated at timelevel /7 + '/2 and A, B, and M are defined in Sec. III. Fourth-order dissipation terms ( V^ A^ ) 2 and ( V^A^ ) 2 are explicitlyappended to the right-hand side to control numerical stabilitywhere, for example, V^ is the conventional backward dif-ference, V^ =I — E^} and E f 1 qjk=qj±ltk. For consistency,these terms are multiplied by At and here a. = 0(1). To alleviaterestrictive stability bounds (aA/X 1/16), second differencesoperating on qn + I —qn are inserted into the implicit factors.By a linear stability test with h = At one finds that aAt< l/2.Implicit use of fourth-order differences as dissipation termswould permit any value of aAt but would require block-pentadiagonal inversions. Note that the dissipation termshave been scaled by the Jacobian determinate to maintain afreestream solution, so the numerical dissipation terms arenot conservatively differenced.

The viscous terms are central-differenced in the usual way.Any one term has the form d^ad^P and is differenced as

(26)-(aj>k + a J i k _ } ) ( ( 3 J > k - l 3 J > k _ 1 ) ] / [ 2 ( A r 1 ) 2 ]

For transonic flow cases, upwind second-order trapezoidal(or Fade) spatial differencing is used in the £ direction for the

last several points prior to the shock wave in order to preventupstream shock capturing oscillations. The operator istransitioned as described by Beam and Warming10 and the £-direction dissipation term must be removed in regions ofupwind differencing. In the freestream, the Fade upwinddifference operator does not lead to perfect difference can-cellation as does the central difference operator, but in thecurrent application it is employed only in those portions of thegrid that gradually vary.

Finally, it is remarked that higher-order spatial accuracyfor the convection terms is simply achieved in the steady stateby using fourth-order accurate central differences for theright-hand side operators <5^ and 5^. However, this dif-ferencing has not been combined with upwind differencingand, according to linear stability theory, it is unstable whenh = At/2.

To solve Eq. (25) one first forms the right-hand side terms,beginning with the smoothing operator and then the steadypart of the partial differential equation. These values aretemporarily stored in qn+1. The block tridiagonals in £ arethen formed and solved with the result again stored in qn + I.Finally, the block tridiagonals in r? are formed, solved, andthe correct value of qn + I is found by adding qn to the result.

Throughout the inversion process values of qn + 1 areassumed to equal qn on the flowfield boundaries. This ap-proximation results in a first-order accurate error in time onthe boundary, but leads to a simple and flexible scheme. Inthe present formulation new values of q are obtained on thebody boundary at the start of each time step by linear ex-trapolation of the flowfield for p and U and using Eq. (11) tofind new values of u and v. Updated values for surfacepressure are obtained from Eq. (12) by central differencing/?£, forward differencing/?^, and solving a tridiagonal systemof equations for p along the body surface. These data are thenconverted into values of p pu, pv, and e. For the particularproblem shown in Fig. 1, values of p, pu, and pv are found onthe downstream boundaries e/and ah by extrapolation and eis found from Eq. (2) by maintaining/?— p^. Flowfield valuesalong the common cut de and ba are found by averaginglinear extrapolates of the variables from above and below.Finally, the numerical dissipation terms are dropped tosecond differences at points adjacent to the boundaries andare dropped altogether at body surfaces in viscous flows.

All of the boundary conditions could have been at leastpartially incorporated into the implicit inversion process;doing so would have improved the time accuracy and perhapsallowed larger time steps to be taken without instability.However, the inclusion of a particular set of boundaryconditions into the inversion process leads to a more com-plicated program that is not as readily converted to otherflowfield problems.

VI. ResultsA variety of flowfields about airfoils have been computed

to test the combination of numerical algorithm, grid map-ping, and boundary conditions for the transformed flowequations. Inviscid and viscid, steady and unsteady cases havebeen run.

A subcritical flow solution and comparison are shown inFig. 5. The flow was computed about a NACA 0012 airfoil atan angle of attack o: of 2 deg using a grid similar to that shownin Fig. 3. Some 49 grid points were distributed over the airfoiland the minimum grid spacing in the rj-direction was 0.01chords. The grid was stretched smoothly to 8-12 chord lengthsaway from the body, depending on whether the outer bound-ary was horizontal or vertical to the airfoil. The presentsolution accuracy is satisfactory in comparison to the Sells23

solution proposed by Lock24 as a test case, although betterleading-edge grid refinement is desired.

A transonic solution obtained with and without upwinddifferencing is shown for the same airfoil in Fig. 6 with

Page 6: Implicit Finite-Difference Simulation of Flow about ...history.arc.nasa.gov/hist_pdfs/awards/hjaa_1987.pdfFinite-difference procedures are used to solve either the Euler equations

684 J. L. STEGER AIAA JOURNAL

•85———— STREAM FUNCTION SOLUTION,

REF. 24

VA CURRENT SOLUTION

.4 .6 .8 1.0x/c

Fig. 5 Inviscid subcritical comparison.

NACA 0012Mx = 0.75a = 2°

• NONCONSERVATIVE FULL POTENTIALSOLUTION REF. 25

V A CURRENT SOLUTION, CENTRALDIFFERENCING

O SUPERSONIC UPWIND DIFFERENCING)

I I I

Fig. 6 Inviscid transonic comparison.

NACA64A010M^ = 0.80, a = 0°PLUNGE - a = 1°

V A CURRENT SOLUTIONCN = 0.238Cm =-0.0170

——— MAGNUS SOLUTION, REF. 26CM = 0.235Cm = -0.0152

Fig. 7 Transonic airfoil solution at a constant plunge velocity.

CL

.10

.05

0;

-.05,

-.10

NACA64A010

Moo = 0.8, a = 0INVISCID

__.._ CURRENT SOLUTION

• A DATA FROM MAGNUS, REF. 26

/' ^x.

60 120 180 240 300 360PLUNGE ANGLE, !//, deg

Fig. 8 CL and Cm variation during the fourth cycle of sinusoidalplunging motion.

MO, =0.75 and a. = 2 deg. For comparison, a nonconservativefull potential solution25 is shown which tends to place theshock wave too far upstream. The effect of angle of attackcan also be achieved by plunging the airfoil at a constant rateby simply setting rjt=—yTrjy and £,= — yTZy solutionabout a NACA 64 AGIO airfoil in a plunge equivalent to anangle of attack of 1 deg (yT= —a^M^ sin (?r/180) where a^ isthe nondimensional reference speed) is compared to a veryaccurate calculation due to Magnus26 in Fig. 7. Again, thesolution accuracy is good although clearly the weak shock onthe lower surface is highly diffused in the coarse grid. In thepreceding calculations approximately 800 time steps arerequired to reach a steady state.

A sinusoidally plunging airfoil comparison was also madewith the Magnus26 program and in Fig. 8 both CL and Cmcomparisons during the fourth cycle are shown. The airfoil inthis case is plunging between ± 1 deg with a reducedfrequency of 0.4 [where the reduced frequency is defined byk = 2ir/(tpMQO) and tp is the nondimensional time period,tp =tpa^ /(chord length)]. The lift comparison with Magnus isexcellent, but the moment about the quarter chord differssomewhat in amplitude and phase. The moment, however, isvery sensitive to shock smearing and this discrepancy can beattributed to the coarser grid used with the present method.

The inviscid calculations basically show the accuracy andflexibility of the code. Good results are obtained on arelatively coarse grid and with use of a finer grid should beexcellent.

A series of viscous flow calculations was made with veryfine grid spacings in the rj direction. For example, for anRe=llx\Q6 simulation the minimum grid spacing near thebody was 0.000025, but the grid is stretched exponentiallyaway from the body. As mentioned previously, a two-layereddy viscosity model was provided by Baldwin for turbulentflow simulations.

To substantiate the numerical algorithm a laminar flowcalculation was made at low Mach number (M^ = 0.2) and inFig. 9 is compared to one of Mehta's27 excellent in-compressible solutions for flow about an NACA 0012 airfoilin zero angle of attack and Re=\04. Like the inviscidsolutions, the agreement is good for the grid size used, but thediscontinuous change of body shape at the airfoil trailing edgedoes result in small spurious oscillations in that region. Thiserror is accentuated at lower Mach numbers and forMOO =0(0.1) the numerical algorithm became generallyinaccurate with very poor steady-state convergence.

A series of exploratory calculations was made with an 18%thick biconvex airfoil at zero angle of attack using a relatively

Page 7: Implicit Finite-Difference Simulation of Flow about ...history.arc.nasa.gov/hist_pdfs/awards/hjaa_1987.pdfFinite-difference procedures are used to solve either the Euler equations

JULY 1978 SIMULATION OF FLOW ABOUT TWO-DIMENSIONAL GEOMETRIES 685

NACA0012cv = 0°, IRe = 104, LAMINAR

———— MEHTA INCOMPRESSIBLE SOLUTIONS ^ SEPARATION

O CURRENT SOLUTION,M^ = 0.2

(s) - SEPARATION

Fig. 9 Laminar flow comparison.

^ o

VBLUNTED NOSE BICONVEX18% THICKM^ = 0.754Re = 11 x 106

O NUMERICAL

4 EXPERIMENTAL DATA, REF. 28

I I

Fig. 10 Computed pressure distribution over an 18% thick biconvexairfoil.

coarse grid. Experimental data on this airfoil were taken byMcDevitt et al.28 in the high Reynolds number channel atAmes Research Center. Numerical calculations were per-formed by Deiwert29'30 and, more recently, Levy31 has beenexploring the buffet range of this airfoil, using the Deiwertcode with MacCormack's new modifications to improveefficiency.32 In Levy's calculation, the leading edge of thebiconvex airfoil was blunted slightly and the same airfoil wasused in the following calculations. In the experiment, theairfoil buffets through the Mach number range 0.76 to 0.78,although this range can be extended depending on whether thetunnel Mach number is brought up or brought down from aprevious Mach number value. In Levy's calculations, strongbuffeting occurs at M^= 0.754 with a reduced frequency£ = 0.81. In the present calculation Mx =0.154 is very steadyand is in relative agreement with experiment (see Fig. 10).Even plunging the airfoil for a brief period failed to induce abuffet condition. However, buffeting does occur with thepresent code at M^ =0.783 at a reduced frequency of 0.82where the period of oscillation was found from the CL vs a.curve shown in Fig. 11. Levy31 gets essentially steady flow atthis Mach number.

20 24 32 36

Fig. 11 CL vs nondimensional time (£=1-0.783 chords traveled)for an 18% thick biconvex airfoil at M^ = 0.783 and a = 0 deg.

Computer processor times for inviscid flow calculationsusing a 11x21 grid have been approximately 0.75 seconds pertime step on a Control Data Corporation 7600 computer andapproximately 1.25 second per time step for the viscous cases(with turbulence model) on a 71x33 grid. The presentprogram is strictly a research code, and computer processorunit (CPU) times should be reduced by 14 to Vi by carefulreprogramming.

Even without assuming improvements to the numericalalgorithm, significant improvements in CPU time will likelybe obtained by exploiting the organized data structure of theoverall numerical algorithm. This is because arbitrarygeometries are mapped onto grid lines of a well-orderedrectangular grid (in contrast to some poorly ordered finite-element methods that use triangular elements) and the spatialoperators have been factored into products of easily in-vertible, one-dimensional operators. Although not employedhere, the algorithm can be readily modified to accept interiorboundary surfaces. Consequently, the overall numericalalgorithm is compatible with vectorized computer processors.At this writing, H. Lomax and H. E. Bailey of Ames ResearchCenter have successfully adapted the basic algorithm(without, for example, upwind differencing) to the ILLIACIV parallel computer processor.

VII. ConclusionsAn implicit finite-difference scheme has been combined

with transformations that permit use of automatic gridgeneration techniques. The overall algorithm for theequations of motion in conservation law form has con-siderable flexibility and should be adaptable to a variety ofproblems. The algorithm is sufficiently robust and efficientfor many unsteady flow problems and can be used to obtainsteady-state solutions as well.

References1 Thompson, J. F., Thames, F. C., and Mastin, C. M.,"Automatic

Numerical Generation of Body-Fitted Curvilinear Coordinate Systemfor Field Containing any Number of Arbitrary Two-DimensionalBodies," Journal of Computational Physics, Vol. 15, July 1974, pp.299-319.

2Thames, F. C., Thompson, J. F., and Mastin, C. M., "Numerical• Solution of the Navier-Stokes Equations for Arbitrary Two-Dimensional Airfoils," NASA SP-347, Pt. I, March 1975, pp. 469-530.

3Ghia, U. and Ghia, K. N., "Numerical Generation of a System ofCurvilinear Coordinates for Turbine Cascade Flow Analysis," Univ.of Cincinnati, Kept. No. AFL 75-4-17, 1975.

4Lapidus, A., "A Detached Shock Calculation by Second-OrderFinite Differences," Journal of Computational Physics, Vol. 2, Nov.1967, pp. 154-177.

5 Viviand, H., "Conservative Forms of Gas Dynamic Equations,"La Recherche Aerospatiale, No. 1, Jan.-Feb. 1974, pp. 65-68.

6Vinokur, M., "Conservation Equations of Gas-dynamics inCurvilinear Coordinate Systems," Journal of Computational Physics,Vol. 14, Feb. 1974, pp. 105-125.

7MacCormack, R. W. and Paullay, A. J., "The Influence of theComputational Mesh on Accuracy for Initial Value Problems withDiscontinuous or Nonunique Solutions," Computers and Fluids, Vol.2, Dec. 1974, pp. 339-361.

Page 8: Implicit Finite-Difference Simulation of Flow about ...history.arc.nasa.gov/hist_pdfs/awards/hjaa_1987.pdfFinite-difference procedures are used to solve either the Euler equations

686 J. L. STEGER AIAA JOURNAL

8Rizzi, A., "Transonic Solutions of the Euler Equations by theFinite Volume Method," Proceedings of Symposium Transsonicum77, edited by K. Oswatitsch and D. Rues, Springer-Verlag, 1975, pp.567-574.

9Schiff, L. B., "A Numerical Solution of the Axisymmetric JetCounterflow Problem," Lecture Notes in Physics, Vol. 59, Springer-Verlag, 1976.

10Beam, R. and Warming, R. P., "An Implicit Finite-DifferenceAlgorithm for Hyperbolic Systems in Conservation-Law-Form,"Journal of Computational Physics, Vol. 22, Sept. 1976, pp. 87-110.

11 Beam, R. and Warming, R. F., "An Implicit Factored Schemefor the Compressible Navier-Stokes Equations," AIAA Paper 77-645,June 1977.

12Briley, W. R. and McDonald, H., "An Implicit NumericalMethod for the Multi-Dimensional Compressible Navier-StokesEquations," United Aircraft Research Laboratoties, Rept. M911363-6, 1973.

13Steger, J. L. and Kutler, P., "Implicit Finite-DifferenceProcedures for the Computation of Vortex Wakes," AIAA Paper 76-385, July 1976.

14Peyret, R. and Viviand, H., "Computation of Viscous Com-pressible Flows Based on the Navier-Stokes Equations," AGARD-AG-212, 1975.

15Warming, R. F., Beam, R., and Hyett, B. J., "Diagonalizationand Simulations Symmetrization of the Gas-Dynamic Matrices,"Mathematics of Computation, Vol. 29, Oct. 1975, pp. 1037-1045.

16Cebeci, T., "Calculation of Compressible Turbulent BoundaryLayers with Heat and Mass Transfer," AIAA Journal, Vol. 9, June1971, pp. 1091-1097.

17Barfield, W. D., "Numerical Method for Generating OrthogonalCurvilinear Meshes," Journal of Computational Physics, Vol. 5, Feb.1970, pp. 23-33.

18Amsden, A. A. and Hirt, C. W., "A Simple Scheme forGenerating Curvilinear Grids," Journal of Computational Physics,Vol. 11, March 1973, pp. 348-359.

19Chu, W. H., "Development of a General Finite DifferenceApproximation for a General Domain," Journal of ComputationalPhysics, Vol. 8, Dec. 1971, pp. 392-408.

20Godunov, S. K. and Prokopov, G. P., "The Use of MovingMeshes in Gas-Dynamical Computations," U.S.S.R. ComputationalMathematics and Mathematical Physics, Vol. 12, No. 2, 1972, pp.182-195.

21Sorenson, R. and Steger, J. L., "Simplified Clustering ofNonorthogonal Grids Generated by Elliptic Partial DifferentialEquations," NASATM-73,252, 1977.

22Kutler, P., Chakravarthy, S. R., and Lombard, C. K.,"Supersonic Flow Over Ablated Nosetips Using a Unsteady ImplicitNumerical Procedure," AIAA Paper 78-213, Jan. 1978.

23Sells, C. C. L., "Plane Subcritical Flow Past a Lifting Airfoil,"Royal Aircraft Establishment, Tech. Rept. 67146, 1967.

24Lock, R. C., "Test Cases for Numerical Methods in TwoDimensional Transonic Flow," AGARD Rept. 575, 1960.

25Steger, J. L. and Lomax, H., "Numerical Calculation ofTransonic Flow About Two-Dimensional Airfoils by RelaxationProcedures," AIAA Journal, Vol. 10, Jan. 1972, pp. 49-54.

26Magnus, R. J., "Computational Research on Inviscid, Unsteady,Transonic Flow Over Airfoils," Office of Naval Reseach,CASD/LVP77-D10, Jan. 1977.

27Mehta, U., Private communication, NASA Ames ResearchCenter, Moffett Field, Calif., 1976.

28McDevitt, J. B., Levy, L. L., Jr., and Deiwert, G. S., "TransonicFlow About a Thick Circular-Arc Airfoil," AIAA Journal, Vol. 14,May 1976, pp. 606-613.

29Deiwert, G. S., "Numerical Simulation of High ReynoldsNumber Transonic Flows," AIAA Journal, Vol. 13, Oct. 1975, pp.1354-1359.

30Deiwert, G. S., "Computation of Separated Transonic TurbulentFlows," AIAA Journal, Vol. 14, June 1976, pp. 735-740.

31 Levy, L. L., Jr., "An Experimental and Computational In-vestigation of the Steady and Unsteady Transonic Flowfield About anAirfoil and a Solid Wall Test Channel," AIAA Paper 77-678, July1977.

32MacCormack, R. W., "An Efficient Numerical Method forSolving the Time Dependent Compressible Navier-Stokes Equationsat High Reynolds Number," NASA TM X-73,129, July 1976.

From the AIAA Progress in Astronautics and Aeronautics Series..

TURBULENT COMBUSTION—v. 58Edited by Lawrence A. Kennedy, State University of New York at Buffalo

Practical combustion systems are almost all based on turbulent combustion, as distinct from the more elementaryprocesses (more academically appealing) of laminar or even stationary combustion. A practical combustor, whetheremployed in a power generating plant, in an automobile engine, in an aircraft jet engine, or whatever, requires a large andfast mass flow or throughput in order to meet useful specifications. The impetus for the study of turbulent combustion istherefore strong. /

In spite of th is , our understanding of turbulent combustion processes, that is, more specifically the interplay of fastoxidative chemical reactions, strong transport fluxes of heat and mass, and intense fluid-mechanical turbulence, is stil lincomplete. In the last few years, two strong forces have emerged that now compel research scientists to attack the subjectof tu rbu len t combustion anew. One is the development of novel instrumental techniques that permit rather precisenonintrusive measurement of reactant concentrations, turbulent velocity fluctuations, temperatures, etc., generally byoptical means using laser beams. The other is the compelling demand to solve hitherto bypassed problems such as iden-t i fy ing the mechanisms responsible for the production of the minor compounds labeled pollutants and discovering ways toreduce such emissions.

This new climate of research in turbulent combustion and the availability of new results led to the Symposium fromwhich th is book is derived. Anyone interested in the modern science of combustion will find this book a rewarding sourceof informat ion.

485pp.,6x 9, illus.'$20.00 Mem. $35.00 List

TO ORDER WRITE: Publications Dept., AIAA, 1290 Avenue of the Americas, New York, N. Y. 10019