PyPost (post)

PyPost

PyPost offers structs and prototypes from POST for the usage in python. Cython is used to create a library which can be imported in a python script.

Usage

You have to add the pytracesuite folder to your PYTHONPATH. Then you are able to import the POST module and to create your own task chain. With this you can create a powerful post-processing chain using the POST tasks in combination with python features, e.g. file handling, numpy arrays and matplotlib.

Example usage in a python script:

from tracesuite.post import POST

post = POST()

ds = post.input("TRACE.cgns")
ds = post.interpolateCellCenteredToVertexData(ds)
post.output(ds, filename = "POST.plt")

Modules

class tracesuite.post.postTasks.POST(showPostVersionOnScreen=True)[source]
ExtendedTurbomachineryAnalysis_0D1D(dataSet, cda=None, domainDefinition=None, tecplotASCII='../output/POST', ulist='../output/POST/GTA.ulst', exitStagnationPressure=None, bidx=None)[source]

0D and 1D global turbomachine analysis including expert variables.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • cda (bool) – flag to compute derived averages (suboption for btm-task)

  • domainDefinition (str) – global domain definition (suboption for btm-task)

  • tecplotASCII (str) – Write in Tecplot ASCII format to specified directory (suboption for wgta-task).

  • ulist (str) – Write in ULIST format to specified file (suboption for wgta-task).

  • exitStagnationPressure (float) – Additional exit stagnation pressure

  • bidx (bool) – Process domain bands by index of inlet and outlet.

TurbomachineryAnalysis_0D1D(dataSet, cda=None, domainDefinition=None, tecplotASCII='../output/POST', ulist='../output/POST/GTA.ulst', MTU=None, onlyMain=None, bidx=None)[source]

Glora performs the 0D and 1D global turbomachine analysis.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • cda (bool) – Flag to compute derived averages (suboption for btm-task).

  • domainDefinition (str) – Global domain definition (suboption for btm-task).

  • tecplotASCII (str) – Write in Tecplot ASCII format to specified directory (suboption for wgta-task).

  • ulist (str) – Write in ULIST format to specified file (suboption for wgta-task).

  • MTU (bool) – Flag to write the values in MTU specific dimensions (suboption for wgta-task).

  • onlyMain (bool) – Flag to build turbomachine only based on main inlets and outlets.

  • bidx (bool) – Process domain bands by index of inlet and outlet.

UnstructToStruct(dataSet)[source]

Transforms an unstructured mesh into structured mesh using ‘StructuredIndices’.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

addControlDomain(dataSet, name, mainInlet, mainOutlet, leaks=None, domainDefinition='user_defined')[source]

Add a control domain to the turbomachine.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • name (str) – name of the control domain

  • mainInlet (str) – main inlet panel group

  • mainOutlet (str) – main outlet panel group

Optional Parameters

Parameters
  • leaks (list[str]) – list of leakage panel group

  • domainDefinition (str) – domain definition

addFlowFields(dataSet)[source]

Calculate the sum of two data sets.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet or list[PyPostDataSet]) – a dataSet or a list of two dataSets

Return Value

Returns

dataSet

Return type

PyPostDataSet

addMeshDeformation(dataSet, md=None, phase=0.0, amp=1.0, rmd=None, fsi=None)[source]

Perturb mesh by a (possibly complex) mesh deformation.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • md (str) – Name of mesh deformation (eigenmode).

  • phase (float) – Phase shift.

  • amp (float) – Scaling factor for deformation amplitude.

  • rmd (bool) – Perturbs mesh by (real) modal displacements coming from a coupled simulation.

  • fsi (bool) – Perturbs mesh by (real) displacements coming from a fully coupled simulation.

addXiEtaToBandIntegrals(dataSet)[source]

Add Xi and Eta to all available band integral values using the S2Mblock.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

aeAnalysis(dataSet)[source]

Computes aerodynamic work, damping, stiffness, etc. for all eigenmodes.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

applyReynoldsStressRealizability(dataSet)[source]

Apply realizability constraints to Reynolds stresses.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

assembleRadialDistributions(dataSet)[source]

Assembly of radial distributions on intersection families from block integral values of cuts.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

averagedGridSize(dataSet)[source]

Calculates the representative grid size according to ASME Standard.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

averaging(dataSet, signed=None, splitAvg=None, order=2, deadStatePressure=None)[source]

This task performs circumferential area-/mass-/flux-averaging for boundary/analysis/interface-panels.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • signed (bool) – Specifies if weighting factor is the signed massflow. Otherwise it’s the magnitude of the massflow. (avgm-task option)

  • splitAvg (bool) – Three types of averaging are performed. Standard averaging for all bands and panels and additionally just for ingoing/outgoing massflow on panels. (avga/avgm/avgf-task option)

  • order (int) – Choose interpolation order. 1st or 2nd order (default).

  • deadStatePressure (float) – Dead state pressure (for flow mechanical work potential)

averagingByArea(dataSet, splitAvg=None, preserveFields=None, deadStatePressure=None)[source]

Performs an area averaging for bands and panels.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • splitAvg (bool) – Three types of averaging are performed. Standard area averaging for all bands and panels and additionally an area averaging just for ingoing/outgoing massflow on panels

  • preserveFields (bool) – Keep existing fields from being overwritten

  • deadStatePressure (float) – Dead state pressure (for flow mechanical work potential)

averagingByFlux(dataSet, splitAvg=None)[source]

Performs a flux averaging for bands and panels.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

splitAvg (bool) – Three types of averaging are performed. Standard flux averaging for all bands and panels and additionally a flux averaging just for ingoing/outgoing massflow on panels

averagingByMassFlow(dataSet, signed=None, splitAvg=None, workAvg=None, workAvgSimple=None, deadStatePressure=None, preserveFields=None)[source]

Performs a mass averaging for bands and panels.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • signed (bool) – Specifies if weighting factor is the signed massflow. Otherwise it’s the magnitude of the massflow.

  • splitAvg (bool) – Three types of averaging are performed. Standard mass averaging for all bands and panels and additionally a mass averaging just for ingoing/outgoing massflow on panels

  • workAvg (bool) – Replace mass weighted sum of total pressure by an expression consistent with total enthalpy conservation, other variables keep mass weighted

  • workAvgSimple (bool) – Simplified version of work average

  • deadStatePressure (float) – Dead state pressure (for flow mechanical work potential)

  • preserveFields (bool) – Keep existing fields from being overwritten

averagingInversion(dataSet)[source]

Retrieves integral physical quantities. Call after the other averaging routines.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

averagingUnsteady(dataSet, accumulatorDataSet, nPics, signed=None, splitAvg=None, order=2, deadStatePressure=None)[source]

This task performs circumferential area-/mass-/flux-averaging for boundary/analysis/interface-panels with proper time averaging.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • accumulatorDataSet (PyPostDataSet or None) – accumulationDataSet for dataSet for task, None for first iteration

  • nPics (int) – number of iterations for this task

Optional Parameters

Parameters
  • signed (bool) – Specifies if weighting factor is the signed massflow. Otherwise it’s the magnitude of the massflow. (avgm-task option)

  • splitAvg (bool) – Three types of averaging are performed. Standard averaging for all bands and panels and additionally just for ingoing/outgoing massflow on panels. (avga/avgm/avgf-task option)

  • order (int) – Choose interpolation order. 1st or 2nd order (default).

  • deadStatePressure (float) – Dead state pressure (for flow mechanical work potential)

Return Value

Returns

updated accumulationDataSet for task. Should be passed in next iteration.

Return type

PyPostDataSet

bladePressureDistribution(dataSet, avgType='flux')[source]

Calculate cp and Mach isentropic.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

avgType (str) – Specify averaging type: flux, mass or area.

bladePressureDistributionSolid2d(dataSet, avgType='flux')[source]

Calculate cp and Mach isentropic on solid panels.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

avgType (str) – Specify averaging type: flux, mass or area.

blendingFunctionsMenter(dataSet, cmu=0.09, sigma=0.856, llcd=1e-20, F1mod=None)[source]

Compute Menter’s blending functions F1, F2, as well as the single arguments.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • cmu (float) – Value for model constant C_mu (default 0.09).

  • sigma (float) – Value for model constant sigma_w2 (default 0.856).

  • llcd (float) – Value for model constant lower limit cross diffusion (default 1.0E-20).

  • F1mod (bool) – Apply F1 modification like for Gamma and Gamma-Re-Theta model.

buildCartesianS2M(dataSet, deep=2, autodeep=None, nAxial=500, nRadial=500, x_min=None, x_max=None, r_min=None, r_max=None)[source]

Performs a S2M-averaging by a recursive Tetrahedron decomposition and projection to a 2D Raster grid (RTP).

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • deep (int) – deep: recursive refinement steps

  • autodeep (bool) – Flag to use adaptive deep refinement (defined deep factor is ignored!).

  • nAxial (int) – Mesh Size Axial

  • nRadial (int) – Mesh Size Radial

  • x_min (float) – Mesh X min

  • x_max (float) – Mesh X max

  • r_min (float) – Mesh R min

  • r_max (float) – Mesh R max

