flow360.Flow360Params

Contents

flow360.Flow360Params#

pydantic model Flow360Params[source]#

Flow360 solver parameters

Parameters:

unit_system (Union[SIUnitSystem, CGSUnitSystem, ImperialUnitSystem, Flow360UnitSystem, UnitSystem]) – version : str = 24.2.0 geometry : Optional[Geometry] = Geometry(ref_area=None, moment_center=None, moment_length=None, mesh_unit=None, _type=’Geometry’) fluid_properties : Union[AirDensityTemperature, AirPressureTemperature, NoneType] = None boundaries : Boundaries initial_condition : Union[FreestreamInitialCondition, ExpressionInitialCondition, NoneType] = None time_stepping : Union[SteadyTimeStepping, UnsteadyTimeStepping, NoneType] = SteadyTimeStepping(max_pseudo_steps=2000, order_of_accuracy=2, CFL=AdaptiveCFL(type=’adaptive’,, min=0.1,, max=10000.0,, max_relative_change=1.0,, convergence_limiting_factor=0.25,, _type=’AdaptiveCFL’), _type=’SteadyTimeStepping’, model_type=’Steady’, physical_steps=1, time_step_size=’inf’) turbulence_model_solver : Union[NoneSolver, SpalartAllmaras, KOmegaSST, NoneType] = None transition_model_solver : Optional[TransitionModelSolver] = None heat_equation_solver : Optional[HeatEquationSolver] = None freestream : Union[FreestreamFromMach, FreestreamFromMachReynolds, FreestreamFromVelocity, ZeroFreestream, ZeroFreestreamFromVelocity] bet_disks : Optional[List[BETDisk]] = None actuator_disks : Optional[List[ActuatorDisk]] = None porous_media : Optional[List[PorousMediumBox]] = None user_defined_dynamics : Optional[List[UserDefinedDynamic]] = None surface_output : Optional[SurfaceOutput] = SurfaceOutput(output_format=’paraview’, animation_frequency=-1, animation_frequency_offset=0, compute_time_averages=False, animation_frequency_time_average=-1, animation_frequency_time_average_offset=0, start_average_integration_step=-1, write_single_file=False, output_fields=[], surfaces=None, _type=’SurfaceOutput’) volume_output : Optional[VolumeOutput] = None slice_output : Optional[SliceOutput] = None iso_surface_output : Optional[IsoSurfaceOutput] = None monitor_output : Optional[MonitorOutput] = None volume_zones : Optional[VolumeZones] = None aeroacoustic_output : Optional[AeroacousticOutput] = None navier_stokes_solver : Union[NavierStokesSolver, IncompressibleNavierStokesSolver, NoneType] = None

Fields:
  • actuator_disks (List[flow360.component.flow360_params.flow360_params.ActuatorDisk] | None)

  • aeroacoustic_output (flow360.component.flow360_params.flow360_output.AeroacousticOutput | None)

  • bet_disks (List[flow360.component.flow360_params.flow360_params.BETDisk] | None)

  • boundaries (flow360.component.flow360_params.flow360_params.Boundaries)

  • fluid_properties (flow360.component.flow360_params.flow360_params.AirDensityTemperature | flow360.component.flow360_params.flow360_params.AirPressureTemperature | None)

  • freestream (flow360.component.flow360_params.flow360_params.FreestreamFromMach | flow360.component.flow360_params.flow360_params.FreestreamFromMachReynolds | flow360.component.flow360_params.flow360_params.FreestreamFromVelocity | flow360.component.flow360_params.flow360_params.ZeroFreestream | flow360.component.flow360_params.flow360_params.ZeroFreestreamFromVelocity)

  • geometry (flow360.component.flow360_params.flow360_params.Geometry | None)

  • heat_equation_solver (flow360.component.flow360_params.solvers.HeatEquationSolver | None)

  • initial_condition (flow360.component.flow360_params.initial_condition.FreestreamInitialCondition | flow360.component.flow360_params.initial_condition.ExpressionInitialCondition | None)

  • iso_surface_output (flow360.component.flow360_params.flow360_output.IsoSurfaceOutput | None)

  • monitor_output (flow360.component.flow360_params.flow360_output.MonitorOutput | None)

  • navier_stokes_solver (flow360.component.flow360_params.solvers.NavierStokesSolver | flow360.component.flow360_params.solvers.IncompressibleNavierStokesSolver | None)

  • porous_media (List[flow360.component.flow360_params.flow360_params.PorousMediumBox] | None)

  • slice_output (flow360.component.flow360_params.flow360_output.SliceOutput | None)

  • surface_output (flow360.component.flow360_params.flow360_output.SurfaceOutput | None)

  • time_stepping (flow360.component.flow360_params.time_stepping.SteadyTimeStepping | flow360.component.flow360_params.time_stepping.UnsteadyTimeStepping | None)

  • transition_model_solver (flow360.component.flow360_params.solvers.TransitionModelSolver | None)

  • turbulence_model_solver (flow360.component.flow360_params.solvers.NoneSolver | flow360.component.flow360_params.solvers.SpalartAllmaras | flow360.component.flow360_params.solvers.KOmegaSST | None)

  • unit_system (flow360.component.flow360_params.unit_system.SIUnitSystem | flow360.component.flow360_params.unit_system.CGSUnitSystem | flow360.component.flow360_params.unit_system.ImperialUnitSystem | flow360.component.flow360_params.unit_system.Flow360UnitSystem | flow360.component.flow360_params.unit_system.UnitSystem)

  • user_defined_dynamics (List[flow360.component.flow360_params.flow360_params.UserDefinedDynamic] | None)

  • version (str)

  • volume_output (flow360.component.flow360_params.flow360_output.VolumeOutput | None)

  • volume_zones (flow360.component.flow360_params.flow360_params.VolumeZones | None)

