TRACE User Guide  TRACE Version 9.6.1
Online Analysis and Output Control

This page lists commands which control different kinds of output which can be written during a TRACE computation.

ComputeVolumeIntegral

Computes volume integral of the specified variables within a block group domain. The values of the volume integral will be computed in each time step (with respect to the interleave) and appended to a Tecplot-ASCII file with the current time and time step.

Usage
ComputeVolumeIntegral [options]
Long option Short option Description
--variables -v Compute volume integral for these variables
--interleave -i Interleave for output of volume integral data.
--blockGroup -b Domain of the volume integral (only one block group possible)
--name -n Name of volume integral.

Computation of volume integral is possible for following variables:

  • Conservative and primitive flow variables
  • Reynolds stresses
  • Turbulent kinetic energy
  • Mathematical entropy
  • Enstrophy
  • Vorticities
  • Unresolved Reynolds stresses, strain rates, pressure strain and total variation (for the FV solver only)

(All turbulent quantities are computed from fluctuating velocities.)

Domain
all
Example
all immediate ComputeVolumeIntegral --blockGroup Main --variables VelocityY -n integral
will compute the mean VelocityY and generate a file ../output/probe/oa_vi_integral_Main_solution_*.dat. Data will be appended each time step.
all immediate ComputeVolumeIntegral --blockGroup Main --variables TurbulentEnergyKinetic -n integral --interleave 100
will compute the turbulent kinetic energy and write/append data to the output file every 100 time steps.
Precondition
Must be called on immediate level.
Since
9.1.216

DoProbe

Setup a probe in the computational domain. The flow field is interpolated onto the probe coordinates with the appropriate accuracy order of the solver. Additional settings for the interpolation can be activated by using the command ProbeInterpolationSettings. Coordinates are specified by a Tecplot file containing one or more ordered zone(s) of points with 3D coordinates (CoordinateX, CoordinateY, CoordinateZ). If a zone contains only one coordinate point, a 0D probe is generated, otherwise the output will reflect the IJK-topology of the input data. Dimensions of length 1 will be removed (as in numpy.squeeze). The respective zone title is used as a name for the probe. The output directory has to be specified in the cgns using GMC. Data will be appended to existing files. The respective cell volume and polynomial order (DG-only) will be stored for each defined probe position.

All transported variables (RANS equations + additional transport equations) are available for 0D- and 1D probes in addition to a specific set of variables depending on the solver mode.

Variables FV DG FV HB Comment
CoordinateX, CoordinateY, CoordinateZ X X X
Density X X X
DensityAmplitude, DensityPhase X
DensityGradientX, DensityGradientY, DensityGradientZ X X
VelocityX, VelocityXGradientX, VelocityXGradientY, VelocityXGradientZ X X
VelocityY, VelocityYGradientX, VelocityYGradientY, VelocityYGradientZ X X
VelocityZ, VelocityZGradientX, VelocityZGradientY, VelocityZGradientZ X X
Pressure, PressureGradientX, PessureGradientY, PressureGradientZ X X
Temperature X X
TemperatureGradientX, TemperatureGradientY, TemperatureGradientZ X
MomentumDensityX, MomentumDensityY, MomentumDensityZ X X X
EnergyDensityStagnation X X X
EnergySpecificInternal X
Enthalpy X
ViscosityEddy X
Mach X
VorticityNorm, VorticityStreamwise X
VorticityX, VorticityY, VorticityZ X
ReynoldsStressXX, ReynoldsStressXY, ReynoldsStressXZ X Turbulence model variable
ReynoldsStressYY, ReynoldsStressYZ, ReynoldsStressZZ X Turbulence model variable
TurbulentEnergyKinetic, TurbulentDissipationRate X Turbulence model variable
TurbulentDissipationRateLog X Turbulence model variable
Gamma, ReTheta X Transition model variable

If a panelFamilyName is specified, a specific type of probe will be set up. The probe data is written for the closest face center point (FV) or face solution point (DG). Additionally, only a fixed preset of variables can be probed on panels, which depends on the panel type, i.e.

Boundary Type Variables
Solid viscous Density, Pressure, ShearStressWallX/Y/Z, MolecularViscosity
other Density, Pressure, VelocityX/Y/Z

Otherwise, the output format of panel family probes is equivalent to multi-dimensional probes.

