Package Modelica.​Media.​Air.​SimpleAir
Air: Simple dry air model (0..100 degC)

Information

Simple Ideal gas air model for low temperatures

This model demonstrates how to use the PartialSimpleIdealGas base class to build a simple ideal gas model with a limited temperature validity range.

Extends from Modelica.​Icons.​MaterialProperty (Icon for property classes) and Modelica.​Media.​Interfaces.​PartialSimpleIdealGasMedium (Medium model of Ideal gas with constant cp and cv. All other quantities, e.g., transport properties, are constant.).

Package Contents

NameDescription
AbsolutePressureType for absolute pressure with medium specific attributes
BasePropertiesBase properties of ideal gas
BasicThe most basic version of a record used in several degrees of detail
betaAlias for isobaricExpansionCoefficient for user convenience
Choices 
CumulativeExtraPropertyType for conserved integral of unspecified, mass specific property
DensityType for density with medium specific attributes
densityReturn density of ideal gas
density_derh_pReturn density derivative w.r.t. specific enthalpy at constant pressure
density_derp_hReturn density derivative w.r.t. pressure at const specific enthalpy
density_derp_TReturns the partial derivative of density with respect to pressure at constant temperature
density_derT_pReturns the partial derivative of density with respect to temperature at constant pressure
density_derXReturns the partial derivative of density with respect to mass fractions at constant pressure and temperature
density_phReturn density from p and h
density_phXReturn density from p, h, and X or Xi
density_psReturn density from p and s
density_psXReturn density from p, s, and X or Xi
density_pTReturn density from p and T
density_pTXReturn density from p, T, and X or Xi
DerDensityByEnthalpyType for partial derivative of density with respect to enthalpy with medium specific attributes
DerDensityByPressureType for partial derivative of density with respect to pressure with medium specific attributes
DerDensityByTemperatureType for partial derivative of density with respect to temperature with medium specific attributes
DerEnthalpyByPressureType for partial derivative of enthalpy with respect to pressure with medium specific attributes
DerTemperatureByPressureType for partial derivative of temperature with respect to pressure with medium specific attributes
DipoleMomentType for dipole moment with medium specific attributes
DynamicViscosityType for dynamic viscosity with medium specific attributes
dynamicViscosityReturn dynamic viscosity
EnthalpyFlowRateType for enthalpy flow rate with medium specific attributes
ExtraPropertyType for unspecified, mass-specific property transported by flow
ExtraPropertyFlowRateType for flow rate of unspecified, mass-specific property
FixedPhasePhase of the fluid: 1 for 1-phase, 2 for two-phase, 0 for not known, e.g., interactive use
FluidConstants 
FluidLimitsValidity limits for fluid model
heatCapacity_cpAlias for deprecated name
heatCapacity_cvAlias for deprecated name
IdealGasThe ideal gas version of a record used in several degrees of detail
isentropicEnthalpyReturn isentropic enthalpy
IsentropicExponentType for isentropic exponent with medium specific attributes
isentropicExponentReturn isentropic exponent
IsobaricExpansionCoefficientType for isobaric expansion coefficient with medium specific attributes
isobaricExpansionCoefficientReturns overall the isobaric expansion coefficient beta
isothermalCompressibilityReturns overall the isothermal compressibility factor
kappaAlias of isothermalCompressibility for user convenience
MassFlowRateType for mass flow rate with medium specific attributes
MassFractionType for mass fraction with medium specific attributes
MolarMassType for molar mass with medium specific attributes
molarMassReturns the molar mass of the medium
MolarVolumeType for molar volume with medium specific attributes
MoleFractionType for mole fraction with medium specific attributes
PrandtlNumberType for Prandtl number with medium specific attributes
prandtlNumberReturn the Prandtl number
pressureReturn pressure of ideal gas
pressure_dTReturn pressure from d and T
SaturationPropertiesSaturation properties of two phase medium
setSmoothStateReturn thermodynamic state so that it smoothly approximates: if x > 0 then state_a else state_b
setState_dTReturn thermodynamic state from d and T
setState_dTXReturn thermodynamic state from d, T, and X or Xi
setState_phReturn thermodynamic state from p and h
setState_phXReturn thermodynamic state from p, h, and X or Xi
setState_psReturn thermodynamic state from p and s
setState_psXReturn thermodynamic state from p, s, and X or Xi
setState_pTReturn thermodynamic state from p and T
setState_pTXReturn thermodynamic state from p, T, and X or Xi
SpecificEnergyType for specific energy with medium specific attributes
SpecificEnthalpyType for specific enthalpy with medium specific attributes
specificEnthalpyReturn specific enthalpy
specificEnthalpy_dTReturn specific enthalpy from d and T
specificEnthalpy_psReturn specific enthalpy from p and s
specificEnthalpy_psXReturn specific enthalpy from p, s, and X or Xi
specificEnthalpy_pTReturn specific enthalpy from p and T
specificEnthalpy_pTXReturn specific enthalpy from p, T, and X or Xi
SpecificEntropyType for specific entropy with medium specific attributes
specificEntropyReturn specific entropy
specificEntropy_pTXReturn specific enthalpy from p, T, and X or Xi
specificGibbsEnergyReturn specific Gibbs energy
SpecificHeatCapacityType for specific heat capacity with medium specific attributes
specificHeatCapacityCpReturn specific heat capacity at constant pressure
specificHeatCapacityCvReturn specific heat capacity at constant volume
specificHelmholtzEnergyReturn specific Helmholtz energy
SpecificInternalEnergyType for specific internal energy with medium specific attributes
specificInternalEnergyReturn specific internal energy
SurfaceTensionType for surface tension with medium specific attributes
TemperatureType for temperature with medium specific attributes
temperatureReturn temperature of ideal gas
temperature_phReturn temperature from p and h
temperature_phXReturn temperature from p, h, and X or Xi
temperature_psReturn temperature from p and s
temperature_psXReturn temperature from p,s, and X or Xi
ThermalConductivityType for thermal conductivity with medium specific attributes
thermalConductivityReturn thermal conductivity
ThermodynamicStateThermodynamic state of ideal gas
TwoPhaseThe two phase fluid version of a record used in several degrees of detail
VelocityOfSoundType for velocity of sound with medium specific attributes
velocityOfSoundReturn velocity of sound