buildTurbomachine(dataSet, cda=None, domainDefinition=None, onlyMain=None)[source]

Create turbomachinery configuration for global turbomachinery analysis.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • cda (bool) – flag to compute derived averages

  • domainDefinition (str) – global domain definition

  • onlyMain (bool) – flag to build turbomachine only based on main inlets and outlets

calcAnisotropyInvariants(dataSet)[source]

Calculates the second, third and combined invariants of the Reynolds stress anisotropy tensor.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcAnisotropyTensor(dataSet)[source]

Calculates the Reynolds stress anisotropy tensor.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcAnisotropyTensorBarycentricWeights(dataSet, offset=0.0, exponent=1.0, uq=None)[source]

Calculates the Eigenvalues of Reynolds stress anisotropy tensor and derived from that coordinates in barycentric map as well as weights for RGB coloring.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • offset (float) – Offset for barycentric weight

  • exponent (float) – Exponent for barycentric weight

  • uq (bool) – Rotate barycentric triangle corresponding to Reynolds stress uncertainty quantification perturbation

calcBandExtrema(dataSet)[source]

Calculate maximal and minimal values of all variables along bands (absolute value for complex variables).

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcCartesianVelocityComponents(dataSet)[source]

Calculates the Cartesian components of the velocity vector in relative frame of reference (radial, circumferential).

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcCascadeLoss(dataSet, height=0.5)[source]

Add CoefPressureStagDiffDynTh to panel integral values.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

height (float) – The channel height at which the reference values are read.

calcCellEdgeLengths(dataSet)[source]

Computation of respective cell edge lengths.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcCircFourierDecomp(dataSet, pf=None)[source]

Performs circumferential Fourier decomposition at given plane (panel family or analysis plane).

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

pf (list[str]) – List of panel families on which the circumferential Fourier decomposition is computed.

calcCircMixingEntropy(dataSet, mt=None)[source]

Compute circumferential mixing entropy.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

mt (list[str]) – List of wave mode types which are taken into account: Entropy, VorticityRadial, VorticityCircumferential, AcousticDownstream, AcousticUpstream

calcCoefFriction(dataSet)[source]

Computation of skin friction coefficient.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcCoefFrictionSolid2D(dataSet, eta=None)[source]

Computation of skin friction coefficient on solid panels.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

eta (bool) – use CoordinateEta

calcCoefPressure(dataSet)[source]

Computation of pressure coefficient.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcCoefPressureSolid2D(dataSet, eta=None)[source]

Computation of pressure coefficient on solid panels.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

eta (bool) – use CoordinateEta

calcConservativeVariables(dataSet)[source]

Calculates conservative variables as preparation for averaging routines. The task is generalized for arbitrary dimensions and arbitrary grid locations.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcCylindricalCoordinates(dataSet)[source]

Computes cylindrical coordinates (i.e. ‘CoordinateR’ and ‘CoordinateTheta’) at current grid location and stores them alongside with the other field variables.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcCylindricalVelocityComponents(dataSet)[source]

Calculates the cylindrical components of the velocity vector in relative frame of reference (radial, circumferential) and the meridional velocity magnitude.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcCylindricalVelocityComponentsAbs(dataSet)[source]

Calculates the cylindrical components of the velocity vector in absolute frame of reference (radial, circumferential) and the meridional velocity magnitude.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcDeterministicStresses(dataSet)[source]

Computes the deterministic stresses.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet or list[PyPostDataSet]) – a dataSet or a list of two dataSets

Return Value

Returns

dataSet

Return type

PyPostDataSet

calcDissipationK(dataSet)[source]

Calculates the dissipation of turbulent kinetic energy.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcEntropyPost(dataSet)[source]

Computation of entropy.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcFaceArea(dataSet)[source]

Calculates the area for each face.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcFaceMassFlow(dataSet)[source]

Calculates the mass flow (in the relative system) for each face.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcForceAndTorque(dataSet)[source]

Compute force and torque (x-component only) at solid walls.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcJacobian(dataSet)[source]

Calculate Jacobians and some cell normal vector components and store them in the flow solution.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcKatoLaunderProductionK(dataSet)[source]

Calculates the production of turbulent kinetic energy according to Kato-Launder modification.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcLambda2(dataSet, gradVar=['VelocityX', 'VelocityY', 'VelocityZ'])[source]

Calculates lambda2 for the visualization of vortex structures.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

gradVar (list[str]) – Specify needed gradients. By default, velocity gradient tensor is computed.

calcLoadBalance(dataSet, nprocs, output=None, splitBlocks=None, transposeBlocks=None, splitJournal=None, mergeJournal=None, implicitWeight=None, RungeKuttaMethod=None, unstructuredWeight=None, minimumEfficiency=None)[source]

Create a load balance file.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • nprocs (int) – Number of processors.

Optional Parameters

Parameters
  • output (str) – Name of the load balance file to be created (Default: ‘BALANCE_<nprocs>PROC.post’).

  • splitBlocks (bool) – Create split and merge files.

  • transposeBlocks (bool) – Transpose blocks in split and merge files for SIMD friendliness.

  • splitJournal (str) – Name of the GMC split journal to be created (Default: ‘split.jou.post’).

  • mergeJournal (str) – Name of the GMC merge journal to be created (Default: ‘merge.jou.post’).

  • implicitWeight (float) – Factor to weight implicit blocks relative to explicit blocks.

  • RungeKuttaMethod (str) – Name of the IMEX Runge-Kutta method (determines the max. stable CFL number).

  • unstructuredWeight (float) – Factor to weight unstructured blocks relative to structured blocks (Default 1.3)

  • minimumEfficiency (float) – Minimum load balance efficiency in percent (Default 97)

calcMach(dataSet)[source]

Computation of Mach number in the relative frame of reference.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcMachAbs(dataSet)[source]

Computation of Mach number in the absolute system.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcMachIsentropic(dataSet)[source]

Computation of isentropic Mach number.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcMachIsentropicSolid2D(dataSet, eta=None)[source]

Computation of isentropic Mach number on solid panels.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

eta (bool) – use CoordinateEta

calcMachMeridional(dataSet)[source]

Computation of meridional Mach number.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcMaximumEdgeLength(dataSet)[source]

Computation of maximum edge length direction for each cell.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcMolecularViscosity(dataSet)[source]

Compute molecular viscosity using the Sutherland law.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcNorm(dataSet, f)[source]

Calculates the norms (L1, L2, Lmax) of current data set.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • f (str) – Specify output file.

calcOffsetCurvesCriteria(dataSet)[source]

Calculate criteria based on a curve and it’s “offset”-curve twin.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcPerturbedAnisotropyTensor(dataSet)[source]

Calculates the perturbed Reynolds stress anisotropy tensor.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcPopeCriterion(dataSet, cd=0.09)[source]

Computation of Pope-Criterion.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

cd (float) – Value for model constant C_d (default 0.09).

calcPressureNormalized(dataSet)[source]

Computation of normalized pressure.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcPressureNormalizedSolid2D(dataSet, eta=None)[source]

Computation of normalized pressure on solid panels.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

eta (bool) – use CoordinateEta

calcPressureStagnation(dataSet)[source]

Computation of stagnation pressure.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcPressureStagnationAbs(dataSet)[source]

Computation of stagnation pressure in the absolute system.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcPrimitiveVariables(dataSet)[source]

Calculates primitive variables. The task is generalized for arbitrary dimensions and arbitrary grid locations.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcPrimitiveVarsCylind(dataSet)[source]

Calculates primitive variables in the cylindrical coordinate system based on conservative variables in the cylindrical coordinate system.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcProductionK(dataSet)[source]

Calculates the production of turbulent kinetic energy.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcRelToAbs(dataSet)[source]

Transform relative quantities to absolute frame of reference.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcReynoldsNumber(dataSet, refLength=None, refLengthEdge=None)[source]

Computation of Reynolds number on every cell from flow data.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • refLength (float) – Reference length.

  • refLengthEdge (bool) – Use maximal edge length as local reference length.

calcReynoldsStresses(dataSet)[source]

Calculates the Reynolds stresses. Input velocity should be fluctuations!

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcReynoldsStressesBoussinesq(dataSet, gradVar=['VelocityX', 'VelocityY', 'VelocityZ'])[source]

Calculates the Reynolds stresses as given by Boussinesq assumption.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

gradVar (list[str]) – Specify needed gradients. By default, velocity gradient tensor is computed.

calcReynoldsStressesEARSM(dataSet, gradVar=['VelocityX', 'VelocityY', 'VelocityZ'])[source]

Calculates the Reynolds stresses as given by Boussinesq assumption and extra anisotropy by EARSM.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

gradVar (list[str]) – Specify needed gradients. By default, velocity gradient tensor is computed.

calcReynoldsStressesIsotropic(dataSet)[source]