field unit_system [Required] (alias 'unitSystem')#
field version = '24.2.0'#
field geometry = Geometry(ref_area=None, moment_center=None, moment_length=None, mesh_unit=None, _type='Geometry')#
Constraints:
  • title = Geometry

  • description = :class: Geometry component Parameters ———- ref_area : Optional[_Constrained] = None moment_center : Optional[_VectorType] = None moment_length : Optional[_VectorType] = None mesh_unit : Optional[_Constrained] = None

  • type = object

  • properties = {‘refArea’: {‘title’: ‘Refarea’, ‘displayed’: ‘Reference area’, ‘properties’: {‘value’: {‘type’: ‘number’, ‘exclusiveMinimum’: 0}, ‘units’: {‘type’: ‘string’, ‘dimension’: ‘area’, ‘enum’: [‘m**2’, ‘cm**2’, ‘ft**2’, ‘flow360_area_unit’]}}}, ‘momentCenter’: {‘title’: ‘Momentcenter’, ‘properties’: {‘value’: {‘type’: ‘array’, ‘items’: {‘type’: ‘number’}, ‘minItems’: 3, ‘maxItems’: 3, ‘strictType’: {‘type’: ‘vector3’}}, ‘units’: {‘type’: ‘string’, ‘dimension’: ‘length’, ‘enum’: [‘m’, ‘cm’, ‘ft’, ‘flow360_length_unit’, ‘mm’, ‘inch’]}}}, ‘momentLength’: {‘title’: ‘Momentlength’, ‘properties’: {‘value’: {‘type’: ‘array’, ‘items’: {‘type’: ‘number’}, ‘minItems’: 3, ‘maxItems’: 3, ‘strictType’: {‘type’: ‘vector3’}}, ‘units’: {‘type’: ‘string’, ‘dimension’: ‘length’, ‘enum’: [‘m’, ‘cm’, ‘ft’, ‘flow360_length_unit’, ‘mm’, ‘inch’]}}}, ‘meshUnit’: {‘title’: ‘Meshunit’, ‘properties’: {‘value’: {‘type’: ‘number’, ‘exclusiveMinimum’: 0}, ‘units’: {‘type’: ‘string’, ‘dimension’: ‘length’, ‘enum’: [‘m’, ‘cm’, ‘ft’, ‘flow360_length_unit’, ‘mm’, ‘inch’]}}}, ‘_type’: {‘title’: ‘ Type’, ‘default’: ‘Geometry’, ‘enum’: [‘Geometry’], ‘type’: ‘string’}}

  • additionalProperties = False

field fluid_properties = None (alias 'fluidProperties')#
field boundaries [Required]#
Constraints:
  • title = Boundaries

  • description = Boundaries class for setting up Boundaries Parameters ———- Parameters ———- <boundary_name> : BoundaryType Supported boundary types: Union[NoSlipWall, SlipWall, FreestreamBoundary, IsothermalWall, HeatFluxWall, SubsonicOutflowPressure, SubsonicOutflowMach, SubsonicInflow, SupersonicInflow, SlidingInterfaceBoundary, WallFunction, MassInflow, MassOutflow, SolidIsothermalWall, SolidAdiabaticWall, RiemannInvariant, VelocityInflow, PressureOutflow, SymmetryPlane] Returns ——- Boundaries An instance of the component class Boundaries. Example ——- >>> boundaries = Boundaries( wing=NoSlipWall(), symmetry=SlipWall(), freestream=FreestreamBoundary() )

  • type = object

  • properties = {‘_type’: {‘title’: ‘ Type’, ‘default’: ‘Boundaries’, ‘enum’: [‘Boundaries’], ‘type’: ‘string’}}

field initial_condition = None (alias 'initialCondition')#
field time_stepping = SteadyTimeStepping(max_pseudo_steps=2000, order_of_accuracy=2, CFL=AdaptiveCFL(type='adaptive', min=0.1, max=10000.0, max_relative_change=1.0, convergence_limiting_factor=0.25, _type='AdaptiveCFL'), _type='SteadyTimeStepping', model_type='Steady', physical_steps=1, time_step_size='inf') (alias 'timeStepping')#
field turbulence_model_solver = None (alias 'turbulenceModelSolver')#
field transition_model_solver = None (alias 'transitionModelSolver')#
Constraints:
  • title = TransitionModelSolver

  • description = TransitionModelSolver class for setting up transition model solver Parameters ———- absolute_tolerance : Optional[PositiveFloat] = 1e-07 relative_tolerance : Optional[NonNegativeFloat] = 0 order_of_accuracy : Optional[Literal[1, 2]] = 2 CFL_multiplier : Optional[PositiveFloat] = 2.0 update_jacobian_frequency : Optional[PositiveInt] = 4 max_force_jac_update_physical_steps : Optional[NonNegativeInt] = 0 model_type : Literal[‘AmplificationFactorTransport’] = AmplificationFactorTransport equation_eval_frequency : Optional[PositiveInt] = 4 turbulence_intensity_percent : Optional[ConstrainedFloatValue] = None N_crit : Optional[ConstrainedFloatValue] = None reconstruction_gradient_limiter : Optional[ConstrainedFloatValue] = 1.0 linear_solver : Optional[LinearSolver] = LinearSolver(max_iterations=20, absolute_tolerance=None, relative_tolerance=None, _type=’LinearSolver’) Parameters ———- (
) Returns ——- TransitionModelSolver An instance of the component class TransitionModelSolver. Example ——- >>> ts = TransitionModelSolver(absolute_tolerance=1e-10)

  • type = object

  • properties = {‘absoluteTolerance’: {‘title’: ‘Absolutetolerance’, ‘default’: 1e-07, ‘exclusiveMinimum’: 0, ‘type’: ‘number’}, ‘relativeTolerance’: {‘title’: ‘Relativetolerance’, ‘default’: 0, ‘minimum’: 0, ‘type’: ‘number’}, ‘orderOfAccuracy’: {‘title’: ‘Orderofaccuracy’, ‘default’: 2, ‘enum’: [1, 2], ‘type’: ‘integer’}, ‘CFLMultiplier’: {‘title’: ‘Cflmultiplier’, ‘default’: 2.0, ‘displayed’: ‘CFL Multiplier’, ‘exclusiveMinimum’: 0, ‘type’: ‘number’}, ‘updateJacobianFrequency’: {‘title’: ‘Updatejacobianfrequency’, ‘default’: 4, ‘exclusiveMinimum’: 0, ‘type’: ‘integer’}, ‘maxForceJacUpdatePhysicalSteps’: {‘title’: ‘Maxforcejacupdatephysicalsteps’, ‘default’: 0, ‘displayed’: ‘Max force JAC update physical steps’, ‘minimum’: 0, ‘type’: ‘integer’}, ‘_type’: {‘title’: ‘ Type’, ‘default’: ‘TransitionModelSolver’, ‘enum’: [‘TransitionModelSolver’], ‘type’: ‘string’}, ‘modelType’: {‘title’: ‘Modeltype’, ‘default’: ‘AmplificationFactorTransport’, ‘const’: ‘AmplificationFactorTransport’, ‘enum’: [‘AmplificationFactorTransport’], ‘type’: ‘string’}, ‘equationEvalFrequency’: {‘title’: ‘Equationevalfrequency’, ‘default’: 4, ‘exclusiveMinimum’: 0, ‘type’: ‘integer’}, ‘turbulenceIntensityPercent’: {‘title’: ‘Turbulenceintensitypercent’, ‘minimum’: 0.03, ‘maximum’: 2.5, ‘type’: ‘number’}, ‘Ncrit’: {‘title’: ‘Ncrit’, ‘minimum’: 1, ‘maximum’: 11, ‘type’: ‘number’}, ‘reconstructionGradientLimiter’: {‘title’: ‘Reconstructiongradientlimiter’, ‘default’: 1.0, ‘minimum’: 0, ‘maximum’: 2, ‘type’: ‘number’}, ‘linearSolver’: {‘title’: ‘LinearSolver’, ‘default’: {‘max_iterations’: 20, ‘absolute_tolerance’: None, ‘relative_tolerance’: None}, ‘displayed’: ‘Linear solver config’, ‘description’: ‘LinearSolver class for setting up linear solver for heat equationnnParametersn———-nmax_iterations : Optional[PositiveInt] = 50n absolute_tolerance : Optional[PositiveFloat] = Nonen relative_tolerance : Optional[PositiveFloat] = Nonen nnParametersn———-nnmax_iterations : PositiveInt, optionaln Maximum number of linear solver iterations, by default 50nnabsolute_tolerance : PositiveFloat, optionaln The linear solver converges when the final residual of the pseudo steps below this value. Either absoluten tolerance or relative tolerance can be used to determine convergence, by default 1e-10nnrelative_tolerance :n The linear solver converges when the ratio of the final residual and the initialn residual of the pseudo step is below this value.nnReturnsn——-n:class:LinearSolvern An instance of the component class LinearSolver.nnnExamplen——-n>>> ls = LinearSolver(n max_iterations=50,n absoluteTolerance=1e-10n )’, ‘type’: ‘object’, ‘properties’: {‘maxIterations’: {‘title’: ‘Maxiterations’, ‘default’: 50, ‘exclusiveMinimum’: 0, ‘type’: ‘integer’}, ‘absoluteTolerance’: {‘title’: ‘Absolutetolerance’, ‘exclusiveMinimum’: 0, ‘type’: ‘number’}, ‘relativeTolerance’: {‘title’: ‘Relativetolerance’, ‘exclusiveMinimum’: 0, ‘type’: ‘number’}, ‘_type’: {‘title’: ‘ Type’, ‘default’: ‘LinearSolver’, ‘enum’: [‘LinearSolver’], ‘type’: ‘string’}}, ‘additionalProperties’: False}}

  • additionalProperties = False

