Skip navigation links
(Wind-US Documentation Home Page) (Wind-US User's Guide) (GMAN User's Guide) (MADCAP User's Guide) (CFPOST User's Guide) (Wind-US Utilities) (Common File User's Guide) (Wind-US Installation Guide) (Wind-US Developer's Reference) (Guidelines Documents)

(Introduction) (Tutorial) (Geometry and Flow Physics Modeling) (Numerical Modeling) (Boundary Conditions) (Convergence Monitoring) (Files) (Scripts) (Parallel Processing) (Keyword Reference) (Test Options)

Test Options

Several user-controlled options have been provided as an aid to modifying Wind-US. These options all may be selected by using the keyword TEST in the input data file. The test options typically control program features which are under test, and have not been accepted for production use. Each test option is of the form

   TEST number mode

If mode is not described for a given test option, the user should use mode = 1 to activate that option.

As test options are accepted, they are "hard wired" into the code and the test option described here becomes meaningless. Test options may also be rejected based on trial runs. In that case, the option code described here will also become meaningless. For this reason, the list of valid options is not consecutive. Selection of an invalid option will be accepted by Wind-US, but will have no effect.

The various test options and modes are described below. For each option, the subroutines referencing that option are listed in parentheses.

Non-Production Test Options

number    Description

1 Reserved for use at ITAC.

2Designed for parallel processing data transfer debugging.

    mode   Result
1 Don't read zonal boundary data (evrwbd)
2 Not used
4 Don't solve zone (evsolv)
8 Don't write zonal data (evwzon)
16 Don't write zonal boundary data (evrwbd)
32 Not used
64 Not used
128 Not used
256 Don't update boundary conditions (structured grids only) (lpschm)

Set mode equal to the sum of the desired actions.

3Parallel processing task tracing.

    mode   Action
1Trace event reads/writes (rwev)
2Trace file I/O (rwnh, rwc, rwd, rwi, rwr)
4Trace network traffic (psexit, psgscat, psrwev, psrwgv, psrwnh, psrwc, psrwd, psrwi, psrwr, rwbc)
8Trace task begin/end (psspwn, tskbeg, tskidl)
16Print task queue for debugging (psqprt)

Set mode equal to the sum of the desired actions. I.e., setting mode = 5 will trace both event reads/writes and network traffic.

4 Reserved for use at ITAC.

5Flag for procedure used in gas1 to compute effective specific heat ratio β and sound speed a for frozen and finite-rate chemistry.

    mode   Procedure
> 0Iterate on pressure, with a maximum of mode iterations
< 0Iterate on temperature, with a maximum of 20 iterations

The default is to iterate on pressure, with a maximum of 20 iterations. (gas1)

6Write .cfl file compatible with the "old" code. (asnsx, asvisc)

7Do not use high performance C I/O interface. (openf)

8Use Version 2 common files. (cftopn, mpinit, openf, zhinit)

9For mode = 1, run a verification case using the method of manufactured solutions. If mode = 2, in addition to running the case, Plot3d function files named mms.exact.fxn, mms.cfd.fxn, and mms.error.fxn are written containing the exact solution, the Wind-US solution, and the error.

The functional forms for the primitive variables are combinations of sine and cosine functions, and are coded in subroutines mms_3d_euler_bc and mms_3d_ns_bc for the Euler and Navier-Stokes equations, respectively. The corresponding source terms for the governing equations are coded in subroutines mms_3d_euler_src and mms_3d_ns_src.

The choice of an Euler or Navier-Stokes solution is determined by the TURBULENCE keyword. If the flow is inviscid in all zones, an Euler solution is computed; otherwise, a constant-viscosity laminar Navier-Stokes solution is computed. The flow may be 2-D or 3-D, as determined by the grid file.

Multi-zone grids may be used, but the use of COUPLING MODE CHARACTERISTIC is recommended for Navier-Stokes solutions. (Viscous terms are neglected in Roe boundary coupling, and they are large in the method of manufactured solutions.)

Frozen boundary conditions must be specified in the grid file at all non-coupled boundaries. The appropriate boundary conditions for the functional forms being used will then be set automatically.

See Roach [Roach, P. J. (1998) Verification and Validation in Computational Science and Engineering, Hermosa Publishers, New Mexico], and Salari and Knupp [Salari, K. and Knupp, P. (2000) "Code Verification by the Method of Manufactured Solutions," SAND 2000-1444, Sandia National Laboratories, Albuquerque, New Mexico], for more detailed information on the method of manufactured solutions. (l2norm1d, lpschm, mms_test_soln, nsrhss, pstinp, sins, tdbcni)

10Print the time step information (i.e., minimum/maximum CFL and Δt) into the .lis file every mode cycles, instead of just on the first cycle. (NSzsolv)

11Normally, the flowfield is rotated to be consistent with changes in the global angles of attack and sideslip. This TEST option prevents that rotation. (Changes in the global angles may occur at the start of a restart run, if the user specifies angles that are different from the values in the .cfl file, or during a run when the FIXED_CL keyword is used.) (lpgrp)

12In the HLLC scheme, use a more accurate method for computing the wave speeds. (hllc, US_HLLC, US_HLLCRL)

13 Reserved for use at ITAC.