Usage
DoProbe [options]
Long option Short option Description
--coordinateFile -cf Path to Tecplot file containing the desired probe coordinates.
--interleave -i Interleave for output of probe data.
--variables -v Space separated list of variables to be probed.
--primitives -p Add primitive variables to list (Density, VelocityX/Y/Z, Pressure).
--primitiveGradients -pg Add gradients of primitive variables to list.
--forceOutputInterleave -foi Forces the output interval of probes to be equivalent to the interleave (optional).
--panelFamilyName -pf Set a panel family as a source of the probe leading a specific type of probes, i.e. panel probes.
--writeSupplementInformationPanelProbesASCII -wsupinfo Write supplementary data to panel probes to analyse the mesh quality, i.e. cell sizes, normal vectors or the polynomial approximation order (=0 for FV). This information is always given when choosing a binary output of panel probes due to the memory-efficient format. However, in order to reduce the memory consumption of the ASCII output, this additional output is only optional.
--solutionFrequency -f Frequency of harmonic solution to be used
--solutionIBPA -ibpa IBPA of harmonic solution to be used
--useAmplitudeAndPhase -ap For complex quantities output amplitude and phase instead of real and imaginary part (currently DENSITY only)
Domain
all
Example
This is an example of a coordinate file:
TITLE = "myTitle"
VARIABLES = "CoordinateX"
"CoordinateY"
"CoordinateZ"
ZONE T="Zonetitle"
I=1, J=8, K=1, ZONETYPE=Ordered
DATAPACKING=POINT
1.0E-02 0.00011338 1.0E-02
1.0E-02 0.00022676 1.0E-02
1.0E-02 0.00057343 1.0E-02
1.0E-02 0.0009201 1.0E-02
1.0E-02 0.00182538 1.0E-02
1.0E-02 0.00273067 1.0E-02
1.0E-02 0.00436533 1.0E-02
1.0E-02 0.006 1.0E-02
Example
all immediate DoProbe --coordinateFile probes.dat -v Pressure
will generate files oa_probe_<zone_title>_solution_0.dat etc containing the coordinates and pressure. Data will be appended each time step.
all immediate DoProbe --coordinateFile probes.dat -v Pressure Density --interleave 100
will generate one file oa_probe_<zone_title>_solution_0.dat containing all points in coordinate file in one zone with pressure and density. A new zone will be appended every 100 time steps.
all immediate DoProbe --coordinateFile probes.dat --panelFamilyName row01blade
will generate one file oa_panel_<zone_title>_solution_0.dat containing all points in coordinate file in one zone probed at the panel family 'row01blade'.
Precondition
Must be called on immediate level. The writing of analysis output files must be activated via GMC.
Since
9.1.216

DoAcousticAnalysis

Setup circumferential Fourier decomposition on specified panel family for mode given by frequency and wavenumber. Calculate and output:

  • sound power, based on Morfey's formula
  • mixing entropy, based on Frey, Schlüß: Mixing losses in steady and unsteady simulations of turbomachinery flows (GT2018-75524)
  • pressure Fourier coefficients Both 0D panel values and 1D radial distributions are computed. Output will be written to online analysis file and alongside the usual panel and radial distribution output.
Usage
DoAcousticAnalysis [options]
Long option Short option Description
--panelFamily -pf Name of panel family on which the sound power is to be computed.
--frequency -f Frequency to use for the calculation of sound power.
--wavenumber -w Wavenumber to use for the calculation of sound power.
--name -n Name of probe.
--radialDistribution -rd Write 1D radial distribution online analysis output.
Domain
all
Example
all immediate DoAcousticAnalysis --panelFamily outflow --frequency 1200 --wavenumber 32 --name john
will generate files ../output/probe/oa_aa_john_solution_0.dat etc. Data will be appended each time step.
Precondition
Must be called at time level immediate.
Since
9.1.357, 9.5 (mixing entropy)

DoAutocorrelation

Setup the autocorrelation of a 0D probe. To perform this analysis a 0D probe must first be defined with the command DoProbe.

Usage
DoAutocorrelation [options]
Long option Short option Description
--source -s Name of the source probe providing the data for the analysis..
--nPoints -np Number of data samples to use in the crosscorrelation analysis.
--offset -o Offset (in terms of the number of data samples) between the two signals to be analysed.
--name -n Name of probe.
Domain
all
Example
all immediate DoAutocorrelation --source fred --nPoints 32 --offset 32 --name john
will generate files ../output/probe/oa_ac_john_solution_0.dat etc. Data will be appended each time step.
Precondition
Must be called on immediate level.
Since
9.1.357

DoFourierAnalysis

Setup the Fourier analysis of a probe. Depending on whether a harmonic list or a frequency list is specified, either a Fourier transform or an Almost Periodic Fourier Transform analysis of the raw data will be computed. To perform this analysis a 0D probe must first be defined with the command DoProbe.