field heat_equation_solver = None (alias 'heatEquationSolver')#
Constraints:
  • title = HeatEquationSolver

  • description = HeatEquationSolver class for setting up heat equation solver. Parameters ———- absolute_tolerance : Optional[PositiveFloat] = 1e-09 relative_tolerance : Optional[NonNegativeFloat] = 0.001 order_of_accuracy : Optional[Literal[2]] = 2 CFL_multiplier : Optional[PositiveFloat] = 1.0 update_jacobian_frequency : Optional[PositiveInt] = 1 max_force_jac_update_physical_steps : Optional[NonNegativeInt] = 0 model_type : Literal[‘HeatEquation’] = HeatEquation equation_eval_frequency : Optional[PositiveInt] = None linear_solver : Optional[LinearSolver] = LinearSolver(max_iterations=50, absolute_tolerance=None, relative_tolerance=None, _type=’LinearSolver’) Parameters ———- equation_eval_frequency : PositiveInt, optional Frequency at which to solve the heat equation in conjugate heat transfer simulations linear_solver_config : LinearSolver, optional Linear solver settings, see LinearSolver documentation. Returns ——- HeatEquationSolver An instance of the component class HeatEquationSolver. Example ——- >>> he = HeatEquationSolver( equation_eval_frequency=10, linear_solver_config=LinearSolver( max_iterations=50, absoluteTolerance=1e-10 ) )

  • type = object

  • properties = {‘absoluteTolerance’: {‘title’: ‘Absolutetolerance’, ‘default’: 1e-09, ‘exclusiveMinimum’: 0, ‘type’: ‘number’}, ‘relativeTolerance’: {‘title’: ‘Relativetolerance’, ‘default’: 0.001, ‘minimum’: 0, ‘type’: ‘number’}, ‘orderOfAccuracy’: {‘title’: ‘Orderofaccuracy’, ‘default’: 2, ‘const’: 2, ‘enum’: [2], ‘type’: ‘integer’}, ‘CFLMultiplier’: {‘title’: ‘Cflmultiplier’, ‘default’: 1.0, ‘displayed’: ‘CFL Multiplier’, ‘exclusiveMinimum’: 0, ‘type’: ‘number’}, ‘updateJacobianFrequency’: {‘title’: ‘Updatejacobianfrequency’, ‘default’: 1, ‘exclusiveMinimum’: 0, ‘type’: ‘integer’}, ‘maxForceJacUpdatePhysicalSteps’: {‘title’: ‘Maxforcejacupdatephysicalsteps’, ‘default’: 0, ‘displayed’: ‘Max force JAC update physical steps’, ‘minimum’: 0, ‘type’: ‘integer’}, ‘_type’: {‘title’: ‘ Type’, ‘default’: ‘HeatEquationSolver’, ‘enum’: [‘HeatEquationSolver’], ‘type’: ‘string’}, ‘modelType’: {‘title’: ‘Modeltype’, ‘default’: ‘HeatEquation’, ‘const’: ‘HeatEquation’, ‘enum’: [‘HeatEquation’], ‘type’: ‘string’}, ‘equationEvalFrequency’: {‘title’: ‘Equationevalfrequency’, ‘exclusiveMinimum’: 0, ‘type’: ‘integer’}, ‘linearSolver’: {‘title’: ‘LinearSolver’, ‘default’: {‘max_iterations’: 50, ‘absolute_tolerance’: None, ‘relative_tolerance’: None}, ‘description’: ‘LinearSolver class for setting up linear solver for heat equationnnParametersn———-nmax_iterations : Optional[PositiveInt] = 50n absolute_tolerance : Optional[PositiveFloat] = Nonen relative_tolerance : Optional[PositiveFloat] = Nonen nnParametersn———-nnmax_iterations : PositiveInt, optionaln Maximum number of linear solver iterations, by default 50nnabsolute_tolerance : PositiveFloat, optionaln The linear solver converges when the final residual of the pseudo steps below this value. Either absoluten tolerance or relative tolerance can be used to determine convergence, by default 1e-10nnrelative_tolerance :n The linear solver converges when the ratio of the final residual and the initialn residual of the pseudo step is below this value.nnReturnsn——-n:class:LinearSolvern An instance of the component class LinearSolver.nnnExamplen——-n>>> ls = LinearSolver(n max_iterations=50,n absoluteTolerance=1e-10n )’, ‘type’: ‘object’, ‘properties’: {‘maxIterations’: {‘title’: ‘Maxiterations’, ‘default’: 50, ‘exclusiveMinimum’: 0, ‘type’: ‘integer’}, ‘absoluteTolerance’: {‘title’: ‘Absolutetolerance’, ‘exclusiveMinimum’: 0, ‘type’: ‘number’}, ‘relativeTolerance’: {‘title’: ‘Relativetolerance’, ‘exclusiveMinimum’: 0, ‘type’: ‘number’}, ‘_type’: {‘title’: ‘ Type’, ‘default’: ‘LinearSolver’, ‘enum’: [‘LinearSolver’], ‘type’: ‘string’}}, ‘additionalProperties’: False}}

  • additionalProperties = False