Calculates the Reynolds stresses as isotropic.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcScaledJacobians(dataSet, order=None, nodeset=None)[source]

Computation of scaled Jacobians for high-order DG grids.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • order (int) – Desired order of lagrange polynomials to investigate.

  • nodeset (str) – Desired node set to investigate. (Uniform, Legendre-Gauss, Legendre-Gauss-Lobatto)

calcSchlieren(dataSet, gradVar=['Density'], magnitude=True)[source]

Calculate Schlieren (density gradient)

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • gradVar (list[str]) – Specify needed gradients. By default, density gradient is computed.

  • magnitude (bool) – Magnitude of all gradients is computed

calcSoundPower(dataSet)[source]

Compute sound power from circumferential mode decomposition.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcSpecificImpedance(dataSet)[source]

Computes the specific impedance on solid walls.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcSpeedOfSound(dataSet)[source]

Computation of local speed of sound from flow data.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcStatisticsConvectionReynoldsStresses(dataSet)[source]

Computation of mean convection of reynolds stresses.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcStatisticsMassFlux(dataSet)[source]

Computation of statistical moments from average values.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcStatisticsMolecularDiffusion(dataSet)[source]

Computation of molecular diffusion.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcStatisticsPressureStrain(dataSet)[source]

Computation of turbulent pressure strain from average values.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcStatisticsSecondMoments(dataSet)[source]

Computation of second moments from statistical values, e.g. Reynolds stresses.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcStatisticsSkewnessAndFlatness(dataSet)[source]

Computation of skewness and flatness.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcStatisticsTKEbudgetTerms(dataSet)[source]

Computation of scalar budget terms based on statistic budget terms of Reynolds stresses transport equation

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcStatisticsTurbulentDiffusion(dataSet)[source]

Computation of turbulent diffusion.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcStatisticsTurbulentDissipationRate(dataSet)[source]

Computation of turbulent dissipation rate

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcStatisticsTurbulentDissipationRateBasedOnBudget(dataSet)[source]

Computation of turbulent dissipation rate based on budget of Reynolds stresses

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcStatisticsTurbulentProduction(dataSet)[source]

Computation of turbulent production from average values.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcStatisticsVelocityFavreAveraged(dataSet)[source]

Computation of Favre-averaged velocity.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcStatisticsVelocityGradientsFavreAveraged(dataSet)[source]

Computation of statistical moments from average values.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcStrainRateTensor(dataSet, gradVar=['VelocityX', 'VelocityY', 'VelocityZ'])[source]

Calculates the strain rate in Cartesian coordinates.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

gradVar (list[str]) – Specify needed gradients. By default, velocity gradient tensor is computed.

calcStreamwiseVorticity(dataSet)[source]

This task calculates the streamwise vorticity vector.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcSubgridLengthScale(dataSet, hybridApproach, subgridApproach='GridBased')[source]

Computation of subgrid length scale for scale-resolving simulations. Original grid-based length scale is computed by default..

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • hybridApproach (str) – Applied hybrid approach. [DES, DDES or IDDES]

Optional Parameters

Parameters

subgridApproach (str) – Applied subgrid length scale approach. [Default = GridBased, Chauvet, Probst, Mockett, Shur]

calcTemperature(dataSet)[source]

Computation of static temperature.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcTemperatureRothalpy(dataSet)[source]

Computation of rothalpy temperature.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcTemperatureStagnation(dataSet)[source]

Computation of stagnation temperature.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcTemperatureStagnationAbs(dataSet)[source]

Computation of stagnation temperature in the absolute system of reference.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcTemperatureStagnationRot(dataSet)[source]

Computation of stagnation temperature in rotating frame.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcThermodynamicProperties(dataSet)[source]

Computation of thermodynamic properties: ratio of specific heats etc.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcTurbomachineryFieldVariables(dataSet)[source]

Computes field variables commonly required for the analysis of turbomachinary.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcTurbulenceIntensity(dataSet, sgs=None)[source]

Calculates the turbulence intensity.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

sgs (bool) – Compute sub-grid and total turbulence intensity in addition to resolved turbulent kinetic energy (for statistics CGNS).

calcTurbulentHeatFluxEAHF(dataSet)[source]

Calculates turbulent heat fluxes based on different turbulent energy diffusion models.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcTurbulentKineticEnergy(dataSet, sgs=None)[source]

Calculates the turbulent kinetic energy from normal Reynolds stresses.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

sgs (bool) – Compute sub-grid and total turbulent kinetic energy in addition to resolved turbulent kinetic energy (for statistics CGNS).

calcTurbulentLengthScale(dataSet)[source]

Calculates the turbulent length scale.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcVelocityAngleAlphaZEpsilon(dataSet)[source]

Computes VelocityAngleAlpha(Abs), VelocityAngleAlphaZ(Abs), VelocityAngleEpsilon

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcVelocityAngles(dataSet)[source]

Computes VelocityAngleR and VelocityAngleTheta

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcVelocityAnglesAbs(dataSet)[source]

Computes VelocityAngleThetaAbs.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcVelocityAnglesAbsTranslational(dataSet)[source]

Computes VelocityAngleYAbs and VelocityAngleZAbs.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcVelocityAnglesTranslational(dataSet)[source]

Computes VelocityAngleY and VelocityAngleZ

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcVelocityMagnitudeAbs(dataSet)[source]

Calculates the magnitude of velocity in absolute system.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcVelocityNorm(dataSet)[source]

Calculates the (Euclidean) norm of velocity vector given by (velocityX,velocityY,velocityZ).

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

calcVorticityVector(dataSet, gradVar=['VelocityX', 'VelocityY', 'VelocityZ'])[source]

This task calculates the 3D vorticity vector in cartesian coordinates and its norm.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

gradVar (list[str]) – Specify needed gradients. By default, velocity gradient tensor is computed.

computeAeroMisc(dataSet, f=None, ibpa=None, em=None)[source]

Computes miscellaneous aerodynamic quantities.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • f (float) – Frequency for which the modal work per cycle was computed. Necessary if there are several aerowork solutions.

  • ibpa (float) – IBPA for which the modal work per cycle was computed. Necessary if there are several aerowork solutions. Notice: ibpa(aerowork) = ibpa(harmonic flow solution) - ibpa(eigenmode)

  • em (str) – Eigenmode for which the modal work per cycle is computed. Necessary if there are several aerowork solutions.

computeAerowork(dataSet, r=None, f=None, mff=None)[source]

Computes aerodynamic work per area for all eigenmodes.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • r (bool) – Read aerowork at faces from cgns file and do not computed it.

  • f (float) – Frequency for which the modal work per cycle is computed. Necessary if there are several harmonics.

  • mff (bool) – Filter modal forces. If used then only modal force harmonics with analysis frequency and zero interblade phase angle will be computed (harmonic solution and displacement must have the same ibpa).

computeAverageS1(dataSet, var=None, suf=None)[source]

Compute average on 1D block or families and store on integral values.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • var (list[str]) – Compute average for specified variables (real and imaginary). Omit to get all variables.

  • suf (bool) – Sum up whole intersection families.

computeMachMax(dataSet)[source]

Compute maximal mach number on 1D block and store on integral values.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

computeStatisticalValues(dataSet, gradVar=['Density', 'Pressure', 'MomentumDensityX', 'MomentumDensityY', 'MomentumDensityZ', 'ViscousStressXX', 'ViscousStressXY', 'ViscousStressXZ', 'ViscousStressYY', 'ViscousStressYZ', 'ViscousStressZZ'])[source]

Compute statistical values (moments) from average fields.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

gradVar (list[str]) – Specify needed gradients. By default, velocity gradient tensor is computed.

convertLogWToOmega(dataSet)[source]

Conversion of turbulent dissipation rate omega from log(omega).

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

convertOmegaToLogW(dataSet)[source]

Conversion of logarithmic turbulent dissipation rate log(omega) from omega.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

createBandedInterfaces(dataSet, ignoreAnalysisLines=None, ignoreBoundaryPanels=None, name=None, zonal=None, ascendingEta=None)[source]

Create bands for all or specified interfaces.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • ignoreAnalysisLines (bool) – ignore families of analysis lines

  • ignoreBoundaryPanels (bool) – ignore families of boundary panels

  • name (list[str]) – list of family names

  • zonal (bool) – create bands for zonal interfaces connecting rows or ducts too

  • ascendingEta (bool) – ensure that band-order is eta-ascending (requires a S2m grid, see –readS2m).

createInterpolatedBoundaryLayerCuts(dataSet, raySize, rayLength, order=2, tetra=None)[source]

Generate rays on all viscous walls and interpolate the 3D solution onto the rays.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • raySize (int) – Number of points on the ray.

  • rayLength (float) – Length of the ray in m.

Optional Parameters

Parameters
  • order (int) – ip3tL: Order of interpolation function. Default is 2nd order.

  • tetra (bool) – ip3tL: linear interpolation.

createMeanLineDistribution(dataSet, sol='FlowSolution', output='../output/POST/meanLine.dat')[source]