Usage
DoFourierAnalysis [options]
Long option Short option Description
--source -s Name of the source probe providing the data for the analysis.
--harmonicList -hl List of harmonics.
--frequencyList -fl List of frequencies.
--nPoints -np Number of data samples to use in the temporal Fourier analysis.
--name -n Name of probe.
Domain
all
Example
all immediate DoFourierAnalysis --source fred --frequencyList 0.0 11186.5 22373 --nPoints 32 --name john
will generate files ../output/probe/oa_apft_john_solution_0.dat etc. Data will be appended each time step. A separate file is created for each harmonic (solution).
all immediate DoFourierAnalysis --source fred --harmonicList 0 1 2 --nPoints 32 --name jim
will generate files ../output/probe/oa_dft_jim_solution_0.dat etc. Data will be appended each time step. A separate file is created for each harmonic (solution).
Precondition
Must be called on immediate level.
Since
9.1.357

DoFrequencySearch

Search for the dominant frequency in a probe signal using a local optimization algorithm. A DTFT (discrete time Fourier transform) is computed for a given frequency and a damped Newton method is employed to maximize the magnitude of the corresponding Fourier coefficient. To perform this analysis a 0D probe must first be defined with the command DoProbe.

Usage
DoFrequencySearch [options]
Long option Short option Description
--source -s Name of the source probe providing the data for the analysis.
--variable -var Name of variable to be read from source.
--initialGuess -g Educated guess of expected frequency. This heavily influences the convergence of local optimization.
--nPoints -n Number of data points recorded in buffer used for calculating the Fourier transformation.
--interleave -i Interleave for recording of data points. Has to be an integer multiple of the writing interval set in gmc.
--verbose -v Be verbose.
--damping -d Damping factor for the Newton's method (default: 0.5).
--maxIter -m Maximal number of iterations for Newton's method.
--tolerance -t Termination tolerance for Newton's method.
Domain
all
Example
all immediate DoFrequencySearch --source fred --variable Pressure --initialGuess 42 --nPoints 32 --interleave 2 --verbose --damping 0.5
will generate file ../output/probe/oa_freqSearch_fred_Pressure_solution_0.dat. Data will be appended each time step.
Precondition
Must be called on immediate level.
Since
9.3. ???

ProbeInterpolationSettings

Control global settings of the probe interpolation. By default, the probes will be interpolated onto the defined coordinates. Use the sub-option --nearestSolutionPoint to deactivate the interpolation and directly probe the nearest solution point, i.e. cell center for FV and solution node for DG.

If the default interpolation is active, a kd tree is created for DG blocks to determine the nearest points to the probe coordinate on each process. Afterwards, a newton method is used to determine the real reference coordinate of each element in question. The points are treated serially in ascending order based on the distance. The element point with valid reference coordinates and the respective reference coordinates are selected. If all attempts to find the real reference coordinate of the probe via Newton method fail, the nearest point from the kd tree is used as backup.

Usage
ProbeInterpolationSettings [--nearestSolutionPoint] [--dgRefinementOrder <order>] [--nInitialPointsForNewtonMethod <number>]
Parameters
nearestSolutionPoint[nsp]Directly probe the nearest solution point.
dgRefinementOrder[p](DG only) Create a refined mesh of possible probe positions, in which every element has a number of nodes, which are uniformly distributed across elements, equivalent to the defined refinement order. (default is the Ansatz order)
nInitialPointsForNewtonMethod[n](DG only) Number of nearest points to be used as initial points in the newton method. (default 8)
Domain
all
Example
all immediate ProbeInterpolationSettings --dgRefinementOrder 10 --nInitialPointsForNewtonMethod 8
Since
9.4.0

ProbeOutputFormat

Set the output format for all configured probes (in GMC or via DoProbe). Choices are:

Keyword Format
HDF5 HDF5
ASCII Tecplot ASCII
Usage
ProbeOutputFormat <HDF5|ASCII>
Domain
all
Example
all immediate ProbeOutputFormat HDF5
This sets output format to HDF5.
Precondition
Must be called on immediate level.
Since
9.4.0

ComputeStatistics

Set up statistics computation. Statistics are computed as running averages. Output is synchronous with the 3D CGNS output. For a restart on already accumulated statistics, an existing file must be specified. This will be overwritten by the updated statistics.

A list of available statistics can be found in Statistics.