field freestream [Required]#
field bet_disks = None (alias 'BETDisks')#
field actuator_disks = None (alias 'actuatorDisks')#
field porous_media = None (alias 'porousMedia')#
field user_defined_dynamics = None (alias 'userDefinedDynamics')#
field surface_output = SurfaceOutput(output_format='paraview', animation_frequency=-1, animation_frequency_offset=0, compute_time_averages=False, animation_frequency_time_average=-1, animation_frequency_time_average_offset=0, start_average_integration_step=-1, write_single_file=False, output_fields=[], surfaces=None, _type='SurfaceOutput') (alias 'surfaceOutput')#
Constraints:
  • title = SurfaceOutput

  • description = SurfaceOutput class Parameters ———- output_format : Optional[Literal[‘paraview’, ‘tecplot’, ‘both’]] = paraview animation_frequency : Union[PositiveInt, Literal[-1], NoneType] = -1 animation_frequency_offset : Optional[int] = 0 compute_time_averages : Optional[bool] = False animation_frequency_time_average : Union[PositiveInt, Literal[-1], NoneType] = -1 animation_frequency_time_average_offset : Optional[int] = 0 start_average_integration_step : Union[NonNegativeInt, Literal[-1], NoneType] = -1 write_single_file : Optional[bool] = False output_fields : Optional[List[Literal[‘Cp’, ‘gradW’, ‘kOmega’, ‘Mach’, ‘mut’, ‘mutRatio’, ‘nuHat’, ‘primitiveVars’, ‘qcriterion’, ‘residualNavierStokes’, ‘residualTransition’, ‘residualTurbulence’, ‘s’, ‘solutionNavierStokes’, ‘solutionTransition’, ‘solutionTurbulence’, ‘T’, ‘vorticity’, ‘wallDistance’, ‘numericalDissipationFactor’, ‘residualHeatSolver’, ‘VelocityRelative’, ‘lowMachPreconditionerSensor’, ‘CfVec’, ‘Cf’, ‘heatFlux’, ‘nodeNormals’, ‘nodeForcesPerUnitArea’, ‘yPlus’, ‘wallFunctionMetric’, ‘Coefficient of pressure’, ‘Gradient of primitive solution’, ‘k and omega’, ‘Mach number’, ‘Turbulent viscosity’, ‘Turbulent viscosity and freestream dynamic viscosity ratio’, ‘Spalart-Almaras variable’, ‘rho, u, v, w, p (density, 3 velocities and pressure)’, ‘Q criterion’, ‘N-S residual’, ‘Transition residual’, ‘Turbulence residual’, ‘Entropy’, ‘N-S solution’, ‘Transition solution’, ‘Turbulence solution’, ‘Temperature’, ‘Vorticity’, ‘Wall distance’, ‘NumericalDissipationFactor sensor’, ‘Heat equation residual’, ‘Velocity with respect to non-inertial frame’, ‘Low-Mach preconditioner factor’, ‘Skin friction coefficient vector’, ‘Magnitude of CfVec’, ‘Non-dimensional heat flux’, ‘Wall normals’, ‘Spalart-Allmaras variable’, ‘Non-dimensional wall distance’, ‘Wall function metrics’]]] = [] surfaces : Optional[Surfaces] = None

  • type = object

  • properties = {‘outputFormat’: {‘title’: ‘Outputformat’, ‘default’: ‘paraview’, ‘enum’: [‘paraview’, ‘tecplot’, ‘both’], ‘type’: ‘string’}, ‘animationFrequency’: {‘title’: ‘Animationfrequency’, ‘default’: -1, ‘options’: [‘Animated’, ‘Static’], ‘anyOf’: [{‘type’: ‘integer’, ‘exclusiveMinimum’: 0}, {‘enum’: [-1], ‘type’: ‘integer’}]}, ‘animationFrequencyOffset’: {‘title’: ‘Animationfrequencyoffset’, ‘default’: 0, ‘type’: ‘integer’}, ‘computeTimeAverages’: {‘title’: ‘Computetimeaverages’, ‘default’: False, ‘type’: ‘boolean’}, ‘animationFrequencyTimeAverage’: {‘title’: ‘Animationfrequencytimeaverage’, ‘default’: -1, ‘options’: [‘Animated’, ‘Static’], ‘anyOf’: [{‘type’: ‘integer’, ‘exclusiveMinimum’: 0}, {‘enum’: [-1], ‘type’: ‘integer’}]}, ‘animationFrequencyTimeAverageOffset’: {‘title’: ‘Animationfrequencytimeaverageoffset’, ‘default’: 0, ‘type’: ‘integer’}, ‘startAverageIntegrationStep’: {‘title’: ‘Startaverageintegrationstep’, ‘default’: -1, ‘options’: [‘From step’, ‘No averaging’], ‘anyOf’: [{‘type’: ‘integer’, ‘minimum’: 0}, {‘enum’: [-1], ‘type’: ‘integer’}]}, ‘writeSingleFile’: {‘title’: ‘Writesinglefile’, ‘default’: False, ‘type’: ‘boolean’}, ‘outputFields’: {‘title’: ‘Outputfields’, ‘default’: [], ‘uniqueItems’: True, ‘type’: ‘array’, ‘items’: {‘enum’: [‘Coefficient of pressure’, ‘Gradient of primitive solution’, ‘k and omega’, ‘Mach number’, ‘Turbulent viscosity’, ‘Turbulent viscosity and freestream dynamic viscosity ratio’, ‘Spalart-Almaras variable’, ‘rho, u, v, w, p (density, 3 velocities and pressure)’, ‘Q criterion’, ‘N-S residual’, ‘Transition residual’, ‘Turbulence residual’, ‘Entropy’, ‘N-S solution’, ‘Transition solution’, ‘Turbulence solution’, ‘Temperature’, ‘Vorticity’, ‘Wall distance’, ‘NumericalDissipationFactor sensor’, ‘Heat equation residual’, ‘Velocity with respect to non-inertial frame’, ‘Low-Mach preconditioner factor’, ‘Skin friction coefficient vector’, ‘Magnitude of CfVec’, ‘Non-dimensional heat flux’, ‘Wall normals’, ‘Spalart-Allmaras variable’, ‘Non-dimensional wall distance’, ‘Wall function metrics’], ‘type’: ‘string’}}, ‘surfaces’: {‘title’: ‘Surfaces’, ‘description’: ‘Surfaces classnnParametersn———-’, ‘type’: ‘object’, ‘properties’: {‘_type’: {‘title’: ‘ Type’, ‘default’: ‘Surfaces’, ‘enum’: [‘Surfaces’], ‘type’: ‘string’}}}, ‘_type’: {‘title’: ‘ Type’, ‘default’: ‘SurfaceOutput’, ‘enum’: [‘SurfaceOutput’], ‘type’: ‘string’}}

  • additionalProperties = False