Creates and writes a 1D mesh with averaged data from xi-const analysis planes created by the intersect3DS2MPlane task for generating 1D distributions.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • sol (str) – Name of solution whose data is taken

  • output (str) – Name of output file including directory

createS2MPlane(dataSet, typeDB=['analysis2d'], sol='FlowSolution', avgType=['flux', 'mass', 'area'], output='../output/POST/s2m.dat')[source]

This Task creates and writes a S2M Plane based on previous averaging.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • typeDB (list[str]) – Specify nothing! (dB-task option)

  • sol (str) – Please specify the solution name to be shown. (bS2m-task option)

  • avgType (list[str]) – Please specify the weighting method (‘flux’, ‘mass’, ‘area’). (bS2m-task option)

  • output (str) – Name of the output file including directory. (wS2m-task option)

createThetaLines(dataSet, gf, cf, bf)[source]

Creates r-constant lines in theta direction on analysis families.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • gf (str) – Tecplot file with grid to define the cut.

  • cf (str) – Tecplot file to define cutting positions.

  • bf (str) – Tecplot file to define band positions.

crossDiffusionKW(dataSet, name=['TurbulentEnergyKinetic', 'TurbulentDissipationRate'])[source]

Compute cross diffusion term of turbulent kinetic energy and dissipation rate.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

name (list[str]) – Specify the two variable names for turbulent kinetic energy and dissipation rate for gradient task.

deleteBlock(dataSet, type=None, dim=None, fam=None, famtype=None, asn=None, bnl=None, bc=None, bb=None, dg=None, regex=None, keep=None)[source]

Delete specified blocks.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • type (list[str]) – Select blocks of type ‘boundary’, ‘analysis2d’, ‘analysis1d’ or ‘undefined’.

  • dim (int) – Select blocks of specified cell dimension.

  • fam (list[str]) – Select blocks in specified family.

  • famtype (list[str]) – Select blocks in specified family type.

  • asn (str) – Select analysis surface with specified names.

  • bnl (list[str]) – Select all blocks with specified names.

  • bc (list[str]) – Select all boundary blocks with specified boundary conditions.

  • bb (list[float]) – Select all blocks outside a bounding box (xmin ymin zmin xmax ymax zmax)

  • dg (bool) – Select all blocks, which are not refined (DG task -rfm).

  • regex (bool) – Use regular expression syntax to find matching names.

  • keep (bool) – Keep blocks specified by criteria and delete rest.

deletePhysics(dataSet, var=None, sol=None, keep=None)[source]

Delete variables or solutions.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • var (list[str]) – Delete specified variables (real and imaginary).

  • sol (list[str]) – Delete solutions of specified names.

  • keep (bool) – Keep variables/solutions specified by criteria and delete rest.

desEvaluation(dataSet, hybridApproach, basisModel, tau, subgridApproach='GridBased', additionalOutput=None, kappa=0.4, retain=None, var=['VelocityXGradientX', 'VelocityXGradientY', 'VelocityXGradientZ', 'VelocityYGradientX', 'VelocityYGradientY', 'VelocityYGradientZ', 'VelocityZGradientX', 'VelocityZGradientY', 'VelocityZGradientZ', 'StrainRateXX', 'StrainRateXY', 'StrainRateXZ', 'StrainRateYY', 'StrainRateYZ', 'StrainRateZZ'], gradVariables=['VelocityX', 'VelocityY', 'VelocityZ'])[source]

Process chain for DES evaluation.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • hybridApproach (str) – Applied hybrid approach. [DES, DDES or IDDES]

  • basisModel (str) – Applied basis model. [SpalartAllmaras, Wilcox1988 or MenterSST2003]

  • tau (float) – Characteristic time scale

Optional Parameters

Parameters
  • subgridApproach (str) – Applied subgrid length scale approach. [Default = GridBased, Chauvet, Probst, Mockett, Shur]

  • additionalOutput (bool) – Activates additional output values for blending and shielding function task.

  • kappa (float) – Value for model constant kappa applied within DES shielding function (default 0.40).

  • retain (bool) – Retains variables such as i.e. strain rate from intermediate steps

  • var (list[str]) – Variables to delete

  • gradVariables (list[str]) – Specify needed gradients. By default, velocity gradient tensor is computed.

detStressFourier(dataSet)[source]

Computes the deterministic stress tensor based on Fourier data.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Return Value

Returns

dataSet

Return type

PyPostDataSet

diffFlowFields(dataSet, var=None, rel=None, dap=None)[source]

Calculate the difference between two data sets.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet or list[PyPostDataSet]) – a dataSet or a list of two dataSets

Optional Parameters

Parameters
  • var (list[str]) – Variables to limit the difference calculations to.

  • rel (bool) – Calculate differences relative to second (of two) input data set(s).

  • dap (bool) – Calculate the difference of complex amplitude and phase (and convert back to cartesian complex plane).

Return Value

Returns

dataSet

Return type

PyPostDataSet

diffStatistics(dataSet)[source]

Difference of statistics sums.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet or list[PyPostDataSet]) – a dataSet or a list of two dataSets

Return Value

Returns

dataSet

Return type

PyPostDataSet

discreteFourierTransform(dataSet, accumulatorDataSet, nPics, hl, f=None)[source]

Perform discrete Fourier transform of movie data set.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • accumulatorDataSet (PyPostDataSet or None) – accumulationDataSet for dataSet for task, None for first iteration

  • nPics (int) – number of iterations for this task

  • hl (list[int]) – order(s) of harmonics to be processed, e.g. 1-3 5 7

Optional Parameters

Parameters

f (list[float]) – list of frequencies (by default frequency is read from cgns)

Return Value

Returns

updated accumulationDataSet for task. Should be passed in next iteration.

Return type

PyPostDataSet

discretePassageFourierTransform(dataSet, fam=None, ibpa=None)[source]

Performs discrete, passagewise Fourier transform.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • fam (list[str]) – List of blockgroups for which the discrete, passagewise Fourier transform is computed.

  • ibpa (list[float]) – List of interblade phase angles for which the discrete, passagewise Fourier transform is computed.

distanceWallCoordinate(dataSet)[source]

Compute first distances to the wall in wall coordinates (yPlus).

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

duplicateAndReconstructFourierData(dataSet, t, nSegments=None, annulus=None, pitch=None, oneToOne=None)[source]

Duplicate, rotate and reconstruct Fourier data in a single task.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet or list[PyPostDataSet]) – a dataSet or a list of two dataSets

  • t (float) – Absolute time in seconds. Mind phase shift when restarting from t!=0

Optional Parameters

Parameters
  • nSegments (int) – Required number of segments.

  • annulus (bool) – Duplicates data to create full annulus (rotational, only).

  • pitch (float) – Create segments with the specified pitch (degrees or meters).

  • oneToOne (bool) – Duplicate passages to automatically generate 1-to-1 connections.

Return Value

Returns

dataSet

Return type

PyPostDataSet

duplicateData(dataSet, nSegments=None, annulus=None, pitch=None, oneToOne=None)[source]

Duplicate a data set and rotate by pitch.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • nSegments (int) – Required number of segments.

  • annulus (bool) – Duplicates data to create full annulus (rotational, only).

  • pitch (float) – Create segments with the specified pitch (degrees or meters).

  • oneToOne (bool) – Duplicate passages to automatically generate 1-to-1 connections.

evaluateReynoldsStressRealizability(dataSet)[source]

Evaluates fraction of cells in which Reynolds stress realizability constraints have been applied.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

extractIsoSurface(dataSet, var, value)[source]

Creates 2D blocks derived from iso-surface of specified ‘var’ and ‘value’ for every 3D block (with appropriate value range).

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • var (str) – variable to create iso-surface from

  • value (float) – variable’s value to create iso-surface with

extractProbeXYZ(dataSet, x, y, z)[source]

Extract data at given coordinates and write to file.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • x (float) – x coordinate.

  • y (float) – y coordinate.

  • z (float) – z coordinate.

favreAverageSpatially(dataSet, index)[source]

Compute a spatial Favre average along specified homogeneous index directions.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • index (list[str]) – Indices of homogeneous directions.

frictionVelocity(dataSet)[source]

Compute friction velocity on 2D panels.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

generateAuxiliaryS2Mesh(dataSet, hub=None, tip=None, simple=None, nCuts=18, type='max', typeDB=['cutHub', 'cutTip'], reference='hub', xieta='length')[source]

This Task generates an auxiliary S2 mesh required for S2M-averaging.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • hub (list[str]) – Please specify all hub boundary blocks by listing up their names (space-separated!) (gtc-task option)

  • tip (list[str]) – Please specify all tip boundary blocks by listing up their names (space-separated!) (gtc-task option)

  • simple (bool) – Automatic hub/tip- boundary detection for simple configurations using GMC-nomenclature. Default is deactivated. (gtc-task option)

  • nCuts (int) – Specify the number of theta = const cuts (gtc-task option) (default 18)

  • type (str) – Please specify ‘min’ (minimal silhouette is generated) or ‘max’ (maximal silhouette is generated) (geo-task option)

  • typeDB (list[str]) – Specify nothing!

  • reference (str) – Specify whether the ‘hub’ or the ‘tip’ line is the reference curve. If nothing’s specified the line with the most vertices is taken (genS2-task option).

  • xieta (str) – Specify in which way the xi and eta values should be generated (‘index’- or ‘length’-based). (genS2-task option)