The statistics file only contain raw accumulated averages such as \(\overline{\rho u u}\), etc. The actual computation of the statistical moments is performed by POST tasks such as --computeStatisticalValues. Use POST to compute the statistical moments such as \(\overline \rho\), \(\overline u\) or \(\overline{u'u'}\) after performing a spatial average.

For the first and second moment, the additional options --reynoldsAverage and --favreAverage are available. Without specification, the average type is consistent to the appearance in the RANS equations, e.g. Favre average for velocity dependent variables and Reynolds average for others, e.g. density and pressure. Specification of option --reynoldsAverage will use Reynolds average for all variables while additional specification of option --favreAverage will compute both, Reynolds and Favre averages.

Usage
ComputeStatistics [options]
Long option Short option Description
--filename -f CGNS file for statistics output.
--timestep -t Start time step for computation of statistics.
--restart -r Restart from existing statistics output. Sampling frequency, number of samples and current timestep in statistics file must match current simulation settings.
--moment -m Choose between 1 (first moments), 2 (first and second moments), 3 (skewness) and 4 (flatness).
--reynoldsAverage -ra Use Reynolds average for all variables.
--favreAverage -fa Compute additionally Favre average for velocity dependent variables.
--subgrid -sgs Compute sub-grid stresses.
--hrlQuantities -hrl Compute hybrid RANS/LES related quantities (shielding function \(f_d\), blending function).
--averageEddyViscosity -aev Average the (SGS) eddy viscosity
--gamma -g Average the transition factor gamma
--budgets -b Compute Reynolds stress budget terms.
--storePermanentInterleave -spi Absolute time step interleave at which permanent copies of statistics are stored.
--samplingInterleave -si Only sample statistics at specified time step interleave (sample every time step by default).
Domain
all
Example
all immediate ComputeStatistics --filename ../output/cgns/TRACE.statistics.cgns --moment 2
will compute first and second moment statistics from the very beginning of the computation.
all immediate ComputeStatistics --filename ../output/cgns/TRACE.statistics.cgns --moment 1 --timestep 1000
will compute first moment statistics from time step 1000 onwards.
all immediate ComputeStatistics --filename ../output/cgns/TRACE.statistics.cgns --moment 2 --restart
will continue to compute statistics already accumulated in specified file.
Precondition
Must be called on immediate level to allow for allocation of buffers.
Warning
Existing statistics output files will be overwritten without warning (other than this one).
Note
If permanently stored statistics coincides with 3D output, only the permanent version is written.
Since
9.0.141

ChgAnPanelInterpolation

Change interpolation order for analysis panels. Default is second order.

Usage
ChgAnPanelInterpolation <1stOrder | 2ndOrder>
Domain
all, component, stage, group, blockGroup, block
Example
all immediate ChgAnPanelInterpolation 1stOrder
will change the interpolation order to first order.

StartWriteBlockResidual

Start to write out block residual files in ASCII Tecplot format.

Usage
StartWriteBlockResidual
Domain
all
Example
all iteration 50 StartWriteBlockResidual
Since
7.3

StopWriteBlockResidual

Stop monitoring of block residual data.

Usage
StopWriteBlockResidual
Domain
all
Example
all iteration 500 StopWriteBlockResidual
Since
7.3

WriteRadialDistribution

Writes the radial distribution files for all panels consisting of bands in TECPLOT-.dat format (ASCII). If an analysis panel contains bands, the radial distribution for the analysis panel is also written out.

Usage
WriteRadialDistribution <interleave> <prefix>
Parameters
interleaveNumber of time steps between two outputs.
prefixPath and file name prefix of the radial distribution files.
Domain
all
Example
all immediate WriteRadialDistribution 5 ../output/bd_radial
Since
7.3

StartProbe

Start single or multi-point probe. Flow quantities of specified cells are written to Tecplot ASCII file.

Usage
StartProbe <zone> <j> <k> <l> <outputfile> <interleave>
StartProbe <zone> <jStart> <jEnd> <kStart> <kEnd> <lStart> <lEnd> <outputfile> <interleave>
Parameters
zoneZone name or zone index (CGNS notation).
jj index of inner cell (CGNS notation).
kk index of inner cell (CGNS notation).
ll index of inner cell (CGNS notation).
jStartStart of j index range of inner cells (CGNS notation).
jEndEnd of j index range of inner cells (CGNS notation).
kStartStart of k index range of inner cells (CGNS notation).
kEndEnd of k index range of inner cells (CGNS notation).
lStartStart of l index range of inner cells (CGNS notation).
lEndEnd of l index range of inner cells (CGNS notation).
outputfilePath to file for probe data.
interleaveNumber of time steps between to outputs.
Domain
all, component, stage, group, blockGroup, block
Example
all immediate StartProbe zonename 10 10 10 probeout.dat 5
all immediate StartProbe zonename 10 20 20 20 2 2 probeout.dat 5
Precondition
Command must be called on immediate level.
Note
Can also be used for unstructured meshes. In this case k and l indices need to be specified but are ignored.
Index range is only supported for structured meshes.
Warning
The zone name must not contain the character '#'. This is used for comments in the control file and the command will be truncated. In these cases the zone index (CGNS notation) can be used instead.
Since
7.3