Package Constants

TypeNameValueDescription
FluidConstantsairConstants[nS]{Modelica.Media.Interfaces.Types.Basic.FluidConstants(iupacName = "simple air", casRegistryNumber = "not a real substance", chemicalFormula = "N2, O2", structureFormula = "N2, O2", molarMass = Modelica.Media.IdealGases.Common.SingleGasesData.N2.MM)}Constant data for the fluid
ExtraPropertyC_default[nC]fill(0, nC)Default value for trace substances of medium (for initialization)
RealC_nominal[nC]1e-6 * ones(nC)Default for the nominal values for the extra properties
SpecificHeatCapacitycp_const1005.45Constant specific heat capacity at constant pressure
SpecificHeatCapacitycv_constcp_const - R_gasConstant specific heat capacity at constant volume
DynamicViscosityeta_const1.82e-5Constant dynamic viscosity
StringextraPropertiesNames[:]fill("", 0)Names of the additional (extra) transported properties. Set extraPropertiesNames=fill("",0) if unused
final BooleanfixedXtrue= true if medium contains the equation X = reference_X
FluidConstantsfluidConstants[nS]airConstantsFluid constants
SpecificEnthalpyh_defaultspecificEnthalpy_pTX(p_default, T_default, X_default)Default value for specific enthalpy of medium (for initialization)
ThermalConductivitylambda_const0.026Constant thermal conductivity
StringmediumName"SimpleAir"Name of the medium
MolarMassMM_const0.0289651159Molar mass
final IntegernCsize(extraPropertiesNames, 1)Number of extra (outside of standard mass-balance) transported properties
final IntegernSsize(substanceNames, 1)Number of substances
IntegernXnSNumber of mass fractions
IntegernXiif fixedX then 0 else if reducedX then nS - 1 else nSNumber of structurally independent mass fractions (see docu for details)
AbsolutePressurep_default101325Default value for pressure of medium (for initialization)
SpecificHeatCapacityR_gas34.52428788658843 * Constants.RMedium specific gas constant
final BooleanreducedXtrue= true if medium contains the equation sum(X) = 1.0; set reducedX=true if only one substance (see docu for details)
AbsolutePressurereference_p101325Reference pressure of Medium: default 1 atmosphere
Temperaturereference_T298.15Reference temperature of Medium: default 25 deg Celsius
MassFractionreference_X[nX]fill(nX ^ (-1), nX)Default mass fractions of medium
final BooleansingleStatefalse= true, if u and d are not a function of pressure
StringsubstanceNames[:]{mediumName}Names of the mixture substances. Set substanceNames={mediumName} if only one substance.
TemperatureT0reference_TZero enthalpy temperature
TemperatureT_defaultModelica.SIunits.Conversions.from_degC(20)Default value for temperature of medium (for initialization)
TemperatureT_maxCv.from_degC(100)Maximum temperature valid for medium model
TemperatureT_minCv.from_degC(0)Minimum temperature valid for medium model
IndependentVariablesThermoStatesModelica.​Media.​Interfaces.​Choices.​IndependentVariables.​pTEnumeration type for independent variables
MassFractionX_default[nX]reference_XDefault value for mass fractions of medium (for initialization)