generateOffsetCurves(dataSet, offset)[source]

Generate curves with an offset from airfoil sections curve.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • offset (float) – Offset in m.

generateQ3DS2M(dataSet)[source]

Creates S2M block for Q3D test cases (z-direction).

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

generateRaysOnWalls(dataSet, raySize, rayLength)[source]

Create rays orthogonal to all viscous walls. (N.B.: Subsequent interpolation does only work with ip3tl task.)

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • raySize (int) – Number of points on the ray.

  • rayLength (float) – Length of the ray in m.

geomDiff(dataSet, invDir=None)[source]

Calculates the vertex-by-vertex difference of two data sets with identical grid topology and gathers the sum of all vertex distances for each block to a global metric.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet or list[PyPostDataSet]) – a dataSet or a list of two dataSets

Optional Parameters

Parameters

invDir (bool) – Invert direction of vectors for geometric differences.

Return Value

Returns

dataSet

Return type

PyPostDataSet

gradient(dataSet, name=None, velocity=None, magnitude=None, ugg=None, unn=None, ufa=None)[source]

Calculate gradients for the given variable set.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • name (list[str]) – List of variables.

  • velocity (bool) – Calculate the velocity gradient.

  • magnitude (bool) – Calculate magnitudes of gradients.

  • ugg (bool) – Use Green-Gauss to calculate gradients for unstructured zones.(default)

  • unn (bool) – Use Least-Square (Node Neighbors) to calculate gradients for unstructured zones.

  • ufa (bool) – Use Least-Square (Full Augmentation) to calculate gradients for unstructured zones.

gtaCalc3DParameters(dataSet, avg='mass', height=0.5, pitchShift=None)[source]

Calculate ‘gta’ parameters on analysis surfaces or sections of them.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • avg (str) – The averaging type of the reference values at inlet and outlet.

  • height (float) – The channel height at which the reference values are read.

  • pitchShift (list[str]) – Shift relative pitch for each specified S3 plane. Usage example: -pitchShift ME1 0.23 ME4 -0.42

heatTransferCoefficient(dataSet)[source]

This task calculates the heat transfer coefficient from an adiabatic and a diabatic input. Two input data sets are required, the output contains the flow field of the 2nd data set! The standard usage is -input diabatic.cgns -input adiabatic.cgns.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet or list[PyPostDataSet]) – a dataSet or a list of two dataSets

Return Value

Returns

dataSet

Return type

PyPostDataSet

helicityRelative(dataSet)[source]

Compute the relative helicity.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

input(filename, hl=None, hlm=None, sn=None, vn=None, ias=None, rbc=None, slf=None, cc=None, family=None, noGhost=None, dcrs=None)[source]

Read a (list of) CGNS/Tecplot ASCII file(s) into a data set. Sub-option only valid for CGNS files.

Mandatory Parameters

Parameters

filename (str) – name of the file

Optional Parameters

Parameters
  • hl (list[int]) – Specify a list of harmonics to be read (deprecated, use -slf instead).

  • hlm (list[int]) – Specify harmonic indices to be associated with harmonic names (deprecated, no longer supported).

  • sn (str) – Specify the name of one solution to be read.

  • vn (list[str]) – Specify the names of the variables to be read.

  • ias (bool) – Ignore all flow solutions, harmonics, etc..

  • rbc (bool) – Read boundary conditions and create boundary blocks.

  • slf (str) – Specify the name of the file containing the solutions to be processed.

  • cc (bool) – Treat multicomponent gas as a constant composition mixture.

  • family (list[str]) – Specify a list of block group families to be read. All blocks of other families will be ignored.

  • noGhost (bool) – Ignore the ghost cells while reading.

  • dcrs (bool) – Don’t check if the reference state equals those in previously loaded files.

Return Value

Returns

dataSet

Return type

PyPostDataSet

integrateBoundaryLayerEdge(dataSet, pressureStagnationCriterion=0.995)[source]

Integrate the Boundary Layer, compute boundary layer thicknesses and shape factors.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

pressureStagnationCriterion (float) – Criterion for boundary layer edge detection, between zero and one (default: 0.995).

interpolate1d(dataSet, vertexBased=None, order=2, linear=None, noLeastSquaresMatrixRegularization=None)[source]

Interpolate field data from parent zones onto analysis lines.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • vertexBased (bool) – If flag is set interpolation is made directly on Vertices.

  • order (int) – Choose interpolation order. 1st or 2nd order (default).

  • linear (bool) – If flag is set interpolation is linear. Requires options ‘-vertexBased’ and ‘-order 2’.

  • noLeastSquaresMatrixRegularization (bool) – If flag is set no additional vertex is added to the least squares stencil.

interpolate2d(dataSet, order=2, linear=None)[source]

Interpolate field data from parent zones onto analysis and boundary panels.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • order (int) – Choose interpolation order for interpolation on analysis planes. 1st or 2nd order (default: 2nd order).

  • linear (bool) – If flag is set interpolation is linear.

interpolate3Dto1D(dataSet, through2d=None, onVertex=None, order=2, tetra=None)[source]

Interpolates 3D field data from (grand)parent 3d blocks onto analysis lines.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • through2d (bool) – Apply task only to the 1d blocks with parents being 2d blocks (w/o the option only direct children of 3d blocks are considered).

  • onVertex (bool) – Interpolation on vertices.

  • order (int) – Choose interpolation order: 1st or 2nd order (default).

  • tetra (bool) – Tetrahedron based interpolation.

interpolate3dToLines(dataSet, onVertex=None, order=2, tetra=None)[source]

Interpolate field data from volume zones onto analysis lines using a kdTree. This task is intended for interpolation if no parent block information is available.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • onVertex (bool) – Interpolation on vertices.

  • order (int) – Order of interpolation function. Default is 2nd order.

  • tetra (bool) – If flag is set interpolation is tetrahedron based.

interpolateCellCenteredToVertexData(dataSet)[source]

Interpolation of cell centered flow data to vertex based flow data.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Return Value

Returns

dataSet

Return type

PyPostDataSet

interpolateS2MToBoundary(dataSet)[source]

Interpolate relative mass flow from S2M block to all solid boundaries.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

interpolateVertexToCellCenteredData(dataSet)[source]

Interpolation of vertex based flow data to cell centered flow data.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Return Value

Returns

dataSet

Return type

PyPostDataSet

intersect3DAndAddInterfacesForS2m(dataSet, nCuts=101, nBands=71, main=None, xiRange=None, etaRange=None, etaExpCoeff=None, etaRelDist=None, etaLocation='both')[source]

Combined task for generation of re-banded interfaces and xi cuts used for the S2M-plane.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • nCuts (int) – Specify number of cuts.

  • nBands (int) – Specify number of bands.

  • main (bool) – Cut only main block groups (ROTOR, STATOR, DUCT_R, DUCT_S).

  • xiRange (list[float]) – Optionally specify range of xi as min max.

  • etaRange (list[float]) – Optionally specify range of eta as min max..

  • etaExpCoeff (list[float]) – Use an exponential function for eta distribution specifying the amplitude (and a scaling factor).

  • etaRelDist (list[float]) – Use an exponential function for eta distribution specifying the first relative distance and the stretching ratio.

  • etaLocation (str) – Use eta distribution at both sides or at one side only. Allowed values: <both|lower|upper> (default: both).

intersect3DS2MPlane(dataSet, nCuts=101, nBands=71, main=None, xiRange=None, etaRange=None, etaExpCoeff=None, etaRelDist=None, etaLocation='both')[source]

Generates xi = const cuts (xi = running length) of a 3D configuration using the S2M-plane.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • nCuts (int) – Specify number of cuts.

  • nBands (int) – Specify number of bands.

  • main (bool) – Cut only main block groups (ROTOR, STATOR, DUCT_R, DUCT_S).

  • xiRange (list[float]) – Optionally specify range of xi as min max.

  • etaRange (list[float]) – Optionally specify range of eta as min max.

  • etaExpCoeff (list[float]) – Use an exponential function for eta distribution specifying the amplitude (and a scaling factor).

  • etaRelDist (list[float]) – Use an exponential function for eta distribution specifying the first relative distance and the stretching ratio.

  • etaLocation (str) – Use eta distribution at both sides or at one side only. Allowed values: <both|lower|upper> (default: both).

intersectBoundaryLayer(dataSet, source='panel')[source]

Create boundary layer cuts.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

source (str) – Select source for boundary layer cuts (‘cut’ or ‘panel’).

intersectLine(dataSet, cf=None, Kp=None, q3d=None)[source]