field volume_output = None (alias 'volumeOutput')#
Constraints:
  • title = VolumeOutput

  • description = VolumeOutput class Parameters ———- output_format : Optional[Literal[‘paraview’, ‘tecplot’, ‘both’]] = paraview animation_frequency : Union[PositiveInt, Literal[-1], NoneType] = -1 animation_frequency_offset : Optional[int] = 0 compute_time_averages : Optional[bool] = False animation_frequency_time_average : Union[PositiveInt, Literal[-1], NoneType] = -1 animation_frequency_time_average_offset : Optional[int] = 0 start_average_integration_step : Union[NonNegativeInt, Literal[-1], NoneType] = -1 output_fields : Optional[List[Literal[‘Cp’, ‘gradW’, ‘kOmega’, ‘Mach’, ‘mut’, ‘mutRatio’, ‘nuHat’, ‘primitiveVars’, ‘qcriterion’, ‘residualNavierStokes’, ‘residualTransition’, ‘residualTurbulence’, ‘s’, ‘solutionNavierStokes’, ‘solutionTransition’, ‘solutionTurbulence’, ‘T’, ‘vorticity’, ‘wallDistance’, ‘numericalDissipationFactor’, ‘residualHeatSolver’, ‘VelocityRelative’, ‘lowMachPreconditionerSensor’, ‘betMetrics’, ‘betMetricsPerDisk’, ‘Coefficient of pressure’, ‘Gradient of primitive solution’, ‘k and omega’, ‘Mach number’, ‘Turbulent viscosity’, ‘Turbulent viscosity and freestream dynamic viscosity ratio’, ‘Spalart-Almaras variable’, ‘rho, u, v, w, p (density, 3 velocities and pressure)’, ‘Q criterion’, ‘N-S residual’, ‘Transition residual’, ‘Turbulence residual’, ‘Entropy’, ‘N-S solution’, ‘Transition solution’, ‘Turbulence solution’, ‘Temperature’, ‘Vorticity’, ‘Wall distance’, ‘NumericalDissipationFactor sensor’, ‘Heat equation residual’, ‘Velocity with respect to non-inertial frame’, ‘Low-Mach preconditioner factor’, ‘BET Metrics’, ‘BET Metrics per Disk’]]] = [‘primitiveVars’, ‘Cp’, ‘mut’, ‘Mach’]

  • type = object

  • properties = {‘outputFormat’: {‘title’: ‘Outputformat’, ‘default’: ‘paraview’, ‘enum’: [‘paraview’, ‘tecplot’, ‘both’], ‘type’: ‘string’}, ‘animationFrequency’: {‘title’: ‘Animationfrequency’, ‘default’: -1, ‘options’: [‘Animated’, ‘Static’], ‘anyOf’: [{‘type’: ‘integer’, ‘exclusiveMinimum’: 0}, {‘enum’: [-1], ‘type’: ‘integer’}]}, ‘animationFrequencyOffset’: {‘title’: ‘Animationfrequencyoffset’, ‘default’: 0, ‘type’: ‘integer’}, ‘computeTimeAverages’: {‘title’: ‘Computetimeaverages’, ‘default’: False, ‘type’: ‘boolean’}, ‘animationFrequencyTimeAverage’: {‘title’: ‘Animationfrequencytimeaverage’, ‘default’: -1, ‘options’: [‘Animated’, ‘Static’], ‘anyOf’: [{‘type’: ‘integer’, ‘exclusiveMinimum’: 0}, {‘enum’: [-1], ‘type’: ‘integer’}]}, ‘animationFrequencyTimeAverageOffset’: {‘title’: ‘Animationfrequencytimeaverageoffset’, ‘default’: 0, ‘type’: ‘integer’}, ‘startAverageIntegrationStep’: {‘title’: ‘Startaverageintegrationstep’, ‘default’: -1, ‘options’: [‘From step’, ‘No averaging’], ‘anyOf’: [{‘type’: ‘integer’, ‘minimum’: 0}, {‘enum’: [-1], ‘type’: ‘integer’}]}, ‘outputFields’: {‘title’: ‘Outputfields’, ‘default’: [‘primitiveVars’, ‘Cp’, ‘mut’, ‘Mach’], ‘uniqueItems’: True, ‘type’: ‘array’, ‘items’: {‘enum’: [‘Coefficient of pressure’, ‘Gradient of primitive solution’, ‘k and omega’, ‘Mach number’, ‘Turbulent viscosity’, ‘Turbulent viscosity and freestream dynamic viscosity ratio’, ‘Spalart-Almaras variable’, ‘rho, u, v, w, p (density, 3 velocities and pressure)’, ‘Q criterion’, ‘N-S residual’, ‘Transition residual’, ‘Turbulence residual’, ‘Entropy’, ‘N-S solution’, ‘Transition solution’, ‘Turbulence solution’, ‘Temperature’, ‘Vorticity’, ‘Wall distance’, ‘NumericalDissipationFactor sensor’, ‘Heat equation residual’, ‘Velocity with respect to non-inertial frame’, ‘Low-Mach preconditioner factor’, ‘BET Metrics’, ‘BET Metrics per Disk’], ‘type’: ‘string’}}, ‘_type’: {‘title’: ‘ Type’, ‘default’: ‘VolumeOutput’, ‘enum’: [‘VolumeOutput’], ‘type’: ‘string’}}

  • additionalProperties = False