Type Modelica.​Media.​Air.​SimpleAir.​AbsolutePressure
Type for absolute pressure with medium specific attributes

Extends from Modelica.​SIunits.​AbsolutePressure.

Attributes

NameValue
quantity"Pressure"
unit"Pa"
displayUnit"bar"
min0
max1e+8
start100000
nominal100000

Type Modelica.​Media.​Air.​SimpleAir.​Density
Type for density with medium specific attributes

Extends from Modelica.​SIunits.​Density.

Attributes

NameValue
quantity"Density"
unit"kg/m3"
displayUnit"g/cm3"
min0
max100000
start1
nominal1

Type Modelica.​Media.​Air.​SimpleAir.​DynamicViscosity
Type for dynamic viscosity with medium specific attributes

Extends from Modelica.​SIunits.​DynamicViscosity.

Attributes

NameValue
quantity"DynamicViscosity"
unit"Pa.s"
min0
max1e+8
start0.001
nominal0.001

Type Modelica.​Media.​Air.​SimpleAir.​EnthalpyFlowRate
Type for enthalpy flow rate with medium specific attributes

Extends from Modelica.​SIunits.​EnthalpyFlowRate.

Attributes

NameValue
quantity"EnthalpyFlowRate"
unit"W"
min-1e+8
max1e+8
start0.
nominal1000

Type Modelica.​Media.​Air.​SimpleAir.​MassFraction
Type for mass fraction with medium specific attributes

Extends from Real.

Attributes

NameValue
quantity"MassFraction"
unit"kg/kg"
min0
max1
start0.
nominal0.1

Type Modelica.​Media.​Air.​SimpleAir.​MoleFraction
Type for mole fraction with medium specific attributes

Extends from Real.

Attributes

NameValue
quantity"MoleFraction"
unit"mol/mol"
min0
max1
start0.
nominal0.1

Type Modelica.​Media.​Air.​SimpleAir.​MolarMass
Type for molar mass with medium specific attributes

Extends from Modelica.​SIunits.​MolarMass.

Attributes

NameValue
quantity"MolarMass"
unit"kg/mol"
min0.001
max0.25
start0.
nominal0.032

Type Modelica.​Media.​Air.​SimpleAir.​MolarVolume
Type for molar volume with medium specific attributes

Extends from Modelica.​SIunits.​MolarVolume.

Attributes

NameValue
quantity"MolarVolume"
unit"m3/mol"
min1e-6
max1000000
start0.
nominal1

Type Modelica.​Media.​Air.​SimpleAir.​IsentropicExponent
Type for isentropic exponent with medium specific attributes

Extends from Modelica.​SIunits.​RatioOfSpecificHeatCapacities.

Attributes

NameValue
quantity"RatioOfSpecificHeatCapacities"
unit"1"
min1
max500000
start1.2
nominal1.2

Type Modelica.​Media.​Air.​SimpleAir.​SpecificEnergy
Type for specific energy with medium specific attributes

Extends from Modelica.​SIunits.​SpecificEnergy.

Attributes

NameValue
quantity"SpecificEnergy"
unit"J/kg"
min-1e+8
max1e+8
start0.
nominal1000000

Type Modelica.​Media.​Air.​SimpleAir.​SpecificInternalEnergy
Type for specific internal energy with medium specific attributes

Extends from Modelica.​Media.​Air.​SimpleAir.​SpecificEnergy (Type for specific energy with medium specific attributes).

Attributes

NameValue
quantity"SpecificEnergy"
unit"J/kg"
min-1e+8
max1e+8
start0.
nominal1000000

Type Modelica.​Media.​Air.​SimpleAir.​SpecificEnthalpy
Type for specific enthalpy with medium specific attributes

Extends from Modelica.​SIunits.​SpecificEnthalpy.

Attributes

NameValue
quantity"SpecificEnergy"
unit"J/kg"
min-1e+10
max1e+10
start0.
nominal1000000

Type Modelica.​Media.​Air.​SimpleAir.​SpecificEntropy
Type for specific entropy with medium specific attributes

Extends from Modelica.​SIunits.​SpecificEntropy.

Attributes

NameValue
quantity"SpecificEntropy"
unit"J/(kg.K)"
min-1e+7
max1e+7
start0.
nominal1000

Type Modelica.​Media.​Air.​SimpleAir.​SpecificHeatCapacity
Type for specific heat capacity with medium specific attributes

Extends from Modelica.​SIunits.​SpecificHeatCapacity.

Attributes

NameValue
quantity"SpecificHeatCapacity"
unit"J/(kg.K)"
min0
max1e+7
start1000
nominal1000

Type Modelica.​Media.​Air.​SimpleAir.​SurfaceTension
Type for surface tension with medium specific attributes

Extends from Modelica.​SIunits.​SurfaceTension.

Attributes