WriteCellResidual

Writes the residual of each cell for main flow and other transport variables to CGNS.

Usage
WriteCellResidual
Domain
all, component, stage, group, blockGroup, block
Example
all immediate WriteCellResidual
Precondition
Must be called on immediate level.
Since
7.3

WriteBandIndex

Start to write band ID of entry, exits and interfaces to 2D CGNS output.

Usage
WriteBandIndex
Domain
all, component, stage, group, blockGroup, block
Example
all immediate WriteBandIndex
Precondition
Must be called on immediate level.
Since
9.2

SetMessageMode

Changes the message mode for the given block(s).

Usage
SetMessageMode <mode>
Parameters
modeON or OFF
Domain
all, component, stage, group, blockGroup, block
Example
block 0 immediate SetMessageMode On
block 0 timestep 10 SetMessageMode Off
Since
7.3

ActivateCatalyst

Activate in co-processing by ParaView Catalyst. TRACE by default provides the complete simulation domain as a multi block data set for each block group and for each boundary panel group. Specific block or boundary panel groups can be selected using the options --blockGroupWhiteList and --panelGroupWhiteList. The following variables are available:

Variable Entities Default
Density All yes
Pressure All yes
Velocity (vector) Volumes, Panels except viscous walls yes
ShearStressWall (vector) Viscous walls yes
ViscosityMolecular Viscous walls no
Lambda2 Volumes no
VorticityStreamwise Volumes no
DensityGradientMagnitude Volumes no
DGFVHybridBlendingWeight Volumes (DG with shock capturing) no

For translational moving block and panel groups, the coordinates and variables are transformed by default into the absolute system. Use option --relativeFrame to turn the transformation off. Finite-Volume based solution will be provided on vertices for the volume data and on face centers for panels. Discontinuous-Galerkin based solutions will be interpolated to uniform nodes according to the polynomial order of each element. Using option --polynomialOrder allows a specification of an arbitrary polynomial order of the output. Option will be ignored for Finite-Volume solutions.

For more details on how to set up the script for Catalyst see Co-processing with ParaView Catalyst.

Usage
ActivateCatalyst --script <script> [--polynomialOrder <polynomialOrder>] [--relativeFrame] [--nativeHighOrder] [--blockGroupWhiteList <name> [<name> ...]] [--panelGroupWhiteList <name> [<name> ...]] [--additionalVariables <name> [<name> ...]]
Parameters
scriptPath to Python script for Catalyst.
polynomialOrderPolynomial representation of the visualization. (Ignored for FV)
relativeFrameOutput coordinates and variables are given in the relative frame.
nativeHighOrderEnables the output of vtk' Lagrange type elements for DG solutions.
blockGroupWhiteListList of block group names provided to Catalyst (use any non-existing name such as 'None' to deactivate block group output).
panelGroupWhiteListList of panel group names provided to Catalyst (use any non-existing name such as 'None' to deactivate panel group output).
additionalVariablesList of variables in addition to the primitives to be provided to Catalyst.
outputIntervalNumber of time steps between two calls of the Catalyst API. Use if update frequency cannot be specified in Catalyst script.
Domain
all
Example
all immediate ActivateCatalyst --script live.py
all immediate ActivateCatalyst --script volume_and_blade.py --additionalVariables DensityGradientMagnitude DGFVHybridBlendingWeight
all immediate ActivateCatalyst --script volume_and_blade.py --blockGroupWhiteList row01 --panelGroupWhiteList row01BladeWall
all immediate ActivateCatalyst --script volume_only.py --panelGroupWhiteList None
The latter can be used to disable panel group output. Note that the scripts would also work without the white lists. They only save some computational effort in preparing unused data for Catalyst.
Precondition
Build TRACE with Catalyst libraries.
Warning
Use --outputInterval with care since an interval inconsistent with the update/output frequency in Catalyst script can lead to data not being written.
Since
9.2.002