field slice_output = None (alias 'sliceOutput')#
Constraints:
  • title = SliceOutput

  • description = SliceOutput class Parameters ———- output_format : Optional[Literal[‘paraview’, ‘tecplot’, ‘both’]] = paraview animation_frequency : Union[PositiveInt, Literal[-1], NoneType] = -1 animation_frequency_offset : Optional[int] = 0 output_fields : Optional[List[Literal[‘Cp’, ‘gradW’, ‘kOmega’, ‘Mach’, ‘mut’, ‘mutRatio’, ‘nuHat’, ‘primitiveVars’, ‘qcriterion’, ‘residualNavierStokes’, ‘residualTransition’, ‘residualTurbulence’, ‘s’, ‘solutionNavierStokes’, ‘solutionTransition’, ‘solutionTurbulence’, ‘T’, ‘vorticity’, ‘wallDistance’, ‘numericalDissipationFactor’, ‘residualHeatSolver’, ‘VelocityRelative’, ‘lowMachPreconditionerSensor’, ‘betMetrics’, ‘betMetricsPerDisk’, ‘Coefficient of pressure’, ‘Gradient of primitive solution’, ‘k and omega’, ‘Mach number’, ‘Turbulent viscosity’, ‘Turbulent viscosity and freestream dynamic viscosity ratio’, ‘Spalart-Almaras variable’, ‘rho, u, v, w, p (density, 3 velocities and pressure)’, ‘Q criterion’, ‘N-S residual’, ‘Transition residual’, ‘Turbulence residual’, ‘Entropy’, ‘N-S solution’, ‘Transition solution’, ‘Turbulence solution’, ‘Temperature’, ‘Vorticity’, ‘Wall distance’, ‘NumericalDissipationFactor sensor’, ‘Heat equation residual’, ‘Velocity with respect to non-inertial frame’, ‘Low-Mach preconditioner factor’, ‘BET Metrics’, ‘BET Metrics per Disk’]]] = [] slices : Slices

  • type = object

  • properties = {‘outputFormat’: {‘title’: ‘Outputformat’, ‘default’: ‘paraview’, ‘enum’: [‘paraview’, ‘tecplot’, ‘both’], ‘type’: ‘string’}, ‘animationFrequency’: {‘title’: ‘Animationfrequency’, ‘default’: -1, ‘options’: [‘Animated’, ‘Static’], ‘anyOf’: [{‘type’: ‘integer’, ‘exclusiveMinimum’: 0}, {‘enum’: [-1], ‘type’: ‘integer’}]}, ‘animationFrequencyOffset’: {‘title’: ‘Animationfrequencyoffset’, ‘default’: 0, ‘type’: ‘integer’}, ‘outputFields’: {‘title’: ‘Outputfields’, ‘default’: [], ‘uniqueItems’: True, ‘type’: ‘array’, ‘items’: {‘enum’: [‘Coefficient of pressure’, ‘Gradient of primitive solution’, ‘k and omega’, ‘Mach number’, ‘Turbulent viscosity’, ‘Turbulent viscosity and freestream dynamic viscosity ratio’, ‘Spalart-Almaras variable’, ‘rho, u, v, w, p (density, 3 velocities and pressure)’, ‘Q criterion’, ‘N-S residual’, ‘Transition residual’, ‘Turbulence residual’, ‘Entropy’, ‘N-S solution’, ‘Transition solution’, ‘Turbulence solution’, ‘Temperature’, ‘Vorticity’, ‘Wall distance’, ‘NumericalDissipationFactor sensor’, ‘Heat equation residual’, ‘Velocity with respect to non-inertial frame’, ‘Low-Mach preconditioner factor’, ‘BET Metrics’, ‘BET Metrics per Disk’], ‘type’: ‘string’}}, ‘slices’: {‘title’: ‘Slices’, ‘description’: ‘SelfNamedSlices classnnParametersn———-’, ‘type’: ‘object’, ‘properties’: {‘_type’: {‘title’: ‘ Type’, ‘default’: ‘Slices’, ‘enum’: [‘Slices’], ‘type’: ‘string’}}}, ‘_type’: {‘title’: ‘ Type’, ‘default’: ‘SliceOutput’, ‘enum’: [‘SliceOutput’], ‘type’: ‘string’}}

  • required = [‘slices’]

  • additionalProperties = False

field iso_surface_output = None (alias 'isoSurfaceOutput')#
Constraints:
  • title = IsoSurfaceOutput

  • description = IsoSurfaceOutput class Parameters ———- output_format : Optional[Literal[‘paraview’, ‘tecplot’, ‘both’]] = None animation_frequency : Union[PositiveInt, Literal[-1], NoneType] = -1 animation_frequency_offset : Optional[int] = 0 iso_surfaces : IsoSurfaces output_fields : Optional[List[Literal[‘Cp’, ‘gradW’, ‘kOmega’, ‘Mach’, ‘mut’, ‘mutRatio’, ‘nuHat’, ‘primitiveVars’, ‘qcriterion’, ‘residualNavierStokes’, ‘residualTransition’, ‘residualTurbulence’, ‘s’, ‘solutionNavierStokes’, ‘solutionTransition’, ‘solutionTurbulence’, ‘T’, ‘vorticity’, ‘wallDistance’, ‘numericalDissipationFactor’, ‘residualHeatSolver’, ‘VelocityRelative’, ‘lowMachPreconditionerSensor’, ‘Coefficient of pressure’, ‘Gradient of primitive solution’, ‘k and omega’, ‘Mach number’, ‘Turbulent viscosity’, ‘Turbulent viscosity and freestream dynamic viscosity ratio’, ‘Spalart-Almaras variable’, ‘rho, u, v, w, p (density, 3 velocities and pressure)’, ‘Q criterion’, ‘N-S residual’, ‘Transition residual’, ‘Turbulence residual’, ‘Entropy’, ‘N-S solution’, ‘Transition solution’, ‘Turbulence solution’, ‘Temperature’, ‘Vorticity’, ‘Wall distance’, ‘NumericalDissipationFactor sensor’, ‘Heat equation residual’, ‘Velocity with respect to non-inertial frame’, ‘Low-Mach preconditioner factor’]]] = []

  • type = object

  • properties = {‘outputFormat’: {‘title’: ‘Outputformat’, ‘enum’: [‘paraview’, ‘tecplot’, ‘both’], ‘type’: ‘string’}, ‘animationFrequency’: {‘title’: ‘Animationfrequency’, ‘default’: -1, ‘options’: [‘Animated’, ‘Static’], ‘anyOf’: [{‘type’: ‘integer’, ‘exclusiveMinimum’: 0}, {‘enum’: [-1], ‘type’: ‘integer’}]}, ‘animationFrequencyOffset’: {‘title’: ‘Animationfrequencyoffset’, ‘default’: 0, ‘type’: ‘integer’}, ‘isoSurfaces’: {‘title’: ‘IsoSurfaces’, ‘description’: ‘IsoSurfaces classnnParametersn———-’, ‘type’: ‘object’, ‘properties’: {‘_type’: {‘title’: ‘ Type’, ‘default’: ‘IsoSurfaces’, ‘enum’: [‘IsoSurfaces’], ‘type’: ‘string’}}}, ‘outputFields’: {‘title’: ‘Outputfields’, ‘default’: [], ‘uniqueItems’: True, ‘type’: ‘array’, ‘items’: {‘enum’: [‘Cp’, ‘gradW’, ‘kOmega’, ‘Mach’, ‘mut’, ‘mutRatio’, ‘nuHat’, ‘primitiveVars’, ‘qcriterion’, ‘residualNavierStokes’, ‘residualTransition’, ‘residualTurbulence’, ‘s’, ‘solutionNavierStokes’, ‘solutionTransition’, ‘solutionTurbulence’, ‘T’, ‘vorticity’, ‘wallDistance’, ‘numericalDissipationFactor’, ‘residualHeatSolver’, ‘VelocityRelative’, ‘lowMachPreconditionerSensor’, ‘Coefficient of pressure’, ‘Gradient of primitive solution’, ‘k and omega’, ‘Mach number’, ‘Turbulent viscosity’, ‘Turbulent viscosity and freestream dynamic viscosity ratio’, ‘Spalart-Almaras variable’, ‘rho, u, v, w, p (density, 3 velocities and pressure)’, ‘Q criterion’, ‘N-S residual’, ‘Transition residual’, ‘Turbulence residual’, ‘Entropy’, ‘N-S solution’, ‘Transition solution’, ‘Turbulence solution’, ‘Temperature’, ‘Vorticity’, ‘Wall distance’, ‘NumericalDissipationFactor sensor’, ‘Heat equation residual’, ‘Velocity with respect to non-inertial frame’, ‘Low-Mach preconditioner factor’], ‘type’: ‘string’}}, ‘_type’: {‘title’: ‘ Type’, ‘default’: ‘IsoSurfaceOutput’, ‘enum’: [‘IsoSurfaceOutput’], ‘type’: ‘string’}}

  • required = [‘isoSurfaces’]

  • additionalProperties = False