NameValue
quantity"SurfaceTension"
unit"N/m"
min-Modelica.Constants.inf
maxModelica.Constants.inf
start0.

Type Modelica.​Media.​Air.​SimpleAir.​Temperature
Type for temperature with medium specific attributes

Extends from Modelica.​SIunits.​Temperature.

Attributes

NameValue
quantity"ThermodynamicTemperature"
unit"K"
displayUnit"degC"
minModelica.SIunits.Conversions.from_degC(0)
maxModelica.SIunits.Conversions.from_degC(100)
start288.15
nominal300

Type Modelica.​Media.​Air.​SimpleAir.​ThermalConductivity
Type for thermal conductivity with medium specific attributes

Extends from Modelica.​SIunits.​ThermalConductivity.

Attributes

NameValue
quantity"ThermalConductivity"
unit"W/(m.K)"
min0
max500
start1
nominal1

Type Modelica.​Media.​Air.​SimpleAir.​PrandtlNumber
Type for Prandtl number with medium specific attributes

Extends from Modelica.​SIunits.​PrandtlNumber.

Attributes

NameValue
quantity"PrandtlNumber"
unit"1"
min0.001
max100000
start0.
nominal1

Type Modelica.​Media.​Air.​SimpleAir.​VelocityOfSound
Type for velocity of sound with medium specific attributes

Extends from Modelica.​SIunits.​Velocity.

Attributes

NameValue
quantity"Velocity"
unit"m/s"
min0
max100000
start1000
nominal1000

Type Modelica.​Media.​Air.​SimpleAir.​ExtraProperty
Type for unspecified, mass-specific property transported by flow

Extends from Real.

Attributes

NameValue
min0
maxModelica.Constants.inf
start1

Type Modelica.​Media.​Air.​SimpleAir.​CumulativeExtraProperty
Type for conserved integral of unspecified, mass specific property

Extends from Real.

Attributes

NameValue
min0
maxModelica.Constants.inf
start1

Type Modelica.​Media.​Air.​SimpleAir.​ExtraPropertyFlowRate
Type for flow rate of unspecified, mass-specific property

Extends from Real.

Attributes

NameValue
unit"kg/s"
min-Modelica.Constants.inf
maxModelica.Constants.inf
start0.

Type Modelica.​Media.​Air.​SimpleAir.​IsobaricExpansionCoefficient
Type for isobaric expansion coefficient with medium specific attributes

Extends from Real.

Attributes

NameValue
unit"1/K"
min0
max1e+8
start0.

Type Modelica.​Media.​Air.​SimpleAir.​DipoleMoment
Type for dipole moment with medium specific attributes

Extends from Real.

Attributes

NameValue
quantity"ElectricDipoleMoment"
unit"debye"
min0
max2
start0.

Type Modelica.​Media.​Air.​SimpleAir.​DerDensityByPressure
Type for partial derivative of density with respect to pressure with medium specific attributes

Extends from Modelica.​SIunits.​DerDensityByPressure.

Attributes

NameValue
unit"s2/m2"
min-Modelica.Constants.inf
maxModelica.Constants.inf
start0.

Type Modelica.​Media.​Air.​SimpleAir.​DerDensityByEnthalpy
Type for partial derivative of density with respect to enthalpy with medium specific attributes

Extends from Modelica.​SIunits.​DerDensityByEnthalpy.

Attributes

NameValue
unit"kg.s2/m5"
min-Modelica.Constants.inf
maxModelica.Constants.inf
start0.

Type Modelica.​Media.​Air.​SimpleAir.​DerEnthalpyByPressure
Type for partial derivative of enthalpy with respect to pressure with medium specific attributes

Extends from Modelica.​SIunits.​DerEnthalpyByPressure.

Attributes

NameValue
unit"J.m.s2/kg2"
min-Modelica.Constants.inf
maxModelica.Constants.inf
start0.

Type Modelica.​Media.​Air.​SimpleAir.​DerDensityByTemperature
Type for partial derivative of density with respect to temperature with medium specific attributes

Extends from Modelica.​SIunits.​DerDensityByTemperature.

Attributes

NameValue
unit"kg/(m3.K)"
min-Modelica.Constants.inf
maxModelica.Constants.inf
start0.

Type Modelica.​Media.​Air.​SimpleAir.​DerTemperatureByPressure
Type for partial derivative of temperature with respect to pressure with medium specific attributes

Extends from Real.

Attributes

NameValue
unit"K/Pa"
min-Modelica.Constants.inf
maxModelica.Constants.inf
start0.

Record Modelica.​Media.​Air.​SimpleAir.​SaturationProperties
Saturation properties of two phase medium

Information

This icon is indicates a record.

Extends from Modelica.​Icons.​Record (Icon for records).

Fields

TypeNameDescription
AbsolutePressurepsatSaturation pressure
TemperatureTsatSaturation temperature