14For structured grids, write pressure to the .cfl file. (It's always written for unstructured grids.) (axflow)

15For the SST model with an ε limiter (the LESB keyword), modify the grid filter width Δ used in the limiter. This test option only applies to structured grids. (sst1, sst2, sst3)

    mode   Grid Filter Width
0 max(ds1, ds2, ds3, V dt, k1/2 dt)
1 max(ds1, ds2, ds3, k1/2 dt)
2 max(ds1, ds2, ds3, V dt)
3 max(ds1, ds2, ds3)

where ds1, ds2, and ds3 are the distances along the grid lines in the three directions, V is the velocity, k is the turbulent kinetic energy, and dt is the time step size.

16Manually set the blowing Mach number for BLOW SURFACE boundary conditions to mode / 100. The default is to compute the blowing Mach number from the local flow conditions and the specified plenum conditions, with a maximum value of 1.0. (Note that this sets the actual blowing Mach number, not a different maximum value.) (BC_bcbled)

17Use "new" Baldwin-Barth turbulence model. (bbarth)

18 Use the integrated mass flux rather than a point by point mass flux to determine the jump conditions of the HEAT EXCHANGER model. (BC_actud2, rwfghd, psrwgv)

19 Allow the use of chemistry (.chm) files with thermodynamic data in SPARKCRV or WINDNASA format, even though those formats are now deprecated because they lack information needed to correctly calculate entropy. When using this option, total/static conversions are only a rough approximation. If possible, avoid this option and use chemistry files with data in the NASA3287 format.

20 Non-dimensionalize k and ω in the SST model the "old" way. (aijkrg, aikeps, sstprtinp, sstpstprt)

21 Flag affecting the initialization and freestream value of the eddy viscosity for the Spalart-Allmaras and Goldberg turbulence models. (goldbergprtinp, goldbergpstprt, redimsa, sabound, saprtinp, sapstprt, sinut, spalart, TURB_goldbergboundUS, TURB_saboundUS)

    mode   Result
0, 1Use a default freestream value for (νt) of 5.0, and initilize the dependent variable to (νt) / νl.
2Use a default freestream value for (νt) of 0.1, and initilize the dependent variable to (νt).

In addition, for the Spalart-Allmaras model in structured grids,

    mode   Result
0Use the original 1992 model, with an ft2 term for laminar stabilization.
1Like mode 0, except with "corrections" to the production and destruction terms. This is equivalent to the default model for WIND beta versions 4.15 to 4.92. (Note that's "WIND," which predates "Wind-US".)
2Like mode 1, except without the ft2 term. This is equivalent to the default model for WIND versions prior to WIND beta 4.15, and includes a slight error that makes the model overly dissipative.

22Compute the corrected MASS FLOW RATE based on area-averaged total pressure and temperature rather than area-averaged static values. (BC_pdsmfr)
25In the Baldwin-Lomax model, use y+ based on wall vorticity. (blomax)

26Use local values in y+ damping for the Baldwin-Lomax, Cebeci-Smith, Baldwin-Barth, and k-ε models. (bbdamp, blomax, cebeci, kepy2)

29For the Cebeci-Smith model, use y+ based on wall vorticity. (algtur, cebeci)

For the k-ε models, TEST 29 is a production limiter (kelhssch, kelhssrg, keprod, kerhssch, kerhssrg, redimkeps3d)

    mode   Result
0Production limited to 20 × dissipation
1Production computed from vorticity, but not limited
2Production not limited
3Production computed from vorticity, then limited
4Production computed using 2μtSijSij, but not limited
5Production computed using 2μtSijSij, then limited

Modes 4 and 5 only apply to the Rumsey-Gatski ASM k-ε model.

30Irrotational boundary condition at freestream inflow boundaries (structured zones only). (BC_bcfree)

31Use quadratic curve fit when applying normal derivative boundary conditions (∂p/∂n and ∂T/∂n) at walls. (BC_bcwall)

32Modifies the default handling of outflow boundaries. This option is intended to improve performance when boundaries in supersonic flow pass through an outflow boundary. For the subsonic points, instead of imposing the downstream pressure from the .dat file or using a simple extrapolation (both of which have their problems), the TEST option causes a search to be performed for the nearest supersonic point, and the pressure at that point is used as the downstream pressure. (BC_preBC, US_tdbcg)

33Hold the temperature on a viscous wall at the current value, using the conjugate heat transfer model. See the WALL TEMPERATURE FIXED keyword for a similar capability. (lpcycl)

34Coefficient for the streamwise vorticity term when using the BSL or SST turbulence models with the net vorticity transport (NVT) option. For details, see the description for TEST 44. (sstpk)

37In wbnd2, deallocate memory used for boundary coupling data before returning. (wbnd2)

38Coefficient for the streamwise velocity gradient term when using the BSL or SST turbulence models with the net vorticity transport (NVT) option. For details, see the description for TEST 44. (sstpk)

39Used with the BSL and SST turbulence models to specify freestream sustainment terms. (sstbound, sst2)

    mode   Result
0Sustainment terms are not used.
1Sustainment terms are used at all locations to preserve the freestream turbulence values (k,ω) set using the FREE_K and FREE_OMEGA keywords.
>1Sustainment terms are used at all locations. However two different levels of turbulence may be preserved. In regions where Tt<1.3*Tt∞, freestream turbulence values are sustained. In regions where Tt>1.5*Tt∞, (e.g., jet plumes) engine turbulence values are sustained instead. In intermediate regions, the sustainment terms are linearly interpolated based upon the local total temperature. The engine turbulence values are computed by treating mode as one thousand times the intensity of turbulent kinetic energy relative to the freestream velocity.
    k = 1.5*(0.01*(mode/1000)*U)2
    ω = ω
Thus, using mode 1000 would result in a turbulence intensity of one percent.

*40*Obsolete. Use K-E COMPRESSIBILITY CORRECTION instead. (keppstin)

41Coefficient for the density gradient term when using the BSL or SST turbulence models with the net vorticity transport (NVT) option. For details, see the description for TEST 44. (sstpk)

43Specify an alternate value for σω2, the diffusion coefficient used in the ω transport equation of the BSL and SST turbulence models. (sstpstprt)

    mode   Result
0Use the default value of 0.856.
nUse a value of 0.001*n.

44Controls modifications of the turbulent kinetic energy production term, \({\cal P}_k = \nu_T \Gamma^2\), in the outer layer of the BSL OR SST turbulence models. These changes are referred to as Net Vorticity Transport (NVT) modifications and are described by Bush (2014). They are intended to incorporate sensitivity to thermal shear layers by the inclusion of density gradient terms.

In order to understand what this option does, the following definitions are needed:

    Variable   Description
\(\vec{\Omega} = \nabla \times \vec{V}\) Vorticity vector
\(\Omega_s = \frac{\vec{V}}{|\vec{V}|} \cdot \vec{\Omega}\) Vorticity magnitude in streamwise direction.
if TEST(34)≠0, then multiply Ωs by 0.001*TEST(34).
\(\vec{D} = \frac{\nabla\rho}{\rho} \times \vec{V}\) Cross product of density gradient and velocity vector.
if TEST(41)≠0, then multiply D by 0.001*TEST(41).
\(\Lambda\) A pseudo-streamwise velocity gradient term (though not a proper vector quantity).
\(\Lambda = \vec{V} \cdot \left( \overrightarrow{ \frac{du}{dx}, \frac{dv}{dy}, \frac{dw}{dz} } \right) \left/ \sqrt{|\vec{V}|^2 \cdot \left| \left( \overrightarrow{ \frac{du}{dx}, \frac{dv}{dy}, \frac{dw}{dz} } \right) \right|^2} \right. \)
if TEST(38)≠0, then multiply Λ by 0.001*TEST(38).

The resulting effect on turbulence production can then be described as:

    mode   Result
0Use the default \({\cal P}_k\) formulation, based on vorticity: \(\Gamma = |\vec{\Omega}|\).
1Use a modified \({\cal P}_k\) formulation, based on the vector sum of \(\vec{\Omega}\) and \(\vec{D}\): \(\Gamma = |\vec{\Omega}+\vec{D}|\). Note that \(\vec{\Omega}+\vec{D} = (1/\rho) \nabla \times (\rho\vec{V})\) is related to the curl of momentum.
2Use a modified \({\cal P}_k\) formulation, based on the turbulent stress tensor and momentum gradient:
\(\Gamma^2 = \frac{\tau_{ij}^{T}}{\rho\mu_T} \frac{\partial{\rho u_i}}{\partial{x_j}}\).
3Use a modified \({\cal P}_k\) formulation, based on the amplitude sum of vorticity and density gradient term:
\(\Gamma^2 = |\vec{\Omega}|^2 + |\vec{D}|^2\).
4Reserved for future use. Use a modified \({\cal P}_k\) formulation, based on the amplitude sum of vorticity and density gradient term, and scaled by the streamwise velocity gradient term:
\(\Gamma^2 = (|\vec{\Omega}|^2 + |\vec{D}|^2)(1+\Lambda)\).
5Reserved for future use. Use a modified \({\cal P}_k\) formulation, based on the amplitude sum of vorticity and density gradient term, less the streamwise vorticity, and scaled by the streamwise velocity gradient term:
\(\Gamma^2 = ( |\vec{\Omega}|^2 + |\vec{D}|^2 - \Omega_s^2)(1+\Lambda)\).
This value is forced to remain non-negative.

Note that the above correction is only applied in the outer layer of the model. In the inner layer, the production term is computed from vorticity: Γ=|Ω|. The same F1 blending function used to switch model coefficients between inner and outer layer values is used to switch between the inner and outer layer Γ values. (sst2, sstpk)

[Bush, R.H. (2014) "Turbulence Model Extension for Low Speed Thermal Shear Layers," AIAA Paper 2014-2086.]

See also: TEST 34, TEST 38, TEST 41.


45Activate additional limiters recommended by Menter after the initial development of the the BSL and SST turbulence models. (sst2)

    mode   Result
0Extra limiters are not active.
1Limit the production of ω to be less than 20 times the dissipation of ω. Also limit the magnitude of the cross-diffusion term to 10 times the dissipation of ω while maintaining the sign.

46In the BSL or SST turbulence models, in blowing regions and bleed regions with a specified negative bleed flow rate, set μturb = 10μlam along the wall. (sstbound, TURB_sstboundUS)

47For the algebraic turbulence models, smooth turbulent viscosity in each i-plane using simple averaging, with the number of smoothing passes set to mode. (smtvis)

48For the algebraic turbulence models, smooth turbulent viscosity in three dimensions using simple averaging, with the number of smoothing passes set to mode. (smtvis)

49Modified smoothing for explicit operator for structured grids (see the SMOOTHING keyword). (bdload, dampi, dampj, dampk)

    mode   Result
2No pressure switch on second-order dissipation, and ramp fourth-order coefficient up and down
3No pressure switch, and an LES type filtering of nonlinear terms

*51* Obsolete. Replaced with the MUT LIMITER keyword option. Original description was as follows:

Limit the turbulent viscosity μT, such that the maximum value of μT / (μL) = mode × 1000. Suggested range is 50 < mode < 100. Not valid with the k-ε models; use K-E MAXIMUM TURBULENT VISCOSITY instead. (keppstin, mutlim, TURB_mutlim, TURB_UpdateGoldberg, TURB_UpdateSA, TURB_UpdateSST)

52When using BLOW PLENUM, print a warning when the plenum total pressure is automatically raised because it was less than the local static pressure. (BC_bcbled)

54Reserved for use at Boeing.

55Reserved for use at Boeing.

56No energy addition to fluid due to MFD equations. (emdef)

57When an explicit solution procedure is being used for the mean flow equations, still solve the Spalart-Allmaras and BSL/SST turbulence model equations using an implicit method. This test option only applies to structured grids. (spalart, sst1, sst2, sst3)

58For MFD flows, read the Lorentz force directly from the .cfl file, but using the .cfl file variable names normally used for the electric field. Requires EFIELD CFL in the MFD keyword block. (emdef)

59Apply SMOOTHING keyword values to the Spalart-Allmaras model as well as the mean flow solver. (Currently deactivated.) (spalart)

60Print warning when local and coupled normal velocities have inconsistent directions at a coupled boundary. (postrbs)

61When mode = 2, all boundary conditions are applied, whether or not they're consistent with the IBLANK values. This only affects corners, where there are usually multiple boundary conditions. So, if a wall boundary at j = 1 meets an outflow boundary at i = imax, if TEST 61 2 is specified, both boundary conditions are applied. (tdbcgs)

62Compute cell areas and volumes using procedure from WIND 4. This test option only applies to structured grids. (mphzmet, nsrhsv, tdarea, vismet)

63Eliminate the "fat" boundary cells in any coordinate direction. mode = 1, 2, or 4 indicates the i, j, and k direction, respectively. Set mode equal to the sum of the desired directions. I.e., setting mode = 5 will eliminate the "fat" boundary cells in the i and k directions. This test option only applies to structured grids. (mphzmet, nsrhsv, tdarea, tdarea2, vismet)

64Remove dt from dq when computing residuals. (l2norm1d)

65In marching solutions, lower the CFL number for the last marching step. (NSzsolv)

66Don't update β in gas3 for equilibrium chemistry. This test option is not recommended but will decrease run time. (gas3)

67Flag affecting boundary conditions for one- and two-equation turbulence models at bleed/blowing boundaries. (kebc, sabound, sstbound, TURB_goldbergboundUS, TURB_saboundUS, TURB_sstboundUS, vprtbound, vsctbound)

    mode   Result
0Treat bleed/blowing boundaries as no-slip walls.
1Treat bleed/blowing boundaries as slip walls. This was the default behavior prior to WIND 5.101.
2Same as mode 0, except do not use the procedure of Wilcox [Wilcox, D. C., Turbulence Modeling for CFD, DCW Industries, 2000] to compute the boundary condition for omega in the BSL or SST model.

68If the density is zero at a coupled boundary, issue a warning, ignore the coupling data, and continue. The default is to issue an error message and abort. This test option only applies to structured grids. (postrbs)

69Rescale the numerical roundoff in species mass fractions.

    mode   Result
0(Default) Multi-species cases with frozen or finite-rate chemistry solve ns − 1 species equations, where ns is the number of species, and the mole fraction for species number ns is set so that the total adds to one. All the numerical error is thus concentrated in the value of the mole fraction for the last species.

1A "dummy" last species is used, whose mole fraction is always zero. The Fortran variable ns is thus one more than the actual number of species in the flow. The code still solves ns − 1 equations, but that now corresponds to all of the "real" species of interest. In general the total of the mole fractions will not be exactly 1.0, so all the values are rescaled by a constant factor to make it 1.0, spreading any numerical error over all the species.

The dummy species is not added automatically. Thus, when this test option is used, the chemistry data (.chm) file must be modified to add entries at the end of the appropriate sections (i.e., thermodynamic coefficients, finite-rate coefficients, and transport properties) for the dummy species. The name of the dummy species doesn't matter, so one method would be to simply copy the entry for one of the other species, and change the species name to DUM to avoid confusion.

2Similar to mode 1, except that the dummy species is automatically created such that the user need not modify the chemistry (.chm) file.

(bcrcpl, bqlinit, chprtinp, chpstin1, dbstate, dqlim1, dqlim2, fixer, flagtbad, frtin1, gas1, gas1RL, gas2, gas3, gas4, gas4RL, propin, qlr2bql, rates2a, ratesaa, ratesadla, ratesarr, ratesbea ratesfa, ratesga, rhohcb, stomp, tdespair, transp, updatq1d, updatqnp, US_Qcell2Qvrtx)

70For mode > 0, the tolerance level for converging gas properties P, ρ, or T in gas2 will be set to 10mode. The default is 10−4. This only affects cases using TEST 99. (gas2)

71Calculation of thermodynamic and transport properties from curve fit equations in .chm file. (aichem, aijkrg, aikeps, airgun, aixyzrg, BC_bcfreebc, BC_bcfreechar, BC_ijkfreechar, BC_usrffreechar, chpstin1, chrhsv, cpfun, gas5, genturb, gibfn, hfun, kwinflow, Part_Evap, pevap, phinit, pstinp, sfun, tdutv1, therm1, trans1, transp, turbupd, uspeci)

For the thermodynamic properties,

    mode   Result
0 Abort if the temperature exceeds the maximum for the curve fits.
1 Extrapolate if the temperature exceeds the maximum for the curve fits, and write a warning message to the .lis file.
2 Same as mode 1, except without a warning message.
3 If the temperature is outside the range of the curve fits, use the values at the nearest limit.
4 Use constant values consistent with a gas constant of 287 m2/sec2-K, and a specific heat at constant pressure of 1004.5 m2/sec2-K.
5 If the temperature is outside the range of the curve fits, set the specific heat to its value at the nearest limit and extrapolate for remaining properties.

For the transport properties, the meaning depends on which formula (i.e., Sutherland's law or the NASA formula) is being used, and whether the temperature is above or below the range of the curve fits.

    mode   Result
0 For most cases, abort if the temperature is outside the range of the curve fits. The only exception is for Sutherland's law with a temperature lower than the minimum temperature for the curve fits. In that case, the values are extrapolated.
1 For Sutherland's law, extrapolate if the temperature is outside the range of the curve fits. If the temperature is too high, a warning message is written to the .lis file.

For the NASA formula, if the temperature is below the minimum value Tmin, apply Sutherland's law with constants computed using the NASA formula at Tmin. If the temperature is above the maximum value, extrapolate. A warning message is written to the .lis file in both cases.

2, 4, 5 Same as mode 1, except without a warning message.
3 If the temperature is outside the range of the curve fits, use the values at the nearest limit.

72, 73For structured grids, periodic boundaries may be established by setting up double (or larger) fringes at the boundaries using GMAN, with the boundary condition type specified as frozen. TEST options 72 and 73 provide the additional information needed to apply the boundary condition.

TEST option 72 specifies the direction(s) of periodicity, where values of 1, 2, and 4 indicate the i, j, and k direction, respectively. Set mode equal to the sum of the desired directions. E.g., setting mode = 5 means periodicity in both the i and k directions.

TEST option 73 specifies the depth of the fringes.

As an example, with TEST 72 1 (periodicity in the i direction) and TEST 73 2 (a double fringe), we have

    Conditions at   Come from
I = 1I = IDIM - 3
I = 2I = IDIM - 2
I = IDIM - 1I = 3
I = IDIMI = 4

This procedure may only be used for periodic boundaries within a single structured zone, with point-matched grids in the source and target regions. It's primarily useful for cases with higher-order differencing schemes, since the order of the scheme is preserved across the boundary. (kebc, sabound, sstbound, tdbcni, vprtbound, vsctbound)

74Include k-direction spacing when computing minimum time step in 2-D or axisymmetric flows. (tdtmst, tdvis1)

75Stop with an error message upon detecting an "Undefined" boundary condition on any structured grid point. Unstructured grids always perform this type of check by default. (tdbcg)

76Use air Cp for implicit chemistry terms. (rcutv1)

84Use the "old" viscous metric calculation, which averages the metric terms. (emdsolv, vismet)

85Check for zero volumes when computing viscous metrics. (emdsolv, vismet)

    mode   Result
1Check; if ≤ 0 print message and continue
2Check; if ≤ 0 print message and stop

87Freezes supersonic inflow at initial conditions. (BC_bcfreechar)

88Bypass checks for negative density and pressure check in tdgas. This is needed for chemically reacting flows if the heat of formation varies widely, since we only have the old heat of formation to use to estimate the temperature. (ChangeGridsLin, lpschm, tdgas)

*89* Obsolete. Original description was as follows:

Use "old" species flux correction method for multi-species flows. (gas1, transp)

90Chemistry stuff. (chinv)

    mode   Result
0Analytic chemistry Jacobian (ns = 5 only)
1Householder chemistry Jacobian
2Solves chemistry source term explicitly

91Gas constant. (BC_bcfreebc, chpstin1, therm1)

    mode   Result
1β = γ = β
2β = γ = 1.4

92Utilize operator splitting for the reacting chemistry source terms to increase the stability of the integration, allowing more efficient solution of the coupled system. A 4th-order Pade approximation is used to integrate the reaction source terms. (chimplicit, chinv, chptimp, chrhss, US_chemsrc, US_chimplicit, US_GaussSeidel)

    mode   Result
0No operator splitting.
<0Use operator splitting and perform point-implicit integration of the approximate chemistry source terms where the number of subiterations is |mode|. For unstructured grids, point-implicit is unavailable and this option will be treated the same as mode>0.
>0Use operator splitting and perform implicit integration of the approximate chemistry source terms where the number of subiterations is mode.

*93*Obsolete. Replaced with the DIFFUSION NONE option in the CHEMISTRY keyword block. (chrhsv, prtinp, rhsvfl, tdutv1, testprtinp)

94Turn off implicit chemistry terms. This test option only applies to structured grids. (tdimafk, tdimfu, tdimja, tdutaa)

95Turn off chemistry source term. (rates, rates2, rates2a, ratesa, ratesaa, ratesadl, ratesadla, ratesarr, ratesbe, ratesbea, ratesf, ratesfa, ratesg, ratesga)

96Gradually apply chemistry source term over the first mode iterations for finite-rate chemistry. (US_chemsrc, chrhss)

97P. D. Thomas turbulence model scanning direction. By default, Wind-US starts at viscous walls and moves into the field. This test option forces the code to calculate turbulent parameters from any boundary, in addition to walls. (algtur)

    mode   Result
0use j lines
1use k lines
2use j and k lines

99Initialize finite-rate chemistry with Liu and Vinokur curve fits. (Also see TEST 70.) (gas2)

    mode   Result
0Do not track the species (valid to 50K?)
1Track the species (valid to 10K?)

100Time-accurate characteristic extrapolation for coupled, freestream, and inflow boundaries. (BC_bcfree, BC_test100)

    mode   Result
02nd-order, with limit of ΔQ ≤ Q/2
11st-order, original characteristic treatment
22nd-order, original characteristic treatment (only available for structured grids)
31st-order, Roe's average characteristic treatment
42nd-order, Roe's average characteristic treatment (only available for structured grids)

102Use time-averaged back pressure when applying specified mass flow boundary condition at outflow boundaries. (BC_pdsmfr)

104Treatment of implicit viscous terms. This test option only applies to structured grids. (rcutv1, tdutv1)

    mode   Result
0Use simple implicit viscous terms.
1Turn off implicit viscous terms.
2Use fully-implicit viscous terms. This only applies to the energy diffusion term for frozen and finite-rate chemistry.

105Time step type. This test option only applies to structured grids. (iterprtinp, tdtmst)

    mode   Time Step Type
0Δt = CFL / max (λξ, λη, λζ)
1Flow angle scaling, Δt = CFL × (fξ Δξ + fη Δη + fζ Δζ), where
fξ = [1 + tan θ + tan ψ]1/2
fη = fξ tan θ
fζ = fξ tan ψ
2Velocity scaling, Δt = CFL × min (fξ Δξ, fη Δη, fζ Δζ), where
fξ = u / uξ / |uξ + c|
fη = u / uη / |uη + c|
fζ = u / uζ / |uζ + c|
3Δt = CFL × min (Δξ, Δη, Δζ) / (|u| + c)
4Δt = CFL / (λξ + λη + λζ)

106Compute the time step at the start of every cycle (even when Newton time stepping is being used), instead of at the start of every iteration. This test option only applies to structured grids. (axflow, lpgrp, lpns, redim)

*107* Obsolete. Replaced with the TEMPORAL SUBITERATIONS MODE {NEWTON|DUALDT} keyword option. Original description was as follows:

Flag for choice of Newton and/or second-order time algorithm; 0 to use the NPARC Alliance algorithm, 1 to use the Boeing algorithm. This test option only applies to structured grids. (bbarth, kestep, pstinp, rcimsc, spalart, sst, sst2, sst3, tdimfu, tdimja, tdimsc)

108Extrapolate freestream outflow. (This only applies to the old GMAN "freestream outflow" boundary type, which is no longer used.) (BC_bcfree, BC_bcfreebc)

    mode   Mach   Outflow Conditions
0< 1Hold upstream running characteristic at freestream
> 1Extrapolate all, even in boundary layer
1AllExtrapolate all, even in boundary layer

109Boundary flux treatment. This test option only applies to structured grids. (roewal, tdup1)

For tdup1:

    mode   Result
0Conservative
1Upwind extrapolation from interior

For roewal:

    mode   Result
0Characteristic inflow, conservation if flow parallel to wall
1Characteristic regardless
1000Use conservative wall treatment at all boundaries

110Grid area variation limiting. This test option only applies to structured grids, and may not be used with third-order fully upwind, fourth-order, or fifth-order explicit operators, specified using the RHS keyword. (roecof)

    mode   A2 / A1
0
12.0
21.5
31.33
41.1

111Singular matrix check. This test option only applies to structured grids. (jacpr4, jacpr5, jacprg, jacprg4, tdsol4, tdsol9, tdsol11, tdsolg, tdsolg4, tdsolv)

    mode   Result
0Check; if singular, arbitrarily set diagonal term to 0.1, print a warning, and continue.
1Same as mode 0, but without printing a warning.
2Don't check.

112Corrected upwind scheme at boundaries. Defaults to corrected scheme, mode > 0 uses second-order smoothing with mode / 1000 as the smoothing level. This test option only applies to structured grids. Users should not use this option. (rhsupw)

113Check for reverse flow at inflow and outflow boundaries. (BC_bcconf, BC_bcfree)

    mode   Result
0, 1Print a warning message and continue.
2Print an error message and stop.
3Set velocity to zero and continue, with no warning message. This mode only applies at outflow boundaries.
4Force a small outflow velocity on outflow boundaries to prevent reversed flow at the exit.
5Adjust the exit pressure based on exit total pressure in order to minimize inflow at outflow boundaries.

114Use central differencing in the ζ direction when the Coakley explicit operator is being used, with a central smoothing coefficient of mode / 1000. (tdup1)

115Do not rescale inviscid wall total velocity to equal adjacent value, just subtract the normal component from the adjacent value. (BC_bcvel, US_lhswall)

116Set inward pointing normal to zero in tdbcm1 at unknown grid topology points. This test option only applies to structured grids. (tdbcm1)

117 Freeze conditions at inflow boundaries, even in subsonic flow. (BC_bcfreebc, BC_tst100bc)

    mode   Result
1Freeze all inflow.
2Freeze only arbitrary inflow points.
3Freeze characteristics on all i = 1 boundaries. This mode value only applies to structured grids.

118Singular axis fix. This test option only applies to structured grids. (radavg)

    mode   Result
0Average density, momentum components, and pressure
1Average density, velocity components, and pressure

121Under-relaxation of points adjacent to singular axis. This test option only applies to structured grids. (bcpinw, bcsing, kebc, relsng, sabound, sngthrm, sstbound, vprtbound, vsctbound)

    mode   Result
0 Value on axis is a radius-weighted average of the values at the adjacent points; values at the adjacent points are unchanged
nValue on axis computed as for mode 0; values at the adjacent points are computed from

Fadj = (1 − r) Fadj + r Faxis

where Fadj is the value at the adjacent point, Faxis is the axis value, and r = n / 1000.

122Allow left-handed coordinates. (tdarea1, tdarea2)

123Track back pressure, mass flow, and integrated total pressure for outflow boundary conditions, writing the values into the .lis file. The back pressure will be in psi, and the integrated total pressure will be the ratio of the boundary value to the freestream value. When the MASS FLOW keyword is used, the mass flow value will actually be the ratio of the computed value to the desired value. For the other outflow boundary conditions the dimensional mass flow is written, in lbm/sec.

Note that when the MASS FLOW keyword is used, the back pressure and the mass flow are automatically written into the .lis file, whether this test option is used or not. Specifying TEST 123 will add the integrated total pressure.

Also note that when the MASS FLOW keyword is used, all three values may be extracted from the .lis file using the resplt (or resplt.pl) utility. For the other outflow boundary conditions, only the integrated total pressure can be extracted. (BC_IntgrtBnd, BC_pdsmfr)

124Write the accumulated time to the list output (.lis) file every iteration instead of every cycle. This test option only applies to single-zone structured grids, with a CFL number specified using the CFL# keyword mode 1 or 2, and with the trailing "ityp" input value set to 1 to indicate that a global time step should be used equal to the minimum value in the zone. (print_res)

126Compressibility correction to Baldwin-Lomax turbulence model. (blomax)

    mode   Result
0No compressibility correction; κ = 0.0168.
1Use κ = 0.0180, as in CFL3D.

127For the maximum and L2 residuals written to the list output (.lis) file with the *RES* line identifier, scale the values by the maximum value over all time steps. Note that this does not apply to the residuals written using the RESIDUAL_OUTPUT keyword. (print_res)

128Check the L2 norm of the residual for convergence instead of the maximum residual. (GRD_MeshDeform, l2norm1d)

131Reset the time step for j index values < mode equal to the time step at j = mode. I.e., (Δt)i,j,k = (Δt)i,mode,k for j < mode. This is intended for use with boundary layers on j = 1 walls, to set the time step in the boundary layer to a (larger) "outer" value. (tdtmst)

132Renormalize, changing from total to static values. The normalizing values in the .cfl file (e.g., the freestream values in the fpar array in the global header) are unchanged. (redim)

134 Order of extrapolation from interior to boundary values used at freestream, arbitrary inflow, and outflow boundaries, and at coupled boundaries using characteristic coupling. (BC_bcptcond)

    mode   Result
2 First-order.
0, 1Second-order, using a minmod limiter. This mode value only applies to structured grids.

135Reset the time step using a weighting function between the ordinary Euler CFL number and a new "viscous CFL number", for convergence acceleration in viscous layers. The viscous CFL number is set to mode / 1000. Limited testing indicates that a value of mode = 50 is stable and increases the time step near the wall by at least an order of magnitude. This test option only applies to structured grids. (tdtmst)

136Divergence checking criteria and action. Set mode = n1 + 10 n2, where n1 and n2 are defined below. (lpgrp)

    n1   Divergence Definition
1Max residual > 1.0, L2 norm increasing
2Max residual > 5.0, L2 norm increasing
3Max residual > 10.0, L2 norm increasing

and

    n2   Action Taken When Diverging
1Terminate iteration for current cycle
2Abort run
3Reduce CFL number by 1/2 and terminate iteration for current cycle

137Butt line interpolation region for USERSPEC; smear USERSPEC conditions over 0.001 × butt line at minimum and maximum butt line. (uspeci)

    mode   Result
0No interpolation
nn = 0.001 × butt line for interpolation

138Treatment options for boundary cells. This test option only applies to structured grids. (BC_bcwall, chrhsv, mphzmet, nsrhsv, tdarea, tdarea1, tdarea2, PreWallBC, US_tdbcg, vismet)

    mode   Result
≤ 1Use large cells
2 Use large cells, central difference Jacobian
3 Throw out half cell at boundaries
5 Solve ∂P/∂n equation at walls

139Turn on grid-based flux limiting for the Coakley explicit operator, using the limiting turning angle specified with the GRID LIMITER keyword. (tdup1)

140Use first-order differencing when computing the (u,v,w) / ∂ξ term in the vorticity used in the turbulence models. This test option only applies to structured grids. (sst2, sst3, vortcy)

141Use second-order differencing for normal derivatives when applying wall boundary conditions (for explicit boundary conditions only). (BC_bcvel, BC_bcwall, US_tdbcg)

    mode   Result
1Second-order ∂p/∂n, ∂T/∂n, and ∂utan/∂n
2Second-order ∂p/∂n and ∂T/∂n, but not ∂utan/∂n

142Override the abort that occurs when requesting time history with steady-state calculations. (thpstinp)

145Ensure the no-slip velocity constraint on heat exchanger actuator disc boundaries is enforced. (bqlup2)

150Singular axis on symmetry planes. When symmetry plane test fails, zero this component of velocity. This test option only applies to structured grids. (bcsing)

    mode   Result
1u = 0
2v = 0
3w = 0
4do not zero any component (use average)
5v = w = 0
6u = w = 0
7u = v = 0

151 For a singular axis, the value on the axis is a radius-weighted average of the values two points away from the axis, instead of the values at the adjacent points; values at the adjacent points are set to the average of the axis value and the value two points away from the axis. E.g., for a singular axis at j = 1, with the k direction "circumferential", the value on the axis is a radius-weighted average of the values at j = 3, instead of at j = 2. Then for each k, the value at j = 2 is set to the average of the values at j = 1 and j = 3. This test option only applies to structured grids, and overrides TEST 121. (bcpinw, bcsing, kebc, kerot, radavg, relsng, sabound, sngthrm, sstbound, vprtbound, vsctbound)

*153* Obsolete. Replaced with the MASS FLOW FREQUENCY keyword. Original description was as follows:

Iteration frequency for updating pressure at outflow boundaries. The default is 5 for all the DOWNSTREAM PRESSURE modes except VARIABLE and UNSTEADY, where the default is 1. The default is also 1 when outflow boundary conditions are specified using the MASS FLOW, DOWNSTREAM MACH, or COMPRESSOR FACE keyword. (BC_IntgrtBnd)

154When computing values at "undefined" boundary points, and no neighboring non-hole, non-fringe, points are found, average over neighboring fringe points. This test option only applies to structured grids. (bcundef, kebc, sabound, sstbound, vprtbound, vsctbound)

155For unstructured grids, extrapolate at freestream characteristic boundaries. (BC_bcfree)

157 Options for USERSPEC inflow. (uspeci)

    mode   Result
1Put USERSPEC inflow at all points in the buttline range. Do not check for above/below vehicle.
2Same as mode 1, but also ignore fuselage station check.

158Write various unstructured grid info to .lis file. (opngrd)

160Pressure correction factor = mode / 1000 for specified mass flow boundary condition. The default is a pressure correction factor of 1. (BC_pdsmfr)

162Boundary layer edge definition for the Cebeci-Smith turbulence model. (cebeci)

    mode   Result
01.0% change in Utotal between grid points
10.995 Ht
20.99 Utotal
30.9999 Utotal

163Criteria for defining Fmax in Baldwin-Lomax model.

    mode   Result
> 0Search outward from wall; use first peak in F that is followed by a fractional decrease in F of mode / 1000.
< 0Use the max F value between the wall and the | mode |'th grid point from the wall

The default is use the first peak in F that is followed by a fractional decrease of 70% (i.e., mode = 700). (blomax)

164Iteration interval for updating gas properties and species for ireal =  2 (i.e., equilibrium air chemistry). The default value is 1. (tdgas)

165Sets the tolerance for the distance between grid points used to determine a singular direction to 10mode/1000. The default is a tolerance of 10−8 (i.e., mode = −8000). This test option applies to structured grids only. (bcsing, direct)

168In a marching solution with the algebraic turbulence models, begin turbulent flow at streamwise station mode. (tdvis1)

170NASA Ames time step formula. (CFL increases as 1/(Δy)1/2 near the wall. Thus, Δt decreases as (Δy)1/2, not Δy as the default.) CA is a scalar coefficient on CFL; i.e., CFLwall is proportional to CA. This test option only applies to structured grids, and has no effect if TEST 105 mode 1, 2, or 3 is used. (tdtmst)

    mode   CA
1 0.01
n0.001n

172Turn off base energy for ireal = 3 (i.e., frozen and finite-rate chemistry). (aichem, aijkrg, aikeps, aixyzrg, BC_bcfreechar, BC_ijkfreechar, BC_test100, BC_usrffreechar, dqlim1, gas1, gas2, gas3, gas4, gas5, gasint, pstinp, redimchem, stomp, tdimfp, tdroe4, tdroe5, US_EnsightGama, US_EnsightMach, uspeci)

174For the algebraic turbulence models, update the turbulent viscosity every mode iterations. The default is 1. (tdvis1)

175Boundary conditions at freestream radial outer boundaries. (BC_bcfree, BC_bcfreechar, tdbcgs)

    mode   Result
0Compute characteristics from freestream conditions
1Compute characteristics from conditions at i = 1 along boundary
2Extrapolate without testing at k boundaries; treat i and j boundaries as in mode 1

177Freeze the maximum residual at the value for the first iteration. This test option applies to structured grids only. (lpgrp)

178For finite-rate chemistry with multi-species blowing (i.e., using BLOW SPECIES_FRACTIONS with BLOW MASS or BLOW VALVE), gradually introduce the species over the first mode iterations. (BC_bcbled)

179When solidbody rotation is specified at an arbitrary inflow boundary, modify the rotation radius to get a linear swirl profile in r with the zero velocity point not at the specified center of rotation. mode = 1000 r0, where r0 is the radius (from the point xc, yc, zc specified using the SOLIDBODY keyword in the ARBITRARY INFLOW keyword block) for zero velocity. (rotat)

180For an actuator disk with free vortex modeling (i.e., the TURNING VORTEX keyword in the ACTUATOR keyword block), set the radius of the solidbody rotation core to mode / 1000 inches. The default is to set a solidbody core radius such that the pressure at r = 0 is p / 10. (rotat1)

182For Roe zonal coupling, don't modify the boundary states at interior face points for consistency with boundary values. This test option applies to structured grids only. (tdbcgs)

185Flag used when restarting a parabolized marching solution for cases with equilibrium chemistry. (gasint)

    mode   Result
1Reset all flow field values at unknown planes, including thermodynamic properties (β, Z, heat of formation, and sound speed), equal to those at the plane upstream of first unknown plane. This should only be necessary when using the RESTART keyword and specifying a restart plane upstream of the last completed plane.
2Reset thermodynamic properties at the last computed plane to the reference conditions.

187The factor for suppression of the streamwise pressure gradient in a marching solution is set to mode / 1000. The default factor is 0.95 (i.e., mode = 950), and mode values below 800 are not recommended. When separation or strong adverse pressure gradients are causing problems, values between 800 and 900 will really help. (rhsmar, tdimfp)

188 Controls how structured-grid SA/BSL/SST turbulence model data is passed across coupled zones. If the flow passes through a zone boundary at an angle, the applied boundary values for the turbulence transport variables are usually modified using a weighted average of the adjacent value. This test option provides alternative treatments at the interface. (sabound, sstbound)

    mode   Result
0Passing of turbulence variables across the boundary is weighted by the fraction of boundary-normal velocity to the total magnitude.
1Passing of turbulence variables across the boundary is simply based on whether the flow is in/out of the domain.
2Turbulence variables on coupled boundaries remain frozen at current values.

189If a first-order upwind explicit operator modified for stretched grids is used (e.g., RHS ROE FIRST PHYSICAL), then TEST 189 1 must also be specified. (numprtinp)

190Outgoing wave Roe boundary treatment. This test option applies to structured grids only. (pstinp, roecof, roeht, tdbcgs)

    mode   Result
0, 1Use normal Roe boundary treatment (uses boundary point in formulation).
2Lower the order by one (does not use boundary point in formulation). This option cannot be used with TVD in the same zone, or with a fourth-order central or fifth-order upwind-biased explicit operator.
3Use zeroth-order extrapolation.

192Save metrics in a temporary file. After the first cycle, metrics will be read rather than computed. This eliminates the CPU resources required to re-compute the metrics each cycle, but adds significant I/O to the computation. In the past, on at least some Cray systems, this reduced the CPU time by approximately 40.8 micro-seconds / (node-cycle). On the more common platforms, however, it is generally faster to re-compute the metrics rather than store them. (lpcycl)

193Do not stop if a singular line is encountered normal to a wall. This test option applies to structured grids only. (bbdamp, blinit, kepy2)

194Bypass singular viscous metric check. This test option applies to structured grids only. (emdsolv, mphzmet, vismet)

195When using BLOW SURFACE, print a warning when the flowfield static pressure becomes larger than the plenum total pressure, causing blowing to be turned off at that point. Note that this is a five-line message written for each iteration and each "closed" node, and could cause the .lis file to become very large very quickly. (BC_bcbled)

196For overlapping grids, print an error message if there are no interior points adjacent to a fringe point. This test option applies to structured grids only. (BC_norot, srfpar, tdbcgs)

197Roe self-coupling mode. This test option applies to structured grids only. (pstinp)

    mode   Result
0Once per iteration, using bcself
1Once per cycle, using standard zone coupling

199Singular axis averaging; average from 1 to (max − 1), not 1 to max. This test option applies to structured grids only. (bcsing, linzero, radavg, relsng, sngthrm)

200Don't bomb for negative speed of sound in tdroe3A. This test option applies to structured grids only. (tdroe3A)


Last updated 30 Sep 2016