Create analysis lines.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • cf (str) – Tecplot file to define cutting positions.

  • Kp (bool) – If flag is set the mesh’s K-planes are used to cut instead of Xi/Eta level sets.

  • q3d (bool) – Cut Q3D cases in half for all solid panels.

intersectPanel(dataSet, gf=None, cf=None, bf=None, clf=None, cn=None, main=None)[source]

Create analysis surfaces.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • gf (str) – Tecplot file with grid to define the cut.

  • cf (str) – Tecplot file to define cutting positions.

  • bf (str) – Tecplot file to define band positions.

  • clf (str) – Tecplot file to define clipping boundaries.

  • cn (str) – Name of cut (mandatory for universal type cuts).

  • main (bool) – Cut only main block groups.

inverseDiscreteFourierTransform(dataSet, t)[source]

Perform inverse discrete Fourier transform to compute solution at a given time.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet or list[PyPostDataSet]) – a dataSet or a list of two dataSets

  • t (float) – Absolute time in seconds.

Return Value

Returns

dataSet

Return type

PyPostDataSet

inverseDiscretePassageFourierTransform(dataSet, fam=None)[source]

Performs inverse discrete, passagewise Fourier transform.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

fam (list[str]) – List of blockgroups for which the inverse discrete, passagewise Fourier transform is computed.

isolateImplicitCells(dataSet, RungeKuttaMethod, dt=None, useMinEdgeLength=None, output=None, dot=None, maxCutTreeDepth=None, minCellDim=None)[source]

Create a GMC journal file to separate implicit and explicit cells.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • RungeKuttaMethod (str) – Name of the IMEX Runge-Kutta method (determines the max. stable CFL number).

Optional Parameters

Parameters
  • dt (float) – Time-step size to be used to calculate the CFL number.

  • useMinEdgeLength (bool) – Compute the CFL number using the minimum edge length (FV only).

  • output (str) – Name of the GMC journal file to be created.

  • dot (bool) – Create block split dot files.

  • maxCutTreeDepth (int) – Maximum cut tree depth (default 10)

  • minCellDim (int) – Minimum block cell dimensions (default 4)

linearizedPressureStagnation(dataSet)[source]

Calculate the linearized stagnation pressure for harmonic solutions.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

linearizedTemperatureStagnation(dataSet)[source]

Calculate the linearized stagnation temperature for harmonic solutions.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

localCFL(dataSet, dt=None, useMinEdgeLength=None)[source]

Computation of local CFL number for physical time step.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • dt (float) – Time-step size to be used to calculate the CFL number.

  • useMinEdgeLength (bool) – Compute the CFL number using the minimum edge length (FV only).

maxPPW(dataSet, f)[source]

Calculate the resolution in points per wavelength for a given frequency.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • f (float) – Frequency to use.

mergeAnalysisLines(dataSet, blc=None, parentBlockInfo=None, identifierSS=None)[source]

This task merges corresponding existing S1 blade cuts and boundary layer cuts into single 1D blocks.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • blc (bool) – Merge only boundary layer cuts.

  • parentBlockInfo (bool) – Add parent info to a new solution “ParentBlockInfo”.

  • identifierSS (str) – Add a identifier-string (e.g. Wall_ss), the panelgroup-names of the suction side contain to merge the lines starting along the suction side.

mergeDataSets(dataSet)[source]

Creates a data set from specified input files and solutions.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet or list[PyPostDataSet]) – a dataSet or a list of two dataSets

Return Value

Returns

dataSet

Return type

PyPostDataSet

meshStatistics(dataSet, RungeKuttaMethod, nDataBins=None)[source]

Computation of mesh statistics.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • RungeKuttaMethod (str) – Name of the IMEX Runge-Kutta method (determines the max. stable CFL number).

Optional Parameters

Parameters

nDataBins (int) – Number of data bins used to create the histogram.

nonDimBoundaryLayerValues(dataSet)[source]

Calculate non-dimensional wall parallel velocity and wall distance based on friction velocity.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

nonDimensionalCellSize(dataSet)[source]

Compute non-dimensional cell sizes in i,j,k index directions of wall adjacent cell.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

output(dataSet, filename, cmc=None, sts=None, wgc=None, bf=None, ffs=None, As=None, ap=None, dss=None, type=None, dim=None, fam=None, famtype=None, asn=None, bnl=None, bc=None, bb=None, dg=None, regex=None, invert=None)[source]

Write a data set into a file with the specified name. (‘.cgns’ for a CGNS file, ‘.dat’ for a Tecplot ASCII file, ‘.plt’ for a Tecplot Binary file, ‘.pvtu’ for a parallel VTK file)

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • filename (str) – name of the file

Optional Parameters

Parameters
  • cmc (bool) – Create master CGNS file for the output picture series.

  • sts (bool) – Set time strands so that Tecplot automatically recognizes solution time.

  • wgc (bool) – Write ghost cells in Tecplot output.

  • bf (list[str]) – Specify the block group families to be written to Tecplot file. (Deprecated. Use option -fam instead.)

  • ffs (bool) – Create the output CGNS file from scratch.

  • As (bool) – Append solutions to an existing CGNS file. Restart solutions have to be written first, without this option.

  • ap (bool) – Write amplitude and phase for complex fields

  • dss (bool) – Write a dataset-summary file of the output-data, i.e. block & family metadata. available for cgns and plt output

  • type (list[str]) – Select blocks of type ‘boundary’, ‘analysis2d’, ‘analysis1d’ or ‘undefined’.

  • dim (int) – Select blocks of specified cell dimension.

  • fam (list[str]) – Select blocks in specified family.

  • famtype (list[str]) – Select blocks in specified family type.

  • asn (str) – Select analysis surface with specified names.

  • bnl (list[str]) – Select all blocks with specified names.

  • bc (list[str]) – Select all boundary blocks with specified boundary conditions.

  • bb (list[float]) – Select all blocks outside a bounding box (xmin ymin zmin xmax ymax zmax)

  • dg (bool) – Select all blocks, which are not refined (DG task -rfm).

  • regex (bool) – Use regular expression syntax to find matching names.

  • invert (bool) – Invert block selection.

outputIntegralData(dataSet, fileName, avgType, bandCenterAsVertex=None, fam=None, sol=None, var=None, dim=0)[source]

Write 0D/1D boundary/interface/analysis integral values.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • fileName (str) – Output file name.

  • avgType (str) – Specify averaging type: flux, mass, area.

Optional Parameters

Parameters
  • bandCenterAsVertex (bool) – Flag to write the band centers as vertices.

  • fam (list[str]) – List of families.

  • sol (list[str]) – Solution list.

  • var (list[str]) – Variable List.

  • dim (int) – Specify dimension: 0 (default), 1

probeAtIJK(dataSet, zone=None, zoneName=None, withDuplicates=None, output=None, i=None, j=None, k=None)[source]

Extracts data at given indices or ranges and writes it to file.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • zone (int) – index of zone to be probed (CGNS notation)

  • zoneName (str) – name of zone to be probed

  • withDuplicates (bool) – extend probing to zones with the same name (as are created using ‘–duplicateData / -dd’).

  • output (str) – name of the Tecplot output file, without extension (‘.dat’ will be added)

  • i (list[int]) – i index or range, in CGNS notation

  • j (list[int]) – j index or range, in CGNS notation

  • k (list[int]) – k index or range, in CGNS notation

qCriterion(dataSet, gradVar=['VelocityX', 'VelocityY', 'VelocityZ'])[source]

Computes Q-criterion for the visualization of vortex structures.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

gradVar (list[str]) – Specify needed gradients. By default, velocity gradient tensor is computed.

radialAverage(dataSet, mass=None, area=None, daType=None)[source]

Overwrites panel averages by a mass or area averaging of the corresponding bands.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • mass (bool) – use mass averaging in radial direction

  • area (bool) – use area averaging in radial direction

  • daType (str) – derived average type (‘work’|’mechanicalWorkPotential’|’entropy’): choose between work average, mechanical work potential based, and entropy average. Default is ‘none’, i.e., no derived quantities are computed from averages.

readInterfaceFiles(dataSet, f=None, autoSelectFiles=None, bdDir='./output/residual', bdPrefix='bd', radialDir='./output/boundary', radialPrefix='radial', dota=None, excludeNames=None)[source]

This task reads interface files (0D and 1D), written e.g. by TRACE. You must use exactly one the sub-options -f or -autoSelectFiles.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • f (list[str]) – Tecplot ASCII files containing 0D or 1D values. Not compatible with -autoSelectFiles

  • autoSelectFiles (bool) – Automatically select appropriate bd and radial files for bd-based GTA chain. Not compatible with -f

  • bdDir (str) – Path to directory containing bd-files. Use together with -autoSelectFiles. (default: ./output/residual/)

  • bdPrefix (str) – Prefix for bd-files. Use together with -autoSelectFiles. (default: bd)

  • radialDir (str) – Path to directory containing radial-files. Use together with -autoSelectFiles. (default: ./output/boundary/)

  • radialPrefix (str) – Prefix for radial-files. Use together with -autoSelectFiles. (default: radial)

  • dota (bool) – Do not overwrite time averages with instantaneous values, i.e., use instantaneous values only if time averages are unavailable.

  • excludeNames (list[str]) – List of strings to exclude from search in *.dat filenames.