Record Modelica.​Media.​Air.​SimpleAir.​FluidLimits
Validity limits for fluid model

Information

The minimum pressure mostly applies to the liquid state only. The minimum density is also arbitrary, but is reasonable for technical applications to limit iterations in non-linear systems. The limits in enthalpy and entropy are used as safeguards in inverse iterations.

Extends from Modelica.​Icons.​Record (Icon for records).

Fields

TypeNameDescription
TemperatureTMINMinimum temperature
TemperatureTMAXMaximum temperature
DensityDMINMinimum density
DensityDMAXMaximum density
AbsolutePressurePMINMinimum pressure
AbsolutePressurePMAXMaximum pressure
SpecificEnthalpyHMINMinimum enthalpy
SpecificEnthalpyHMAXMaximum enthalpy
SpecificEntropySMINMinimum entropy
SpecificEntropySMAXMaximum entropy

Type Modelica.​Media.​Air.​SimpleAir.​FixedPhase
Phase of the fluid: 1 for 1-phase, 2 for two-phase, 0 for not known, e.g., interactive use

Extends from Integer.

Attributes

NameValue
min0
max2
start0

Record Modelica.​Media.​Air.​SimpleAir.​FluidConstants
Critical, triple, molecular and other standard data of fluid

Information

This icon is indicates a record.

Extends from Modelica.​Media.​Interfaces.​Types.​Basic.​FluidConstants (Critical, triple, molecular and other standard data of fluid).

Fields