field monitor_output = None (alias 'monitorOutput')#
Constraints:
  • title = MonitorOutput

  • description = MonitorOutput class Parameters ———- monitors : Monitors output_fields : Optional[List[Literal[‘Cp’, ‘gradW’, ‘kOmega’, ‘Mach’, ‘mut’, ‘mutRatio’, ‘nuHat’, ‘primitiveVars’, ‘qcriterion’, ‘residualNavierStokes’, ‘residualTransition’, ‘residualTurbulence’, ‘s’, ‘solutionNavierStokes’, ‘solutionTransition’, ‘solutionTurbulence’, ‘T’, ‘vorticity’, ‘wallDistance’, ‘numericalDissipationFactor’, ‘residualHeatSolver’, ‘VelocityRelative’, ‘lowMachPreconditionerSensor’, ‘Coefficient of pressure’, ‘Gradient of primitive solution’, ‘k and omega’, ‘Mach number’, ‘Turbulent viscosity’, ‘Turbulent viscosity and freestream dynamic viscosity ratio’, ‘Spalart-Almaras variable’, ‘rho, u, v, w, p (density, 3 velocities and pressure)’, ‘Q criterion’, ‘N-S residual’, ‘Transition residual’, ‘Turbulence residual’, ‘Entropy’, ‘N-S solution’, ‘Transition solution’, ‘Turbulence solution’, ‘Temperature’, ‘Vorticity’, ‘Wall distance’, ‘NumericalDissipationFactor sensor’, ‘Heat equation residual’, ‘Velocity with respect to non-inertial frame’, ‘Low-Mach preconditioner factor’]]] = []

  • type = object

  • properties = {‘monitors’: {‘title’: ‘Monitors’, ‘description’: ‘Monitors classnnParametersn———-’, ‘type’: ‘object’, ‘properties’: {‘_type’: {‘title’: ‘ Type’, ‘default’: ‘Monitors’, ‘enum’: [‘Monitors’], ‘type’: ‘string’}}}, ‘outputFields’: {‘title’: ‘Outputfields’, ‘default’: [], ‘uniqueItems’: True, ‘type’: ‘array’, ‘items’: {‘enum’: [‘Coefficient of pressure’, ‘Gradient of primitive solution’, ‘k and omega’, ‘Mach number’, ‘Turbulent viscosity’, ‘Turbulent viscosity and freestream dynamic viscosity ratio’, ‘Spalart-Almaras variable’, ‘rho, u, v, w, p (density, 3 velocities and pressure)’, ‘Q criterion’, ‘N-S residual’, ‘Transition residual’, ‘Turbulence residual’, ‘Entropy’, ‘N-S solution’, ‘Transition solution’, ‘Turbulence solution’, ‘Temperature’, ‘Vorticity’, ‘Wall distance’, ‘NumericalDissipationFactor sensor’, ‘Heat equation residual’, ‘Velocity with respect to non-inertial frame’, ‘Low-Mach preconditioner factor’], ‘type’: ‘string’}}, ‘_type’: {‘title’: ‘ Type’, ‘default’: ‘MonitorOutput’, ‘enum’: [‘MonitorOutput’], ‘type’: ‘string’}}

  • required = [‘monitors’]

  • additionalProperties = False

field volume_zones = None (alias 'volumeZones')#
Constraints:
  • title = VolumeZones

  • description = VolumeZones class for setting up volume zones Parameters ———- Parameters ———- <zone_name> : Union[FluidDynamicsVolumeZone, HeatTransferVolumeZone] Returns ——- VolumeZones An instance of the component class VolumeZones. Example ——- >>> zones = VolumeZones( zone1=FluidDynamicsVolumeZone(), zone2=HeatTransferVolumeZone(thermal_conductivity=1) )

  • type = object

  • properties = {‘_type’: {‘title’: ‘ Type’, ‘default’: ‘VolumeZones’, ‘enum’: [‘VolumeZones’], ‘type’: ‘string’}}