readS2m(dataSet, lS2, xieta=None)[source]

This task reads in a Tecplot file containing a structured S2-mesh.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • lS2 (str) – Load a Tecplot file with S2M-grid

Optional Parameters

Parameters

xieta (str) – Specify in which way the xi and eta values should be generated (‘index’-, ‘length’- or ‘xhrel’-based).

reconstructTimeHistory(dataSet, nPics, f, positionTheta=None, exact=None)[source]

Reconstruct time history from Fourier data.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • nPics (int) – number of pictures to be created

  • f (float) – frequency to use in reconstruction of time history

Optional Parameters

Parameters
  • positionTheta (float) – Angular position (in degree) near a multiple of segments to which the block groups are to be rotated.

  • exact (bool) – Rotate exactly to angular position given by ‘positionTheta’.

Return Value

Returns

iterator over PyPostDataSet

Return type

PyPostSchedulerIterator

redefineBandIntegrals(dataSet, icf)[source]

Redefine band integrals of all boundaries and control domains.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • icf (str) – Tecplot file to define cutting positions.

redefineBands(dataSet, mf=None, area=None, family=None, cleaks=None, igf=None, ibf=None, boundaries=None, transferSol=None, ewc=None, pos=None, familyToCopyAndClip=None, flowRegion='core', newFamily=None)[source]

Redefine bands on surfaces.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • mf (list[float]) – List of relative massflow values.

  • area (list[float]) – List of relative area values used to compute relative massflow values at the given family.

  • family (str) – Family used for converting area in massflow values or used as reference for the cleaks option.

  • cleaks (bool) – Consider massflow leaks at hub and tip streamtubes.

  • igf (str) – Tecplot file with grid to define the bands.

  • ibf (str) – Tecplot file to define band positions.

  • boundaries (str) – Kind of boundary families to be processed (‘all’|’zonals’|’none’).

  • transferSol (bool) – Transfer existing flow solutions to the new bands.

  • ewc (str) – Tecplot file with hub and Tip lines for not axial symmetric Bands

  • pos (list[float]) – List of relative positions that seperates the new bands for ewc mode.

  • familyToCopyAndClip (str) – Family to be copied. The copy will be clipped using the leaked massflows and will receive new bands according to the mf option.

  • flowRegion (str) – Flow region to copy: hub, core, tip.

  • newFamily (str) – Name of the new family, result of clipping.

removeAllStatisticsSums(dataSet, var=['temp', 'PressureVelocityX', 'PressureVelocityY', 'PressureVelocityZ', 'DensityVelocityXVelocityX', 'DensityVelocityXVelocityY', 'DensityVelocityXVelocityZ', 'DensityVelocityYVelocityX', 'DensityVelocityYVelocityY', 'DensityVelocityYVelocityZ', 'DensityVelocityZVelocityX', 'DensityVelocityZVelocityY', 'DensityVelocityZVelocityZ', 'DensityDensity', 'PressurePressure', 'DensityVelocityXXX', 'DensityVelocityXXY', 'DensityVelocityXXZ', 'DensityVelocityXYY', 'DensityVelocityXYZ', 'DensityVelocityXZZ', 'DensityVelocityYYY', 'DensityVelocityYYZ', 'DensityVelocityYZZ', 'DensityVelocityZZZ', 'DensityVelocityXQuaded', 'DensityVelocityYQuaded', 'DensityVelocityZQuaded', 'ViscousStressXXVelocityX', 'ViscousStressXYVelocityX', 'ViscousStressXZVelocityX', 'ViscousStressYYVelocityX', 'ViscousStressYZVelocityX', 'ViscousStressZZVelocityX', 'ViscousStressXXVelocityY', 'ViscousStressXYVelocityY', 'ViscousStressXZVelocityY', 'ViscousStressYYVelocityY', 'ViscousStressYZVelocityY', 'ViscousStressZZVelocityY', 'ViscousStressXXVelocityZ', 'ViscousStressXYVelocityZ', 'ViscousStressXZVelocityZ', 'ViscousStressYYVelocityZ', 'ViscousStressYZVelocityZ', 'ViscousStressZZVelocityZ', 'MomentumDensityXGradientX', 'MomentumDensityXGradientY', 'MomentumDensityXGradientZ', 'MomentumDensityYGradientX', 'MomentumDensityYGradientY', 'MomentumDensityYGradientZ', 'MomentumDensityZGradientX', 'MomentumDensityZGradientY', 'MomentumDensityZGradientZ', 'ViscousStressXXGradientX', 'ViscousStressXYGradientX', 'ViscousStressXZGradientX', 'ViscousStressYYGradientX', 'ViscousStressYZGradientX', 'ViscousStressZZGradientX', 'ViscousStressXXGradientY', 'ViscousStressXYGradientY', 'ViscousStressXZGradientY', 'ViscousStressYYGradientY', 'ViscousStressYZGradientY', 'ViscousStressZZGradientY', 'ViscousStressXXGradientZ', 'ViscousStressXYGradientZ', 'ViscousStressXZGradientZ', 'ViscousStressYYGradientZ', 'ViscousStressYZGradientZ', 'ViscousStressZZGradientZ', 'ViscousStressXX', 'ViscousStressXY', 'ViscousStressXZ', 'ViscousStressYY', 'ViscousStressYZ', 'ViscousStressZZ', 'DissipationRateXX', 'DissipationRateXY', 'DissipationRateXZ', 'DissipationRateYY', 'DissipationRateYZ', 'DissipationRateZZ', 'StrainRateXX', 'StrainRateXY', 'StrainRateXZ', 'StrainRateYY', 'StrainRateYZ', 'StrainRateZZ', 'PressureStrainRateXX', 'PressureStrainRateXY', 'PressureStrainRateXZ', 'PressureStrainRateYY', 'PressureStrainRateYZ', 'PressureStrainRateZZ'])[source]

Remove all statistical sums, which are not required for further analysis.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

var (list[str]) – Variables to delete

renameSolution(dataSet, sol)[source]

Rename all solutions with the specified name.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • sol (list[str]) – <original solution name> <new solution name> .

rescaleDisplacements(dataSet, andFlow=None, f=None, amp=None)[source]

Rescale displacements, harmonic flow solutions and modal force per area for all eigenmodes.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • andFlow (bool) – Also rescale harmonic flow perturbations and modal forces.

  • f (float) – Frequency of the fundamental harmonic.

  • amp (list[float]) – Amplitude for rescaling (real and imaginary part).

rotateAerowork(dataSet)[source]

Computes aerodynamic work integral from aerowork stored in the input file and rotate face values by the integral values phase. Requires the -aea task to compute integral values.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

rotateData(dataSet, family=None, offset=None, positionTheta=None, exact=None)[source]

Rotate data set using the specified segment offset.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • family (str) – Block group family to be rotated.

  • offset (int) – Integer segment offset.

  • positionTheta (float) – Angular position (in degree) near a multiple of segments to which the block groups are to be rotated.

  • exact (bool) – Rotate exactly to angular position given by ‘positionTheta’.

Return Value

Returns

dataSet

Return type

PyPostDataSet

s1coordinates(dataSet, sol='FlowSolution', detLETEbyDist=None, detLETEbyXi=None, relDist=0.125, indexShift=13, signed=None, signedByNames=None)[source]

Calculate normalized coordinates along an airfoil section.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • sol (str) – The solution to which the coordinates will be added.

  • detLETEbyDist (bool) – Flag to determine LE and TE by max. distance instead of maximum curvature.

  • detLETEbyXi (bool) – Flag to determine LE and TE by min. and max. xi instead of maximum curvature.

  • relDist (float) – specify the relative distance from initially determined LE and TE to search for maximum curvature.

  • indexShift (int) – specify index shift to define left and right leg from current vertex to search for maximum curvature.

  • signed (bool) – Add signed coordinates, negative on the suction side and positive on the pressure side. SS and PS determined by Pressure.

  • signedByNames (bool) – Add signed coordinates, negative on the suction side and positive on the pressure side. This subopoption expects a correctly merged S1-cut from the -mal task using suboption identifierSS.

s1cylindricalCoordinates(dataSet, sol='FlowSolution')[source]

Calculate cylindrical coordinates along an airfoil section.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

sol (str) – The solution to which the coordinates will be added.

s2mRTP(dataSet, deep=2, autodeep=None, nAxial=500, nRadial=500, x_min=None, x_max=None, r_min=None, r_max=None)[source]