TypeNameDescription
StringiupacNameComplete IUPAC name (or common name, if non-existent)
StringcasRegistryNumberChemical abstracts sequencing number (if it exists)
StringchemicalFormulaChemical formula, (brutto, nomenclature according to Hill
StringstructureFormulaChemical structure formula
MolarMassmolarMassMolar mass

Record Modelica.​Media.​Air.​SimpleAir.​ThermodynamicState
Thermodynamic state of ideal gas

Information

This icon is indicates a record.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​ThermodynamicState (Minimal variable set that is available as input argument to every medium function).

Fields

TypeNameDescription
AbsolutePressurepAbsolute pressure of medium
TemperatureTTemperature of medium

Model Modelica.​Media.​Air.​SimpleAir.​BaseProperties
Base properties of ideal gas

Information

This is the most simple incompressible medium model, where specific enthalpy h and specific internal energy u are only a function of temperature T and all other provided medium quantities are assumed to be constant.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​BaseProperties.

Parameters

TypeNameDefaultDescription
BooleanpreferredMediumStatesfalse= true if StateSelect.prefer shall be used for the independent property variables of the medium
final BooleanstandardOrderComponentstrueIf true, and reducedX = true, the last element of X will be computed from the other ones

Connectors

TypeNameDescription
input InputAbsolutePressurepAbsolute pressure of medium
input InputMassFractionXi[nXi]Structurally independent mass fractions
input InputSpecificEnthalpyhSpecific enthalpy of medium

Function Modelica.​Media.​Air.​SimpleAir.​setState_pTX
Return thermodynamic state from p, T, and X or Xi

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
TemperatureTTemperature
MassFractionX[:]Mass fractions

Outputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Function Modelica.​Media.​Air.​SimpleAir.​setState_phX
Return thermodynamic state from p, h, and X or Xi

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
SpecificEnthalpyhSpecific enthalpy
MassFractionX[:]Mass fractions

Outputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Function Modelica.​Media.​Air.​SimpleAir.​setState_psX
Return thermodynamic state from p, s, and X or Xi

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
SpecificEntropysSpecific entropy
MassFractionX[:]Mass fractions

Outputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Function Modelica.​Media.​Air.​SimpleAir.​setState_dTX
Return thermodynamic state from d, T, and X or Xi

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
DensitydDensity
TemperatureTTemperature
MassFractionX[:]Mass fractions

Outputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Function Modelica.​Media.​Air.​SimpleAir.​setSmoothState
Return thermodynamic state so that it smoothly approximates: if x > 0 then state_a else state_b

Information

This function is used to approximate the equation

    state = if x > 0 then state_a else state_b;

by a smooth characteristic, so that the expression is continuous and differentiable:

   state := smooth(1, if x >  x_small then state_a else
                      if x < -x_small then state_b else f(state_a, state_b));

This is performed by applying function Media.Common.smoothStep(..) on every element of the thermodynamic state record.

If mass fractions X[:] are approximated with this function then this can be performed for all nX mass fractions, instead of applying it for nX-1 mass fractions and computing the last one by the mass fraction constraint sum(X)=1. The reason is that the approximating function has the property that sum(state.X) = 1, provided sum(state_a.X) = sum(state_b.X) = 1. This can be shown by evaluating the approximating function in the abs(x) < x_small region (otherwise state.X is either state_a.X or state_b.X):

    X[1]  = smoothStep(x, X_a[1] , X_b[1] , x_small);
    X[2]  = smoothStep(x, X_a[2] , X_b[2] , x_small);
       ...
    X[nX] = smoothStep(x, X_a[nX], X_b[nX], x_small);

or

    X[1]  = c*(X_a[1]  - X_b[1])  + (X_a[1]  + X_b[1])/2
    X[2]  = c*(X_a[2]  - X_b[2])  + (X_a[2]  + X_b[2])/2;
       ...
    X[nX] = c*(X_a[nX] - X_b[nX]) + (X_a[nX] + X_b[nX])/2;
    c     = (x/x_small)*((x/x_small)^2 - 3)/4

Summing all mass fractions together results in

    sum(X) = c*(sum(X_a) - sum(X_b)) + (sum(X_a) + sum(X_b))/2
           = c*(1 - 1) + (1 + 1)/2
           = 1

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​setSmoothState (Return thermodynamic state so that it smoothly approximates: if x > 0 then state_a else state_b).

Inputs

TypeNameDescription
Realxm_flow or dp
ThermodynamicStatestate_aThermodynamic state if x > 0
ThermodynamicStatestate_bThermodynamic state if x < 0
Realx_smallSmooth transition in the region -x_small < x < x_small

Outputs

TypeNameDescription
ThermodynamicStatestateSmooth thermodynamic state for all x (continuous and differentiable)

Function Modelica.​Media.​Air.​SimpleAir.​dynamicViscosity
Return dynamic viscosity

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​dynamicViscosity (Return dynamic viscosity).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
DynamicViscosityetaDynamic viscosity

Function Modelica.​Media.​Air.​SimpleAir.​thermalConductivity
Return thermal conductivity

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​thermalConductivity (Return thermal conductivity).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
ThermalConductivitylambdaThermal conductivity

Function Modelica.​Media.​Air.​SimpleAir.​prandtlNumber
Return the Prandtl number

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
PrandtlNumberPrPrandtl number

Function Modelica.​Media.​Air.​SimpleAir.​pressure
Return pressure of ideal gas

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​pressure (Return pressure).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
AbsolutePressurepPressure

Function Modelica.​Media.​Air.​SimpleAir.​temperature
Return temperature of ideal gas

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​temperature (Return temperature).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
TemperatureTTemperature

Function Modelica.​Media.​Air.​SimpleAir.​density
Return density of ideal gas

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​density (Return density).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
DensitydDensity

Function Modelica.​Media.​Air.​SimpleAir.​specificEnthalpy
Return specific enthalpy

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​specificEnthalpy (Return specific enthalpy) and Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEnthalpyhSpecific enthalpy

Function Modelica.​Media.​Air.​SimpleAir.​specificInternalEnergy
Return specific internal energy

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​specificInternalEnergy (Return specific internal energy) and Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEnergyuSpecific internal energy

Function Modelica.​Media.​Air.​SimpleAir.​specificEntropy
Return specific entropy

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​specificEntropy (Return specific entropy) and Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEntropysSpecific entropy

Function Modelica.​Media.​Air.​SimpleAir.​specificGibbsEnergy
Return specific Gibbs energy

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​specificGibbsEnergy (Return specific Gibbs energy) and Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEnergygSpecific Gibbs energy

Function Modelica.​Media.​Air.​SimpleAir.​specificHelmholtzEnergy
Return specific Helmholtz energy

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​specificHelmholtzEnergy (Return specific Helmholtz energy) and Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEnergyfSpecific Helmholtz energy

Function Modelica.​Media.​Air.​SimpleAir.​specificHeatCapacityCp
Return specific heat capacity at constant pressure

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​specificHeatCapacityCp (Return specific heat capacity at constant pressure).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificHeatCapacitycpSpecific heat capacity at constant pressure

Function Modelica.​Media.​Air.​SimpleAir.​heatCapacity_cp
Alias for deprecated name

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Air.​SimpleAir.​specificHeatCapacityCp (Return specific heat capacity at constant pressure).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificHeatCapacitycpSpecific heat capacity at constant pressure

Function Modelica.​Media.​Air.​SimpleAir.​specificHeatCapacityCv
Return specific heat capacity at constant volume

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​specificHeatCapacityCv (Return specific heat capacity at constant volume).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificHeatCapacitycvSpecific heat capacity at constant volume

Function Modelica.​Media.​Air.​SimpleAir.​heatCapacity_cv
Alias for deprecated name

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Air.​SimpleAir.​specificHeatCapacityCv (Return specific heat capacity at constant volume).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificHeatCapacitycvSpecific heat capacity at constant volume

Function Modelica.​Media.​Air.​SimpleAir.​isentropicExponent
Return isentropic exponent

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​isentropicExponent (Return isentropic exponent).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
IsentropicExponentgammaIsentropic exponent

Function Modelica.​Media.​Air.​SimpleAir.​isentropicEnthalpy
Return isentropic enthalpy

Information

This function computes an isentropic state transformation:

  1. A medium is in a particular state, refState.
  2. The enthalpy at another state (h_is) shall be computed under the assumption that the state transformation from refState to h_is is performed with a change of specific entropy ds = 0 and the pressure of state h_is is p_downstream and the composition X upstream and downstream is assumed to be the same.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​isentropicEnthalpy (Return isentropic enthalpy).

Inputs

TypeNameDescription
AbsolutePressurep_downstreamDownstream pressure
ThermodynamicStaterefStateReference state for entropy

Outputs

TypeNameDescription
SpecificEnthalpyh_isIsentropic enthalpy

Function Modelica.​Media.​Air.​SimpleAir.​velocityOfSound
Return velocity of sound

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​velocityOfSound (Return velocity of sound).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
VelocityOfSoundaVelocity of sound

Function Modelica.​Media.​Air.​SimpleAir.​isobaricExpansionCoefficient
Returns overall the isobaric expansion coefficient beta

Information

beta is defined as  1/v * der(v,T), with v = 1/d, at constant pressure p.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​isobaricExpansionCoefficient (Return overall the isobaric expansion coefficient beta).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
IsobaricExpansionCoefficientbetaIsobaric expansion coefficient

Function Modelica.​Media.​Air.​SimpleAir.​beta
Alias for isobaricExpansionCoefficient for user convenience

Information

beta is defined as  1/v * der(v,T), with v = 1/d, at constant pressure p.

Extends from Modelica.​Media.​Air.​SimpleAir.​isobaricExpansionCoefficient (Returns overall the isobaric expansion coefficient beta).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
IsobaricExpansionCoefficientbetaIsobaric expansion coefficient

Function Modelica.​Media.​Air.​SimpleAir.​isothermalCompressibility
Returns overall the isothermal compressibility factor

Information


kappa is defined as - 1/v * der(v,p), with v = 1/d at constant temperature T.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​isothermalCompressibility (Return overall the isothermal compressibility factor).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
IsothermalCompressibilitykappaIsothermal compressibility

Function Modelica.​Media.​Air.​SimpleAir.​kappa
Alias of isothermalCompressibility for user convenience

Information


kappa is defined as - 1/v * der(v,p), with v = 1/d at constant temperature T.

Extends from Modelica.​Media.​Air.​SimpleAir.​isothermalCompressibility (Returns overall the isothermal compressibility factor).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
IsothermalCompressibilitykappaIsothermal compressibility

Partial Function Modelica.​Media.​Air.​SimpleAir.​density_derp_h
Return density derivative w.r.t. pressure at const specific enthalpy

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
DerDensityByPressureddphDensity derivative w.r.t. pressure

Partial Function Modelica.​Media.​Air.​SimpleAir.​density_derh_p
Return density derivative w.r.t. specific enthalpy at constant pressure

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
DerDensityByEnthalpyddhpDensity derivative w.r.t. specific enthalpy

Function Modelica.​Media.​Air.​SimpleAir.​density_derp_T
Returns the partial derivative of density with respect to pressure at constant temperature

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​density_derp_T (Return density derivative w.r.t. pressure at const temperature).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
DerDensityByPressureddpTDensity derivative w.r.t. pressure

Function Modelica.​Media.​Air.​SimpleAir.​density_derT_p
Returns the partial derivative of density with respect to temperature at constant pressure

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​density_derT_p (Return density derivative w.r.t. temperature at constant pressure).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
DerDensityByTemperatureddTpDensity derivative w.r.t. temperature

Function Modelica.​Media.​Air.​SimpleAir.​density_derX
Returns the partial derivative of density with respect to mass fractions at constant pressure and temperature

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​density_derX (Return density derivative w.r.t. mass fraction).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
DensitydddX[nX]Derivative of density w.r.t. mass fraction

Function Modelica.​Media.​Air.​SimpleAir.​molarMass
Returns the molar mass of the medium

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialPureSubstance.​molarMass (Return the molar mass of the medium).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
MolarMassMMMixture molar mass

Function Modelica.​Media.​Air.​SimpleAir.​specificEnthalpy_pTX
Return specific enthalpy from p, T, and X or Xi

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
TemperatureTTemperature
MassFractionX[nX]Mass fractions

Outputs

TypeNameDescription
SpecificEnthalpyhSpecific enthalpy at p, T, X

Function Modelica.​Media.​Air.​SimpleAir.​specificEntropy_pTX
Return specific enthalpy from p, T, and X or Xi

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
TemperatureTTemperature
MassFractionX[:]Mass fractions

Outputs

TypeNameDescription
SpecificEntropysSpecific entropy

Function Modelica.​Media.​Air.​SimpleAir.​density_pTX
Return density from p, T, and X or Xi

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
TemperatureTTemperature
MassFractionX[:]Mass fractions

Outputs

TypeNameDescription
DensitydDensity

Function Modelica.​Media.​Air.​SimpleAir.​temperature_phX
Return temperature from p, h, and X or Xi

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
SpecificEnthalpyhSpecific enthalpy
MassFractionX[nX]Mass fractions

Outputs

TypeNameDescription
TemperatureTTemperature

Function Modelica.​Media.​Air.​SimpleAir.​density_phX
Return density from p, h, and X or Xi

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
SpecificEnthalpyhSpecific enthalpy
MassFractionX[nX]Mass fractions

Outputs

TypeNameDescription
DensitydDensity

Function Modelica.​Media.​Air.​SimpleAir.​temperature_psX
Return temperature from p,s, and X or Xi

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
SpecificEntropysSpecific entropy
MassFractionX[:]Mass fractions

Outputs

TypeNameDescription
TemperatureTTemperature

Function Modelica.​Media.​Air.​SimpleAir.​density_psX
Return density from p, s, and X or Xi

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
SpecificEntropysSpecific entropy
MassFractionX[:]Mass fractions

Outputs

TypeNameDescription
DensitydDensity

Function Modelica.​Media.​Air.​SimpleAir.​specificEnthalpy_psX
Return specific enthalpy from p, s, and X or Xi

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
SpecificEntropysSpecific entropy
MassFractionX[:]Mass fractions

Outputs

TypeNameDescription
SpecificEnthalpyhSpecific enthalpy

Type Modelica.​Media.​Air.​SimpleAir.​MassFlowRate
Type for mass flow rate with medium specific attributes

Extends from Modelica.​SIunits.​MassFlowRate.

Attributes

NameValue
quantity"MassFlowRate." + mediumName
unit"kg/s"
min-100000
max100000
start0.

Function Modelica.​Media.​Air.​SimpleAir.​setState_pT
Return thermodynamic state from p and T

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
TemperatureTTemperature

Outputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Function Modelica.​Media.​Air.​SimpleAir.​setState_ph
Return thermodynamic state from p and h

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
SpecificEnthalpyhSpecific enthalpy

Outputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Function Modelica.​Media.​Air.​SimpleAir.​setState_ps
Return thermodynamic state from p and s

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
SpecificEntropysSpecific entropy

Outputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Function Modelica.​Media.​Air.​SimpleAir.​setState_dT
Return thermodynamic state from d and T

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
DensitydDensity
TemperatureTTemperature

Outputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Function Modelica.​Media.​Air.​SimpleAir.​density_ph
Return density from p and h

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
SpecificEnthalpyhSpecific enthalpy

Outputs

TypeNameDescription
DensitydDensity

Function Modelica.​Media.​Air.​SimpleAir.​temperature_ph
Return temperature from p and h

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
SpecificEnthalpyhSpecific enthalpy

Outputs

TypeNameDescription
TemperatureTTemperature

Function Modelica.​Media.​Air.​SimpleAir.​pressure_dT
Return pressure from d and T

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
DensitydDensity
TemperatureTTemperature

Outputs

TypeNameDescription
AbsolutePressurepPressure

Function Modelica.​Media.​Air.​SimpleAir.​specificEnthalpy_dT
Return specific enthalpy from d and T

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
DensitydDensity
TemperatureTTemperature

Outputs

TypeNameDescription
SpecificEnthalpyhSpecific enthalpy

Function Modelica.​Media.​Air.​SimpleAir.​specificEnthalpy_ps
Return specific enthalpy from p and s

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
SpecificEntropysSpecific entropy

Outputs

TypeNameDescription
SpecificEnthalpyhSpecific enthalpy

Function Modelica.​Media.​Air.​SimpleAir.​temperature_ps
Return temperature from p and s

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
SpecificEntropysSpecific entropy

Outputs

TypeNameDescription
TemperatureTTemperature

Function Modelica.​Media.​Air.​SimpleAir.​density_ps
Return density from p and s

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
SpecificEntropysSpecific entropy

Outputs

TypeNameDescription
DensitydDensity

Function Modelica.​Media.​Air.​SimpleAir.​specificEnthalpy_pT
Return specific enthalpy from p and T

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
TemperatureTTemperature

Outputs

TypeNameDescription
SpecificEnthalpyhSpecific enthalpy

Function Modelica.​Media.​Air.​SimpleAir.​density_pT
Return density from p and T

Information

This icon indicates Modelica functions.

Extends from Modelica.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
AbsolutePressurepPressure
TemperatureTTemperature

Outputs

TypeNameDescription
DensitydDensity