.. meta:: :description: The current Flow360 CFD simulation Mesh Processor and Solver input configuration parameters. Boundaries & Sliding Interfaces mesh types, non-dimensionalization. Solver Configuration ******************** The current Mesh processor and Solver input configuration parameters for Flow360 are: .. _Flow360Meshjson: Flow360Mesh.json ================ .. table:: :widths: 25 25 50 +-------------------+-------------------+---------+---------------------------------------------------------------------------------------------------------+ | Type | Options | Default | Description | +===================+===================+=========+=========================================================================================================+ | boundaries | noSlipWalls | [] | list of names of boundary patches, e.g. [2,3,7] (for .ugrid), ["blk-1/wall1","blk-2/wall2"] (for .cgns) | +-------------------+-------------------+---------+---------------------------------------------------------------------------------------------------------+ | slidingInterfaces | | [] | list of pairs of sliding interfaces | | +-------------------+---------+---------------------------------------------------------------------------------------------------------+ | | stationaryPatches | [] | list of names of stationary boundary patches, e.g. ["stationaryField/interface"] | | +-------------------+---------+---------------------------------------------------------------------------------------------------------+ | | rotatingPatches | [] | list of names of dynamic boundary patches, e.g. ["rotatingField/interface"] | | +-------------------+---------+---------------------------------------------------------------------------------------------------------+ | | axisOfRotation | [] | axis of rotation, e.g. [0,0,-1] | | +-------------------+---------+---------------------------------------------------------------------------------------------------------+ | | centerOfRotation | [] | center of rotation, e.g. [0,0,0] | +-------------------+-------------------+---------+---------------------------------------------------------------------------------------------------------+ .. warning:: "slidingInterfaces" can be only used for multi-block meshes. .. _Flow360json: Flow360.json ============== Most input quantities in case configuration file Flow360.json is dimensionless. The convention of non-dimensional input in Flow360 can be found at :ref:`Non-dimensional input `. Some commonly used variables in the table below: :math:`L_{gridUnit}` (SI unit = :math:`m`) physical length represented by unit length in the given mesh file, e.g. if your grid is in feet, :math:`L_{gridUnit}=1 \text{ feet}=0.3048 \text{ meter}`; if your grid is in millimeter, :math:`L_{gridUnit}=1 \text{ millimeter}=0.001 \text{ meter}`. :math:`C_\infty` (SI unit = :math:`m/s`) speed of sound of freestream :math:`\rho_\infty` (SI unit = :math:`kg/m^3`) density of freestream :math:`\mu_\infty` (SI unit = :math:`N \cdot s/m^2`) dynamic viscosity of freestream :math:`p_\infty` (SI unit = :math:`N/m^2`) static pressure of freestream :math:`U_\text{ref} \triangleq \text{MachRef}\times C_\infty` (SI unit = :math:`m/s`) reference velocity .. _geometryConfiguration: geometry -------- .. table:: :widths: 25 25 50 +--------------+-----------------+---------------------------------------------------------+ | Options | Default | Description | +==============+=================+=========================================================+ | refArea | 1 | The reference area of the geometry | +--------------+-----------------+---------------------------------------------------------+ | momentCenter | [0.0, 0.0, 0.0] | The x, y, z moment center of the geometry in grid units | +--------------+-----------------+---------------------------------------------------------+ | momentLength | [1.0, 1.0, 1.0] | The x, y, z moment reference lengths | +--------------+-----------------+---------------------------------------------------------+ .. _solverConfiguration-freestream: freestream ---------- .. csv-table:: :file: Tables/freestreamTable.csv :widths: 20, 20, 70 :header-rows: 1 :delim: @ According to Flow360's definitions of the angle of attack :math:`\alpha` and the sideslip angle :math:`\beta`, as given in the above table, with respect to the grid coordinates, the following values of velocity components are imposed at a “Freestream” farfield boundary as defined in the next subsection. .. math:: :label: EQ_FreestreamBC U^*_{\infty} &= M_{\infty} \cdot cos(\beta) \cdot cos(\alpha) \\ V^*_{\infty} &= - M_{\infty} \cdot sin(\beta) \\ W^*_{\infty} &= M_{\infty} \cdot cos(\beta) \cdot sin(\alpha) Where, the velocity components are non-dimensionalized by the freestream speed of sound :math:`C_{\infty}`. Also, the effects of these two angles are intrinsically taken into account by the solver in the computed :math:`C_l` and :math:`C_d` values, etc. .. _boundariesParameters: boundaries ---------- .. table:: :class: bounadriestable +-------------------------+----------------------------------------------------------------------------+----------------------------------------------------------------------------------+ | Type | Format | Description | +=========================+============================================================================+==================================================================================+ | SlipWall | .. code-block:: json | Slip wall condition. Also used for symmetry. | | | | | | | "boundary_name" : | | | | { | | | | "type" : "SlipWall" | | | | } | | +-------------------------+----------------------------------------------------------------------------+----------------------------------------------------------------------------------+ | NoSlipWall | .. code-block:: json | Sets no-slip wall condition. Optionally, a tangential velocity can be prescribed | | | | on the wall using the keyword "Velocity". An example: :ref:`sample ` | | | "boundary_name" : | | | | { | | | | "type" : "NoSlipWall", | | | | "Velocity": (default: [0, 0, 0]) [ | | | | float or "expression", | | | | float or "expression", | | | | float or "expression"] | | | | } | | +-------------------------+----------------------------------------------------------------------------+----------------------------------------------------------------------------------+ | IsothermalWall | .. code-block:: json | Isothermal wall boundary condition. "Temperature" is specified in Kelvin. | | | | Optionally a tangential velocity can be presribed on the wall using the keyword | | | "boundary_name" : | "Velocity". | | | { | | | | "type" : "IsothermalWall", | | | | "Temperature": | | | | float or "expression" (REQUIRED), | | | | "Velocity": (default: [0, 0, 0]) [ | | | | float or "expression", | | | | float or "expression", | | | | float or "expression"] | | | | } | | +-------------------------+----------------------------------------------------------------------------+----------------------------------------------------------------------------------+ | Freestream | .. code-block:: json | External freestream condition. Optionally, an expression for each of the velocity| | | | components can be specified using the keyword "Velocity". | | | "boundary_name" : | | | | { | | | | "type" : "Freestream", | | | | "Velocity": (default: freestream) [ | | | | float or "expression", | | | | float or "expression", | | | | float or "expression"] | | | | } | | +-------------------------+----------------------------------------------------------------------------+----------------------------------------------------------------------------------+ | SubsonicOutflowPressure | .. code-block:: json | Subsonic outflow, enforced through static pressure ratio. | | | | | | | "boundary_name" : | | | | { | | | | "type" : "SubsonicOutflowPressure", | | | | "staticPressureRatio" : float | | | | } | | +-------------------------+----------------------------------------------------------------------------+----------------------------------------------------------------------------------+ | SubsonicOutflowMach | .. code-block:: json | Static pressure outflow boundary condition set via a specified subsonic Mach | | | | number. | | | "boundary_name" : | | | | { | | | | "type" : "SubsonicOutflowMach", | | | | "MachNumber" : float | | | | } | | +-------------------------+----------------------------------------------------------------------------+----------------------------------------------------------------------------------+ | SubsonicInflow | .. code-block:: json | Subsonic inflow (enforced via total pressure ratio and total temperature ratio) | | | | for nozzle or tunnel plenum. | | | "boundary_name" : | | | | { | | | | "type" : "SubsonicInflow", | | | | "totalPressureRatio" : float, | | | | "totalTemperatureRatio" : float, | | | | "rampSteps" : Integer | | | | } | | +-------------------------+----------------------------------------------------------------------------+----------------------------------------------------------------------------------+ | MassOutflow | .. code-block:: json | Specification of massflow out of the control volume. | | | | | | | "boundary_name" : | | | | { | | | | "type" : "MassOutflow", | | | | "massFlowRate" : float | | | | } | | +-------------------------+----------------------------------------------------------------------------+----------------------------------------------------------------------------------+ | MassInflow | .. code-block:: json | Specification of massflow into the control volume. | | | | | | | "boundary_name" : | | | | { | | | | "type" : "MassInflow", | | | | "massFlowRate" : float | | | | } | | +-------------------------+----------------------------------------------------------------------------+----------------------------------------------------------------------------------+ | SlidingInterface | .. code-block:: json | Sliding interface condition. Details of each sliding interface need to be | | | | prescribed in a seperate section: | | | "boundary_name" : | :ref:`slidingInterfaces ` | | | { | | | | "type" : "SlidingInterface" | | | | } | | +-------------------------+----------------------------------------------------------------------------+----------------------------------------------------------------------------------+ | WallFunction | .. code-block:: json | This boundary type uses wall functions to estimate the velocity field close | | | | to the solid boundaries. | | (`beta feature`) | "boundary_name" : | | | | { | | | | "type" : "WallFunction" | | | | } | | +-------------------------+----------------------------------------------------------------------------+----------------------------------------------------------------------------------+ .. note:: Note: "expression" is an expression with "x", "y", "z" as independent variables. An example of NoSlipWall boundary with prescribed velocity is :ref:`NoSlipWall with velocity `. .. _postProcessingParameters: Output -------------- Universal non-dimensional variables suppoprted by all types of output : [note]_ .. _UniversalVariables: .. table:: :widths: 25 50 +-----------------------+-----------------------------------------------------------------------------------------------+ | Name | Description | +=======================+===============================================================================================+ | Cp | Coefficient of pressure. :math:`C_p=(\frac{p-p_\infty}{\frac{1}{2}\rho_\infty{U_{ref}}^2})`. | +-----------------------+-----------------------------------------------------------------------------------------------+ | gradW | Gradient of W | +-----------------------+-----------------------------------------------------------------------------------------------+ | kOmega | k and omega when using kOmegaSST model | +-----------------------+-----------------------------------------------------------------------------------------------+ | Mach | Mach number | +-----------------------+-----------------------------------------------------------------------------------------------+ | mut | Turbulent viscosity | +-----------------------+-----------------------------------------------------------------------------------------------+ | mutRatio | :math:`\mu_t/{\mu_\infty}` | +-----------------------+-----------------------------------------------------------------------------------------------+ | nuHat | nuHat | +-----------------------+-----------------------------------------------------------------------------------------------+ | primitiveVars | Outputs rho, u, v, w, p | +-----------------------+-----------------------------------------------------------------------------------------------+ | qcriterion | Q criterion | +-----------------------+-----------------------------------------------------------------------------------------------+ | residualComponentsSA | Residual for the turbulence model | +-----------------------+-----------------------------------------------------------------------------------------------+ | residualNavierStokes | 5 components of the N-S residual | +-----------------------+-----------------------------------------------------------------------------------------------+ | residualTransition | Residual for the transition model | +-----------------------+-----------------------------------------------------------------------------------------------+ | residualTurbulence | Residual for the turbulence model | +-----------------------+-----------------------------------------------------------------------------------------------+ | s | Entropy | +-----------------------+-----------------------------------------------------------------------------------------------+ | solutionNavierStokes | Solution for the N-S equation in conservative form | +-----------------------+-----------------------------------------------------------------------------------------------+ | solutionTransition | Solution for the transition model | +-----------------------+-----------------------------------------------------------------------------------------------+ | solutionTurbulence | Solution for the turbulence model | +-----------------------+-----------------------------------------------------------------------------------------------+ | T | Temperature | +-----------------------+-----------------------------------------------------------------------------------------------+ | vorticity | Vorticity | +-----------------------+-----------------------------------------------------------------------------------------------+ | wallDistance | wall distance | +-----------------------+-----------------------------------------------------------------------------------------------+ Additional non-dimensional variables suppoprted by :ref:`volumeOutput` and :ref:`sliceOutput`: .. _VolumeAndSliceSpecificVariables: .. table:: :widths: 25 50 +-----------------------+-----------------------------------------------------------------------------------------------+ | Name | Description | +=======================+===============================================================================================+ | betMetrics | VelocityRelative, AlphaRadians, CfAxial, CfCircumferential, TipLossFactor, | | | LocalSolidityIntegralWeight for all BETDisks with possible overlapping. | +-----------------------+-----------------------------------------------------------------------------------------------+ | betMetricsPerDisk | Same as above but each BETdisk has its own :code:`betMetrics` so overlapping is avoided. | +-----------------------+-----------------------------------------------------------------------------------------------+ | kOmegaSST_DDES | Outputs :code:`DDES_fd` (1 in the LES region, and 0 elsewhere), :code:`DDES_lengthRANS` (RANS | | | length scale), and :code:`DDES_lengthLES` (LES length scale) | +-----------------------+-----------------------------------------------------------------------------------------------+ Additional non-dimensional variables suppoprted by :ref:`surfaceOutput`: .. _SurfaceSpecificVariables: .. table:: :widths: 25 50 +-----------------------+-----------------------------------------------------------------------------------------------+ | Name | Description | +=======================+===============================================================================================+ | CfVec | Viscous stress coefficient vector. For example, | | | :math:`C_{f_{Vec}}[3]=\frac{\tau_{wall}[3]}{\frac{1}{2}\rho_\infty U_{ref}^2}`. | | | The :math:`\tau_{wall}` is the vector of viscous stress on the wall. | +-----------------------+-----------------------------------------------------------------------------------------------+ | Cf | Magnitude of :code:`CfVec`. | +-----------------------+-----------------------------------------------------------------------------------------------+ | CfNormal | Magnitude of :code:`CfVec` normal to the wall. | +-----------------------+-----------------------------------------------------------------------------------------------+ | CfTangent | Magnitude of :code:`CfVec` tangential to the wall. | +-----------------------+-----------------------------------------------------------------------------------------------+ | heatFlux | Heat Flux. | +-----------------------+-----------------------------------------------------------------------------------------------+ | nodeNormals | Wall normal direction (may not be a unit vector). | | | Note: This variable does not support time average. | +-----------------------+-----------------------------------------------------------------------------------------------+ | nodeForcesPerUnitArea | :math:`\frac{\tau_{wall}[3]-(p-p_\infty)*normal[3]}{\rho_\infty C_\infty^2}`, | | | where the :math:`normal[3]` is the unit normal vector pointing from solid to fluid. | +-----------------------+-----------------------------------------------------------------------------------------------+ | VelocityRelative | Velocity in rotating frame. | +-----------------------+-----------------------------------------------------------------------------------------------+ | yPlus | :math:`y^+`. | +-----------------------+-----------------------------------------------------------------------------------------------+ | wallFunctionMetric | (`beta feature`) : This metric is a local indicator for quality of the wall model. | | | A value less than 1.25 shows good estimation of wall shear stress. Between 1.25 and 10 is a | | | region of less validity, and values greater than 10 are not reliable for wall shear stress | | | estimation. | +-----------------------+-----------------------------------------------------------------------------------------------+ .. _volumeOutputInputParameters: volumeOutput ^^^^^^^^^^^^ .. csv-table:: :file: Tables/volumeOutputTable.csv :widths: 25 10 65 :header-rows: 1 :delim: @ .. _surfaceOutputInputParameters: surfaceOutput ^^^^^^^^^^^^^ .. csv-table:: :file: Tables/surfaceOutputTable.csv :widths: 25 10 65 :header-rows: 1 :delim: @ An example surfaceOutput configuration is shown below. .. literalinclude:: Files/surfaceExample.json :linenos: .. _sliceOutputInputParameters: sliceOutput ^^^^^^^^^^^ .. csv-table:: :file: Tables/sliceOutputTable.csv :widths: 25 10 65 :header-rows: 1 :delim: @ An example sliceOutput configuration is shown below. .. literalinclude:: Files/sliceExample.json :linenos: .. _monitorOutputInputParameters: monitorOutput ^^^^^^^^^^^^^ .. csv-table:: :file: Tables/monitorOutputTable.csv :widths: 25 10 65 :header-rows: 1 :delim: @ An example monitor configuration is shown below. In the example a monitor group with name :code:`Group1` is created which contains two monitor points with coordinates :code:`(0.12, 0.34, 0.262)` and :code:`(0.3124, 0.01, 0.03)` respectively. Note: Please increase precision of the input coordinates when probing near the boundaries of volume grid (for example noSlipWalls) as the actual point may be out of grid volume when precision is insufficient. .. literalinclude:: Files/monitorExample.json :linenos: .. _isoSurfaceOutputInputParameters: isoSurfaceOutput ^^^^^^^^^^^^^^^^ .. csv-table:: :file: Tables/isoSurfaceOutputTable.csv :widths: 25 10 65 :header-rows: 1 :delim: @ An example isoSurface configuration is shown below, in which the pressure, :code:`p`, and :code:`Mach` number are evaluated on an iso-surface of :code:`qcriterion` with an iso-surface magnitude of 1e-3. .. literalinclude:: Files/isoSurfaceConfigExample.json :linenos: .. _navierStokesSolverParameters: navierStokesSolver ------------------ .. table:: :widths: 25 10 65 +--------------------------------+----------+-----------------------------------------------------------------------------------------------------------------------------------------------------+ | Options | Default | Description | +================================+==========+=====================================================================================================================================================+ | absoluteTolerance | 1.00E-10 | Tolerance for the NS residual, below which the solver goes to the next physical step | +--------------------------------+----------+-----------------------------------------------------------------------------------------------------------------------------------------------------+ | relativeTolerance | 0 | Tolerance to the relative residual, below which the solver goes to the next physical step. Relative residual is defined as the ratio of the current | | | | pseudoStep's residual to the maximum residual present in the first 10 pseudoSteps within the current physicalStep. | | | | **NOTE**: relativeTolerance is ignored in steady simulations and only absoluteTolerance is used as the convergence criterion | +--------------------------------+----------+-----------------------------------------------------------------------------------------------------------------------------------------------------+ | CFLMultiplier | 1 | factor to the CFL definitions defined in "timeStepping" section | +--------------------------------+----------+-----------------------------------------------------------------------------------------------------------------------------------------------------+ | linearIterations | 30 | Number of linear solver iterations | +--------------------------------+----------+-----------------------------------------------------------------------------------------------------------------------------------------------------+ | kappaMUSCL | -1 | Kappa for the MUSCL scheme, range from [-1, 1], with 1 being unstable. The default value of -1 leads to a 2nd order upwind scheme and is the most | | | | stable. A value of 0.33 leads to a blended upwind/central scheme and is recommended for low subsonic flows leading to reduced dissipation | +--------------------------------+----------+-----------------------------------------------------------------------------------------------------------------------------------------------------+ | updateJacobianFrequency | 4 | Frequency at which the jacobian is updated. | +--------------------------------+----------+-----------------------------------------------------------------------------------------------------------------------------------------------------+ | equationEvalFrequency | 1 | Frequency at which to update the NS equation in loosely-coupled simulations | +--------------------------------+----------+-----------------------------------------------------------------------------------------------------------------------------------------------------+ | maxForceJacUpdatePhysicalSteps | 0 | when which physical steps, the jacobian matrix is updated every pseudo step | +--------------------------------+----------+-----------------------------------------------------------------------------------------------------------------------------------------------------+ | orderOfAccuracy | 2 | order of accuracy in space | +--------------------------------+----------+-----------------------------------------------------------------------------------------------------------------------------------------------------+ | limitVelocity | FALSE | limiter for velocity | +--------------------------------+----------+-----------------------------------------------------------------------------------------------------------------------------------------------------+ | limitPressureDensity | FALSE | limiter for pressure and density | +--------------------------------+----------+-----------------------------------------------------------------------------------------------------------------------------------------------------+ .. _turbulenceModelSolverParameters: turbulenceModelSolver --------------------- .. table:: :widths: 25 15 60 +--------------------------------+-----------------+-------------------------------------------------------------------------------------------------------------------------------------------+ | Options | Default | Description | +================================+=================+===========================================================================================================================================+ | modelType | SpalartAllmaras | Turbulence model type can be: "SpalartAllmaras" or "kOmegaSST" | +--------------------------------+-----------------+-------------------------------------------------------------------------------------------------------------------------------------------+ | absoluteTolerance | 1.00E-08 | Tolerance for the turbulence model residual, below which the solver goes to the next physical step | +--------------------------------+-----------------+-------------------------------------------------------------------------------------------------------------------------------------------+ | relativeTolerance | 0 | Tolerance to the relative residual, below which the solver goes to the next physical step. Relative residual is defined as the ratio of | | | | the current pseudoStep's residual to the maximum residual present in the first 10 pseudoSteps within the current physicalStep. | | | | **NOTE**: relativeTolerance is ignored in steady simulations and only absoluteTolerance is used as the convergence criterion | +--------------------------------+-----------------+-------------------------------------------------------------------------------------------------------------------------------------------+ | linearIterations | 20 | Number of linear iterations for the turbulence moddel linear system | +--------------------------------+-----------------+-------------------------------------------------------------------------------------------------------------------------------------------+ | updateJacobianFrequency | 4 | Frequency at which to update the Jacobian | +--------------------------------+-----------------+-------------------------------------------------------------------------------------------------------------------------------------------+ | equationEvalFrequency | 4 | Frequency at which to evaluate the turbulence equation in loosely-coupled simulations | +--------------------------------+-----------------+-------------------------------------------------------------------------------------------------------------------------------------------+ | reconstructionGradientLimiter | 1.0 | The strength of gradient limiter used in reconstruction of solution variables at the faces (specified in the range [0.0, 2.0]). | | | | 0.0 corresponds to setting the gradient equal to zero, and 2.0 means no limiting. | +--------------------------------+-----------------+-------------------------------------------------------------------------------------------------------------------------------------------+ | rotationCorrection | FALSE | Rotation correction for the turbulence model. Only support for SpalartAllmaras | +--------------------------------+-----------------+-------------------------------------------------------------------------------------------------------------------------------------------+ | quadraticConstitutiveRelation | FALSE | Use quadratic constitutive relation for turbulence shear stress tensor instead of Boussinesq Approximation | +--------------------------------+-----------------+-------------------------------------------------------------------------------------------------------------------------------------------+ | orderOfAccuracy | 2 | Order of accuracy in space | +--------------------------------+-----------------+-------------------------------------------------------------------------------------------------------------------------------------------+ | maxForceJacUpdatePhysicalSteps | 0 | When which physical steps, the jacobian matrix is updated every pseudo step | +--------------------------------+-----------------+-------------------------------------------------------------------------------------------------------------------------------------------+ | DDES | FALSE | "true" enables Delayed Detached Eddy Simulation. Supported for both SpalartAllmaras and kOmegaSST turbulence models, | | | | with and without AmplificationFactorTransport transition model enabled | +--------------------------------+-----------------+-------------------------------------------------------------------------------------------------------------------------------------------+ | gridSizeForLES | "maxEdgeLength" | Specifes the length used for the computation of LES length scale. The allowed inputs are :code:`"maxEdgeLength"` (default) and | | | | :code:`"meanEdgeLength"` | +--------------------------------+-----------------+-------------------------------------------------------------------------------------------------------------------------------------------+ | modelConstants | {} | | Here, user can change the default values used for DDES coefficients in the solver: | | | | | **SpalartAllmaras**: :code:`"C_DES"` (= 0.72), :code:`"C_d"` (= 8.0) | | | | | **kOmegaSST**: :code:`"C_DES1"` (= 0.78), :code:`"C_DES2"` (= 0.61), :code:`"C_d1"` (= 20.0), :code:`"C_d2"` (= 3.0) | | | | | *(values shown in the parentheses are the default values used in Flow360)* | | | | | An example with kOmegaSST mode would be: | | | | | | | | .. code-block:: JSON | | | | | | | | "modelConstants" : { | | | | "C_DES1": 0.85, | | | | "C_d1": 8.0 | | | | } | +--------------------------------+-----------------+-------------------------------------------------------------------------------------------------------------------------------------------+ .. _transitionModelSolverParameters: transitionModelSolver --------------------- The laminar to turbulence transition model supported by Flow360 is the 2019b version of the Amplification Factor Transport Model created by James Coder, University of Tennessee. This models adds two additional equations to the flow solver in order to solve for the amplification factor and intermittency flow quantities. More details about the model can be found at: https://turbmodels.larc.nasa.gov/aft_transition_3eqn.html. Below are a list of configuration parameters for the transition model. Either Ncrit or turbulenceIntensityPercent can be used to tune the location of transition from laminar to turbulent flow. .. table:: :widths: 25 15 60 +--------------------------------+------------------------------+------------------------------------------------------------------------------------------------------------------------------+ | Options | Default | Description | +================================+==============================+==============================================================================================================================+ | modelType | None | Transition model type can either be: "None" (disabled) or "AmplificationFactorTransport" (enabled) | +--------------------------------+------------------------------+------------------------------------------------------------------------------------------------------------------------------+ | absoluteTolerance | 1.00E-07 | Tolerance for the transition model residual, below which the solver goes to the next physical step | +--------------------------------+------------------------------+------------------------------------------------------------------------------------------------------------------------------+ | relativeTolerance | 0 | Tolerance to the relative residual, below which the solver goes to the next physical step. Relative residual is defined as | | | | the ratio of the current pseudoStep's residual to the maximum residual present in the first 10 pseudoSteps within the current| | | | physicalStep. | | | | **NOTE**: relativeTolerance is ignored in steady simulations and only absoluteTolerance is used as the convergence criterion | +--------------------------------+------------------------------+------------------------------------------------------------------------------------------------------------------------------+ | linearIterations | 20 | Number of linear iterations for the transition model linear system | +--------------------------------+------------------------------+------------------------------------------------------------------------------------------------------------------------------+ | updateJacobianFrequency | 4 | Frequency at which to update the Jacobian | +--------------------------------+------------------------------+------------------------------------------------------------------------------------------------------------------------------+ | equationEvalFrequency | 4 | Frequency at which to evaluate the turbulence equation in loosely-coupled simulations | +--------------------------------+------------------------------+------------------------------------------------------------------------------------------------------------------------------+ | orderOfAccuracy | 2 | Order of accuracy in space | +--------------------------------+------------------------------+------------------------------------------------------------------------------------------------------------------------------+ | turbulenceIntensityPercent | 0.1 | Used to compute Ncrit parameter for AFT transition model. Range: 0.03 - 2.5. Higher values result in earlier transition | +--------------------------------+------------------------------+------------------------------------------------------------------------------------------------------------------------------+ | Ncrit | 8.15 | Scalar parameter for transition model. Range: 1-11. Higher values delays onset of laminar-turbulent transition. | | | | Only one of "Ncrit" or turbulenceIntensityPercent" can be specified in this section | +--------------------------------+------------------------------+------------------------------------------------------------------------------------------------------------------------------+ | maxForceJacUpdatePhysicalSteps | 0 | When which physical steps, the jacobian matrix is updated every pseudo step | +--------------------------------+------------------------------+------------------------------------------------------------------------------------------------------------------------------+ initialCondition ---------------- .. table:: :widths: 25 15 60 +---------+--------------+---------------------------------------------------------------------------------+ | Options | Default | Description | +=========+==============+=================================================================================+ | type | "freestream" | Use the flow conditions defined in freestream section to set initial condition. | | | | Could be "freestream" or an "expression" | +---------+--------------+---------------------------------------------------------------------------------+ .. _timeSteppingParameters: timeStepping ------------ .. _table_timeStepping: .. csv-table:: :file: Tables/timeSteppingTable.csv :widths: 25 10 65 :header-rows: 1 :delim: @ .. note:: The :code:`timeStepSize` is in solver units (non-dimensional), where time-scale is mesh unit divided by freestream speed of sound. So a time of :code:`timeStepSize=1` means the time it takes for sound to travel 1 mesh unit at freestream. .. _slidingInterfacesParameters: slidingInterfaces (list) ------------------------ .. table:: :widths: 25 10 65 +-------------------+---------+-----------------------------------------------------------------------------------------------+ | Options | Default | Description | +===================+=========+===============================================================================================+ | interfaceName | Empty | name of slidingInterface | +-------------------+---------+-----------------------------------------------------------------------------------------------+ | stationaryPatches | Empty | a list of static patch names of an interface | +-------------------+---------+-----------------------------------------------------------------------------------------------+ | rotatingPatches | Empty | a list of dynamic patch names of an interface | +-------------------+---------+-----------------------------------------------------------------------------------------------+ | thetaRadians | Empty | expression for rotation angle (in radians) as a function of time | +-------------------+---------+-----------------------------------------------------------------------------------------------+ | thetaDegrees | Empty | expression for rotation angle (in degrees) as a function of time | +-------------------+---------+-----------------------------------------------------------------------------------------------+ | omegaRadians | Empty | non-dimensional rotating speed, radians/nondim-unit-time, = | | | | :math:`\Omega*L_{gridUnit}/C_\infty`, where the SI unit of :math:`\Omega` is rad/s. | +-------------------+---------+-----------------------------------------------------------------------------------------------+ | omegaDegrees | Empty | non-dimensional rotating speed, degrees/nondim-unit-time, = :math:`\text{omegaRadians}*180/PI`| +-------------------+---------+-----------------------------------------------------------------------------------------------+ | centerOfRotation | Empty | a 3D array, representing the origin of rotation, e.g. [0,0,0] | +-------------------+---------+-----------------------------------------------------------------------------------------------+ | axisOfRotation | Empty | a 3D array, representing the rotation axis, e.g. [0,0,1] | +-------------------+---------+-----------------------------------------------------------------------------------------------+ | volumeName | Empty | a list of dynamic volume zones related to the above {omega, centerOfRotation, axisOfRotation} | +-------------------+---------+-----------------------------------------------------------------------------------------------+ | parentVolumeName | Empty | name of the volume zone that the rotating reference frame is contained in, | | | | used to compute the acceleration in the nested rotating reference frame | +-------------------+---------+-----------------------------------------------------------------------------------------------+ | isDynamic | FALSE | whether rotation of this interface is dictated by userDefinedDynamics | +-------------------+---------+-----------------------------------------------------------------------------------------------+ .. _actuatorDisksParameters: actuatorDisks (list) -------------------- .. csv-table:: :file: Tables/actuatorDiskTable.csv :widths: 20, 10, 70 :header-rows: 1 :delim: @ .. _betDisksInputParameters: BETDisks (list) -------------------- An introduction of blade element theory model in Flow360 is available at :ref:`BET solver `. A case study of the XV-15 rotor based on steady blade element disk model is available at :ref:`BET case study `. .. csv-table:: :file: Tables/betTable.csv :widths: 20, 10, 70 :header-rows: 1 :delim: @ .. _porousMediaParameters: porousMedia (list) -------------------- The porous media model supported by Flow360 is the Darcy-Forchheimer model which has two coefficients: Darcy coefficient for viscous losses and Forchheimer coefficient for inertial losses. The model acts by adding a sink term to the momentum equations. More details about the model can be found at https://openfoamwiki.net/index.php/DarcyForchheimer. Below are a list of configuration parameters for the porous media model. .. csv-table:: :file: Tables/porousTable.csv :widths: 30, 15, 70 :header-rows: 1 :delim: @ .. _examples_Flow360json: .. _userDefinedDynamicsParameters: userDefinedDynamics -------------------- An example of how to use the userDefinedDynamics is available :ref:`here `. .. csv-table:: :file: Tables/userDefinedDynamicsTable.csv :widths: 20, 10, 70 :header-rows: 1 :delim: @ Examples of Flow360.json ======================== .. _wall_vel: 1. a NoSlipWall boundary with a prescribed velocity .. literalinclude:: Files/noSlipWall_velocity.json :linenos: .. _actuatorDisks_negativeCircumForce: 2. an actuator disk modelling of left-hand-rotation rotor in quiescent flow: .. grid:: 2 .. grid-item:: :columns: 6 :margin: auto .. code-block:: JSON "actuatorDisks":[ { ... "axisThrust":[0,0,1], "forcePerArea":[ "radius":[0.01, 0.05, 0.1], "thrust":[0.001, 0.02, 0], "circumferential":[-0.0001, -0.003, 0] ] } ] .. grid-item:: :columns: 6 :margin: auto .. figure:: Files/leftHand_thrust_z+.svg :width: 80% :align: center .. _actuatorDisks_positiveCircumForce: 3. an actuator disk modelling of right-hand-rotation rotor in quiescent flow: .. grid:: 2 .. grid-item:: :columns: 6 :margin: auto .. code-block:: JSON "actuatorDisks":[ { ... "axisThrust":[0,0,-1], "forcePerArea":[ "radius":[0.01, 0.05, 0.1], "thrust":[0.001, 0.02, 0], "circumferential":[0.0001, 0.003, 0] ] } ] .. grid-item:: :columns: 6 :margin: auto .. figure:: Files/rightHand_thrust_z-.svg :width: 80% :align: center .. [note] Since release-23.1.1.0, `previous syntax `_ to specify output variables is being deprecated and not all variables are supported. Users are encouraged to use the new syntax as described in :ref:`this documentation `.