Performs a S2M-averaging by a recursive Tetrahedron decomposition and projection to a 2D Raster grid (RTP).

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • deep (int) – deep: recursive refinement steps

  • autodeep (bool) – Flag to use adaptive deep refinement (defined deep factor is ignored!).

  • nAxial (int) – Mesh Size Axial

  • nRadial (int) – Mesh Size Radial

  • x_min (float) – Mesh X min

  • x_max (float) – Mesh X max

  • r_min (float) – Mesh R min

  • r_max (float) – Mesh R max

setMassAveragedPressureStagnation(dataSet, type, cda=None)[source]

Set mass average stagnation pressure to work or entropy averaged value or to the value derived from the mechanical work potential.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • type (str) – averaging type (‘work’|’mechanicalWorkPotential’|’entropy’): choose between work average, mechanical work potential based, and entropy average.

Optional Parameters

Parameters

cda (bool) – flag to compute derived averages

setupGeometry(dataSet)[source]

Geometry setup.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

setupMetrics(dataSet)[source]

Metrics setup.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

shearStressWall(dataSet)[source]

Calculate wall shear stress vector on all solid walls.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

storeElementCentersToFields(dataSet)[source]

Stores element center coordinates to fields, i.e. as variable ‘CoordinateCenterX’, ‘CoordinateCenterY’ and ‘CoordinateCenterZ’.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

storeFaceNormalsToFields(dataSet)[source]

Stores face normal vector components of 2D blocks to fields, i.e. as variable ‘NormalX’, ‘NormalY’ and ‘NormalZ’.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

storeReferenceValues(dataSet, avgType='flux')[source]

Store reference values (panel integral values or band value at cut position) of corresponding inlet panel.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

avgType (str) – Specify averaging type: flux, mass or area.

surfaceHeatFlux(dataSet)[source]

Calculate surface heat flux.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

timeAverage(dataSet, accumulatorDataSet, nPics)[source]

Compute time average of field and integral data values.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • accumulatorDataSet (PyPostDataSet or None) – accumulationDataSet for dataSet for task, None for first iteration

  • nPics (int) – number of iterations for this task

Return Value

Returns

updated accumulationDataSet for task. Should be passed in next iteration.

Return type

PyPostDataSet

timeDistanceDataset(dataSet, accumulatorDataSet, nPics, name, baseFrequency=None)[source]

This task creates a 2D-dataset for time-distance-diagrams. The task requires s1 blade cuts that are reconstructed into time domain (movie-files or reconstructed fourier data).

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • accumulatorDataSet (PyPostDataSet or None) – accumulationDataSet for dataSet for task, None for first iteration

  • nPics (int) – number of iterations for this task

  • name (list[str]) – Name of the airfoil section cuts to be merged. e.g. row02Blade002_3dH050.00

Optional Parameters

Parameters

baseFrequency (float) – Base frequency to create a normalized time variable (normalizedTime = time*baseFrequency).

Return Value

Returns

updated accumulationDataSet for task. Should be passed in next iteration.

Return type

PyPostDataSet

transferBandIntegralsToSurfaces(dataSet, avgType='mass')[source]

Read integral values of bands and write the values to the corresponding panels.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

avgType (str) – The averaging type of the band integrals.

transformCartesianMeshToCylindrical(dataSet)[source]

Transforms Cartesian mesh coordinates to cylindrical coordinate system

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

transformCircFourierCoeffsToAbsSystem(dataSet)[source]

Transforms circumferential Fourier coefficients from relative to absolute frame of reference.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

transformCylindricalMeshToCartesian(dataSet)[source]

Transforms cylindrical mesh coordinates to Cartesian coordinate system

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

transformMeshAndFlowSolution(dataSet, mod=None)[source]

Transform mesh and flow solution to actual position.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

mod (bool) – Use modulo operation on rotation angle to keep it within one pitch.

transformReynoldsStressCylindrical(dataSet)[source]

Transforms the Reynolds stress tensor to cylindrical basis (x-r-theta).

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

translateMesh(dataSet, vec=[0, 0, 0])[source]

Translate the mesh with a given vector.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

vec (list[float]) – vector for the translation (x y z)

valueRMS(dataSet, accumulatorDataSet, nPics)[source]

Calculates the root mean square of all values. Input value should be fluctuations!

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • accumulatorDataSet (PyPostDataSet or None) – accumulationDataSet for dataSet for task, None for first iteration

  • nPics (int) – number of iterations for this task

Return Value

Returns

updated accumulationDataSet for task. Should be passed in next iteration.

Return type

PyPostDataSet

velocityCrossVorticityNorm(dataSet)[source]

Compute the norm of the cross product of velocity and vorticity vectors.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

velocityRMS(dataSet, accumulatorDataSet, nPics)[source]

Calculates the root mean square of velocities. Input velocity should be fluctuations!

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • accumulatorDataSet (PyPostDataSet or None) – accumulationDataSet for dataSet for task, None for first iteration

  • nPics (int) – number of iterations for this task

Return Value

Returns

updated accumulationDataSet for task. Should be passed in next iteration.

Return type

PyPostDataSet

visualizeDGSolutions(dataSet, cc=None, order=None, dg=True)[source]

Process DG solution for visualization. This creates a linear uniform sub-cell grid (vertex-based) and interpolates the DG solution onto the new grid. DG solutions are automatically removed afterwards.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • cc (bool) – Create mesh for cell centered flow solutions.

  • order (int) – Specify order of the polynomal representation.

  • dg (bool) – DG blocks are selected by default.

vortexDetection(dataSet, gradVar=['VelocityX', 'VelocityY', 'VelocityZ'], delete=['VelocityXGradientX', 'VelocityXGradientY', 'VelocityXGradientZ', 'VelocityYGradientX', 'VelocityYGradientY', 'VelocityYGradientZ', 'VelocityZGradientX', 'VelocityZGradientY', 'VelocityZGradientZ', 'StrainRateXX', 'StrainRateXY', 'StrainRateXZ', 'StrainRateYY', 'StrainRateYZ', 'StrainRateZZ', 'StrainNorm'])[source]

Computes Vorticity, QCriterion and Lambda2 for the visualization of vortex structures. Velocity gradient and strain rate tensors are deleted by default.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters
  • gradVar (list[str]) – Specify needed gradients. By default, velocity gradient tensor is computed.

  • delete (list[str]) – Delete specified temporary variables afterwards. By default, velocity gradient and strain rate tensor are deleted.

writeAEData(dataSet, f, computeTotalAerodynamicWork=None, referenceModalEnergy=None)[source]

Write integral data of aeroelastic post processing.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • f (str) – Specify output file.

Optional Parameters

Parameters
  • computeTotalAerodynamicWork (bool) – Compute total aerodynamic work, i.e., the sum over all eigenmodes.

  • referenceModalEnergy (float) – Specify a total energy for the computation of the total aerodynamic damping and stiffness (requires ‘-computeTotalAerodynamicWork’).

writeCircFourierDecomp(dataSet, outputPath, ap=None, average=None)[source]

Write circumferential Fourier decomposition. Fourier coefficients have to be computed by ‘–calcCircFourierDecomp/-ccfd’ task in advance.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • outputPath (str) – Output path to which the output is written.

Optional Parameters

Parameters
  • ap (bool) – Write amplitude and phase for complex fields

  • average (bool) – Flag for calculating radial averages of amplitudes.

writeDataSetSummary(dataSet, filename)[source]

Write a summary of the data set, i.e. block & family metadata.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • filename (str) – Filename of data set output.

writeS1Average(dataSet, tecplotASCII)[source]

Write Averages on S1 cuts.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • tecplotASCII (str) – Write in Tecplot ASCII format to specified directory.

writeS1criteria(dataSet, outDir=None)[source]

Write radial distributions on intersection families as Tecplot scatter data.

Mandatory Parameters

Parameters

dataSet (PyPostDataSet) – input dataSet for task

Optional Parameters

Parameters

outDir (str) – Specifies relative path to output directory.

writeS2M(dataSet, name)[source]

Write s2m data from global turbomachinery analysis in specified file.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • name (str) – name of output file.

writeSolutionList(dataSet, output)[source]

Create and write list of solutions to file.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • output (str) – Name of the ASCII output file.

writeTraceBdVal(dataSet, fileName, panelFamily=None, avgType=None, bandCenterAsVertex=None, writeAllVars=None, add0D=None)[source]

Write 0D/1D boundary/interface/analysis surface values which can be read in by TRACE for entries/exits. Values have to be computed by averaging task in advance.

Mandatory Parameters

Parameters
  • dataSet (PyPostDataSet) – input dataSet for task

  • fileName (str) – Name of file to which the output is written or format string, e.g. bd_%s_%s_%s.dat (panel family name, averaging type, 0D/1D will be inserted).

Optional Parameters

Parameters
  • panelFamily (str) – Panel family for which the boundary values are written.

  • avgType (list[str]) – Specify averaging types: flux, mass, area.

  • bandCenterAsVertex (bool) – Flag to write the band centers as vertices.

  • writeAllVars (bool) – Flag to write all available (and meaningful) variables.

  • add0D (bool) – Flag to additionally write 0D data.