field aeroacoustic_output = None (alias 'aeroacousticOutput')#
Constraints:
  • title = AeroacousticOutput

  • description = AeroacousticOutput class for configuring output data about acoustic pressure signals Parameters ———- patch_type : Optional[str] = solid observers : List[Tuple[float, float, float]] write_per_surface_output : Optional[bool] = False Parameters ———- observers : List[Coordinate] List of observer locations at which time history of acoustic pressure signal is stored in aeroacoustic output file. The observer locations can be outside the simulation domain, but cannot be inside the solid surfaces of the simulation domain. Returns ——- AeroacousticOutput An instance of the component class AeroacousticOutput. Example ——- >>> aeroacoustics = AeroacousticOutput(observers=[(0, 0, 0), (1, 1, 1)])

  • type = object

  • properties = {‘patchType’: {‘title’: ‘Patchtype’, ‘default’: ‘solid’, ‘const’: ‘solid’, ‘type’: ‘string’}, ‘observers’: {‘title’: ‘Observers’, ‘type’: ‘array’, ‘items’: {‘type’: ‘array’, ‘minItems’: 3, ‘maxItems’: 3, ‘items’: [{‘type’: ‘number’}, {‘type’: ‘number’}, {‘type’: ‘number’}]}}, ‘writePerSurfaceOutput’: {‘title’: ‘Writepersurfaceoutput’, ‘default’: False, ‘type’: ‘boolean’}, ‘_type’: {‘title’: ‘ Type’, ‘default’: ‘AeroacousticOutput’, ‘enum’: [‘AeroacousticOutput’], ‘type’: ‘string’}}

  • required = [‘observers’]

  • additionalProperties = False

field navier_stokes_solver = None (alias 'navierStokesSolver')#
classmethod from_file(filename)[source]#

Loads a Flow360BaseModel from .json, or .yaml file.

Parameters:

filename (str) – Full path to the .yaml or .json file to load the Flow360BaseModel from.

Returns:

An instance of the component class calling load.

Return type:

Flow360Params

Example

>>> simulation = Flow360Params.from_file(filename='folder/sim.json') 
copy(update=None, **kwargs)[source]#

Copy a Flow360BaseModel. With deep=True as default.

to_solver()[source]#

returns configuration object in flow360 units system

flow360_json()[source]#

Generate a JSON representation of the model, as required by Flow360

Returns:

Returns JSON representation of the model.

Return type:

json

Example

>>> params.flow360_json() 
flow360_dict()[source]#

Generate a dict representation of the model, as required by Flow360

Returns:

Returns dict representation of the model.

Return type:

dict

Example

>>> params.flow360_dict() 
to_flow360_json(filename)[source]#

Exports Flow360Params instance to .json file

Example

>>> params.to_flow360_json() 
append(params, overwrite=False)[source]#

append parametrs to the model

Parameters:
  • params (Flow360BaseModel) – Flow360BaseModel parameters to be appended

  • overwrite (bool, optional) – Whether to overwrite if key exists, by default False

classmethod construct(filename=None, **kwargs)[source]#

Creates a new model from trusted or pre-validated data. Default values are respected, but no other validation is performed. Behaves as if Config.extra = ‘allow’ was set since it adds all passed values

classmethod add_type_field()#

Automatically place “type” field with model name in the model field dictionary.

dict(*args, exclude=None, **kwargs)#

Returns dict representation of the model.

Parameters:
  • *args – Arguments passed to pydantic’s dict method.

  • **kwargs – Keyword arguments passed to pydantic’s dict method.

Returns:

A formatted dict.

Return type:

dict

Example

>>> params.dict() 
classmethod dict_from_file(filename)#

Loads a dictionary containing the model from a .json or .yaml file.

Parameters:

filename (str) – Full path to the .yaml or .json file to load the Flow360BaseModel from.

Returns:

A dictionary containing the model.

Return type:

dict

Example

>>> params = Flow360Params.from_file(filename='folder/flow360.json') 
classmethod flow360_schema()#

Generate a schema json string for the flow360 model

classmethod flow360_ui_schema()#

Generate a UI schema json string for the flow360 model

classmethod from_json(filename, **parse_obj_kwargs)#

Load a Flow360BaseModel from .json file.

Parameters:

filename (str) – Full path to the .json file to load the Flow360BaseModel from.

Returns:

  • Flow360BaseModel – An instance of the component class calling load.

  • **parse_obj_kwargs – Keyword arguments passed to pydantic’s parse_obj method.

Example

>>> params = Flow360Params.from_json(filename='folder/flow360.json') 
classmethod from_orm(obj)#
classmethod from_yaml(filename, **parse_obj_kwargs)#

Loads Flow360BaseModel from .yaml file.

Parameters:
  • filename (str) – Full path to the .yaml file to load the Flow360BaseModel from.

  • **parse_obj_kwargs – Keyword arguments passed to pydantic’s parse_obj method.

Returns:

An instance of the component class calling from_yaml.

Return type:

Flow360BaseModel

Example

>>> params = Flow360Params.from_yaml(filename='folder/flow360.yaml') 
classmethod generate_docstring()#

Generates a docstring for a Flow360 model and saves it to the __doc__ of the class.

help(methods=False)#

Prints message describing the fields and methods of a Flow360BaseModel.

Parameters:

methods (bool = False) – Whether to also print out information about object’s methods.

Example

>>> solver_params.help(methods=True) 
json(*args, exclude=None, **kwargs)#

Returns json representation of the model.

Parameters:
  • *args – Arguments passed to pydantic’s json method.

  • **kwargs – Keyword arguments passed to pydantic’s json method.

Returns:

A formatted json. Sets default vaules by_alias=True, exclude_none=True

Return type:

json

Example

>>> params.json() 
classmethod parse_file(path, *, content_type=None, encoding='utf8', proto=None, allow_pickle=False)#
classmethod parse_obj(obj)#
classmethod parse_raw(b, *, content_type=None, encoding='utf8', proto=None, allow_pickle=False)#
classmethod schema(by_alias=True, ref_template='#/definitions/{model}')#
classmethod schema_json(*, by_alias=True, ref_template='#/definitions/{model}', **dumps_kwargs)#
set_will_export_to_flow360(flag)#

Recursivly sets flag will_export_to_flow360

Parameters:

flag (bool) – set to true before exporting to flow360 json

to_file(filename)#

Exports Flow360BaseModel instance to .json or .yaml file

Parameters:

filename (str) – Full path to the .json or .yaml or file to save the Flow360BaseModel to.

Example

>>> params.to_file(filename='folder/flow360.json') 
to_json(filename)#

Exports Flow360BaseModel instance to .json file

Parameters:

filename (str) – Full path to the .json file to save the Flow360BaseModel to.

Example

>>> params.to_json(filename='folder/flow360.json') 
to_yaml(filename)#

Exports Flow360BaseModel instance to .yaml file.

Parameters:

filename (str) – Full path to the .yaml file to save the Flow360BaseModel to.

Example

>>> params.to_yaml(filename='folder/flow360.yaml') 
classmethod update_forward_refs(**localns)#

Try to update ForwardRefs on fields based on this Model, globalns and localns.

classmethod validate(value)#