Package Modelica.​Media.​Air.​ReferenceMoistAir
ReferenceMoistAir: Detailed moist air model (143.15 ... 2000 K)

Information

Calculation of fluid properties for moist air in the region from 143.15 Kelvin to 2000 Kelvin at pressures up to 10 MPa. This model of moist air is based on the diploma thesis of Hellriegel [10] with small modifications. Moist air is treated as an ideal mixture of the real fluids air and water.

Restriction

The functions provided by this package shall be used inside of the restricted limits according to the referenced literature.

Usage

The package MoistAir can be used as any other medium model (see User's Guide of Media Library for further information). The package defines two boolean constants useEnhancementFactor and useDissociation, which give the user fine grained control of the calculations.

Constant Default Value Meaning
useEnhancementFactor false The enhancement factor is used in the calculation of the saturation partial pressure of water in moist air. It is always very close to 1 except for high pressures (>2 MPa) and low temperatures (<233.15 K). For pressures less than 1 MPa this factor can be safely set to 1. Its calculation is very expensive, since it can only be calculated by an iterative method.
useDissociation true The effect of dissociation is taken into account for temperatures greater than 773.15 K.

Calculation algorithms

Nomenclature
p Mixture pressure in Pa
T Temperature in K
xw Absolutue humidity in kg(water)/kg(dry air)
xws Absolutue humidity on saturation boundary in kg(water)/kg(dry air)
φ Relative humidity (only defined for unsaturated humid air)
Unsaturated and saturated humid air (0 ≤ xw ≤ xws)

Ideal mixture of dry air and steam

Supersaturated humid air (liquid fog and ice fog)

Liquid fog (xw > xwsw) and T ≥ 273.16 K

Ideal mixture of saturated humid air and water

Ice fog (xw > xwsw) and T < 273.16 K

Ideal mixture of saturated humid air and ice

Saturation pressure of water in moist air

The saturation pressure pds of water in moist air is calculated by pds = f*psat, where

Dissociation

For temperatures above 773.15 K effects of dissociation are taken into account. Dissociation is modeled according to [11]. For high temperatures the calculated values for moist air with 0 kg(water)/kg(dry air) (i.e. dry air) may differ from those calculated by the package Modelica.Media.Air.ReferenceAir, because there no dissociation is considered.

References

[1] Thermodynamic Properties of Air and Mixtures of Nitrogen, Argon, and Oxygen From 60 to 2000 K at Pressures to 2000 MPa. J. Phys. Chem. Ref. Data, Vol. 29, No. 3, 2000.
[2] Viscosity and Thermal Conductivity Equations for Nitrogen, Oxygen, Argon, and Air. International Journal of Thermophysics, Vol. 25, No. 1, January 2004
[3] Revised Release on the IAPWS Formulation 1995 for the Thermodynamic Properties of Ordinary Water Substance for General and Scientific Use. 2009 International Association for the Properties of Water and Steam.
[4] Revised Release on the IAPWS Industrial Formulation 1997 for the Thermodynamic Properties of Water and Steam. 2007 International Association for the Properties of Water and Steam.
[5] Release on the IAPWS Formulation 2008 for the Viscosity of Ordinary Water Substance. 2008 International Association for the Properties of Water and Steam
[6] Release on the IAPWS Formulation 2011 for the Thermal Conductivity of Ordinary Water Substance. 2011 International Association for the Properties of Water and Steam.
[7] Revised Release on the Equation of State 2006 for H2O Ice Ih. 2009 International Association for the Properties of Water and Steam.
[8] Revised Release on the Pressure along the Melting and Sublimation Curves of Ordinary Water Substance. 2011 International Association for the Properties of Water and Steam.
[9] Determination of Thermodynamic and Transport Properties of Humid Air for Power-Cycle Calculations. 2009 PTB, Braunschweig, Germany.
[10] Berechnung der thermodynamischen Zustandsfunktionen von feuchter Luft in energietechnischen Prozessmodellierungen. 2001 Diplomarbeit, Zittau.
[11] Thermodynamische Stoffwerte von feuchter Luft und Verbrennungsgasen. 2003 VDI-Richtlinie 4670.
[12] Wärmeübertragung in Dampferzeugern und Wärmetauschern. 1985 FDBR-Fachbuchreihe, Bd. 2, Vulkan Verlag Essen.

References

Lemmon, E. W., Jacobsen, R. T., Penoncello, S. G., Friend, D. G.:
Thermodynamic Properties of Air and Mixtures of Nitrogen, Argon, and Oxygen From 60 to 2000 K at Pressures to 2000 MPa. J. Phys. Chem. Ref. Data, Vol. 29, No. 3, 2000.
Lemmon, E. W., Jacobsen, R. T.:
Viscosity and Thermal Conductivity Equations for Nitrogen, Oxygen, Argon, and Air. International Journal of Thermophysics, Vol. 25, No. 1, January 2004

Verification

The verification report for the development of this library is provided here.

Acknowledgment

This library was developed by XRG Simulation GmbH as part of the Clean Sky JTI project (Project title: MoMoLib-Modelica Model Library Development for Media, Magnetic Systems and Wavelets; Project number: 296369; Theme: JTI-CS-2011-1-SGO-02-026: Modelica Model Library Development Part I). The partial financial support for the development of this library by the European Union is highly appreciated.

Some parts of this library refer to the ThermoFluid library developed at Lund University (http://thermofluid.sourceforge.net).

Copyright © 2013-2019, Modelica Association and contributors

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases (Base class for mixtures of real condensing and non-condensing gases).

Package Contents

NameDescription
AbsolutePressureType for absolute pressure with medium specific attributes
BasePropertiesMoist air base properties record
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
densityReturns density as a function of the thermodynamic state record
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_TReturn density derivative w.r.t. pressure at const temperature
density_derT_pReturn density derivative w.r.t. temperature at constant pressure
density_derXReturn density derivative w.r.t. mass fraction
density_phXReturn density from p, h, and X or Xi
density_psXReturn density from p, s, and X or Xi
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 as a function of the thermodynamic state record, valid from 73.15 K to 373.15 K
EnthalpyFlowRateType for enthalpy flow rate with medium specific attributes
enthalpyOfCondensingGasReturn specific enthalpy of steam
enthalpyOfDryAirReturn specific enthalpy of dry air
enthalpyOfGasReturn specific enthalpy of gas (air and steam)
enthalpyOfLiquidReturn enthalpy of liquid water
enthalpyOfNonCondensingGasReturn specific enthalpy of dry air
enthalpyOfVaporizationReturn enthalpy of vaporization of water
enthalpyOfWaterReturn specific enthalpy of water (solid + liquid + steam)
enthalpyOfWaterNonVaporReturn enthalpy of liquid and solid water
enthalpyOfWaterVaporReturn specific enthalpy of steam
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
gasConstantReturn ideal gas constant as a function from thermodynamic state, only valid for phi<1
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
isobaricExpansionCoefficientReturn overall the isobaric expansion coefficient beta
isothermalCompressibilityReturn 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
massFraction_pTphiReturn mass fractions as a function of pressure, temperature and relative humidity
massFraction_waterContentReturn mass fractions as a function of pressure, temperature and absolute humidity in kg(water)/kg(dry air)
massFractionSaturationReturn saturation mass fractions
massFractionSaturation_ppsatReturn mass fvraction at saturation boundary given pressure and saturation pressure
massFractionWaterNonVaporReturn mass fraction of liquid and solid water
massFractionWaterVaporReturn mass fraction of water vapor
massToMoleFractionsReturn mole fractions from mass fractions X
MolarMassType for molar mass with medium specific attributes
molarMassReturn the molar mass of the medium
MolarVolumeType for molar volume with medium specific attributes
MoleFractionType for mole fraction with medium specific attributes
moleToMassFractionsReturn mass fractions X from mole fractions
PrandtlNumberType for Prandtl number with medium specific attributes
prandtlNumberReturn the Prandtl number
pressureReturns pressure of ideal gas as a function of the thermodynamic state record
relativeHumidityReturn relative humidity
saturationPressureReturn saturation pressure of condensing fluid
saturationPressureLiquidReturn saturation pressure of water as a function of temperature T
SaturationPropertiesSaturation properties of two phase medium
saturationTemperatureReturn saturation temperature of condensing fluid
setSmoothStateReturn thermodynamic state so that it smoothly approximates: if x > 0 then state_a else state_b
setState_dTXReturn thermodynamic state as function of density d, temperature T and composition X
setState_phXReturn thermodynamic state as function of pressure p, specific enthalpy h and composition X
setState_psXReturn thermodynamic state as function of pressure p, specific enthalpy h and composition X
setState_pTXReturn thermodynamic state as function of pressure p, temperature T and composition X
SpecificEnergyType for specific energy with medium specific attributes
SpecificEnthalpyType for specific enthalpy with medium specific attributes
specificEnthalpyReturn specific enthalpy of moist air as a function of the thermodynamic state record
specificEnthalpy_psXReturn specific enthalpy from p, s, and X or Xi
specificEnthalpy_pTXReturn specific enthalpy from p, T, and X or Xi
SpecificEntropyType for specific entropy with medium specific attributes
specificEntropyReturn specific entropy from thermodynamic state record, only valid for phi<1
specificEntropy_phXReturn specific entropy as a function of pressure, specific enthalpy and mass fractions
specificEntropy_pTXReturn specific enthalpy from p, T, and X or Xi
specificGibbsEnergyReturn specific Gibbs energy as a function of the thermodynamic state record, only valid for phi<1
SpecificHeatCapacityType for specific heat capacity with medium specific attributes
specificHeatCapacityCpReturn specific heat capacity at constant pressure as a function of the thermodynamic state record
specificHeatCapacityCvReturn specific heat capacity at constant volume as a function of the thermodynamic state record
specificHelmholtzEnergyReturn specific Helmholtz energy as a function of the thermodynamic state record, only valid for phi<1
SpecificInternalEnergyType for specific internal energy with medium specific attributes
specificInternalEnergyReturn specific internal energy of moist air as a function of the thermodynamic state record
sublimationPressureIceReturn sublimation pressure of water as a function of temperature T between 223.16 and 273.16 K
SurfaceTensionType for surface tension with medium specific attributes
TemperatureType for temperature with medium specific attributes
temperatureReturn temperature of ideal gas as a function of the thermodynamic state record
temperature_phXReturn temperature from p, h, and X or Xi
temperature_psXReturn temperature from p,s, and X or Xi
ThermalConductivityType for thermal conductivity with medium specific attributes
thermalConductivityReturn thermal conductivity as a function of the thermodynamic state record, valid from 73.15 K to 373.15 K
ThermodynamicStateThermodynamicState record for moist air
TwoPhaseThe two phase fluid version of a record used in several degrees of detail
UtilitiesUtility package for moist air
VelocityOfSoundType for velocity of sound with medium specific attributes
velocityOfSoundReturn velocity of sound
waterContent_XReturn water content in kg(water)/kg(dry air) given mass fractions
XsaturationReturn absolute humitity per unit mass of moist air at saturation as a function of the thermodynamic state record
xsaturationReturn absolute humitity per unit mass of dry air at saturation as a function of the thermodynamic state record

Package Constants

TypeNameValueDescription
IntegerAir2Index of air (in substanceNames, massFractions X, etc.)
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
FundamentalConstantsdryairReferenceAir.​Air_Utilities.​Basic.​Constants 
StringextraPropertiesNames[:]fill("", 0)Names of the additional (extra) transported properties. Set extraPropertiesNames=fill("",0) if unused
final BooleanfixedXfalse= true if medium contains the equation X = reference_X
FluidConstantsfluidConstants[nS]{Utilities.Water95_Utilities.waterConstants, Modelica.Media.Air.ReferenceAir.airConstants}Constant data for the fluid
SpecificEnthalpyh_defaultspecificEnthalpy_pTX(p_default, T_default, X_default)Default value for specific enthalpy of medium (for initialization)
Realk_mairsteam.MM / dryair.MMRatio of molar weights
StringmediumName"Moist air"Name of the medium
MolarMassMMX[2]{steam.MM, dryair.MM}Molar masses of components
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)
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]{0.01, 0.99}Default mass fractions of medium
final BooleansingleStatefalse= true, if u and d are not a function of pressure
FundamentalConstantssteamUtilities.​Water95_Utilities.​Constants 
StringsubstanceNames[:]{"Water", "Air"}Names of the mixture substances. Set substanceNames={mediumName} if only one substance.
TemperatureT_defaultModelica.SIunits.Conversions.from_degC(20)Default value for temperature of medium (for initialization)
IndependentVariablesThermoStatesModelica.​Media.​Interfaces.​Choices.​IndependentVariables.​pTXEnumeration type for independent variables
BooleanuseDissociationtrueTake dissociation into account for high temperatures
BooleanuseEnhancementFactorfalseUse the enhancement factor in the calculations
IntegerWater1Index of water (in substanceNames, massFractions X, etc.)
MassFractionX_default[nX]reference_XDefault value for mass fractions of medium (for initialization)

Type Modelica.​Media.​Air.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​SpecificInternalEnergy
Type for specific internal energy with medium specific attributes

Extends from Modelica.​Media.​Air.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​Temperature
Type for temperature with medium specific attributes

Extends from Modelica.​SIunits.​Temperature.

Attributes

NameValue
quantity"ThermodynamicTemperature"
unit"K"
displayUnit"degC"
min1
max10000
start288.15
nominal300

Type Modelica.​Media.​Air.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​ExtraProperty
Type for unspecified, mass-specific property transported by flow

Extends from Real.

Attributes

NameValue
min0
maxModelica.Constants.inf
start1

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

Extends from Real.

Attributes

NameValue
min0
maxModelica.Constants.inf
start1

Type Modelica.​Media.​Air.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​FluidConstants
Extended fluid constants

Information

This icon is indicates a record.

Extends from Modelica.​Media.​Interfaces.​Types.​TwoPhase.​FluidConstants (Extended fluid constants).

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
TemperaturecriticalTemperatureCritical temperature
AbsolutePressurecriticalPressureCritical pressure
MolarVolumecriticalMolarVolumeCritical molar Volume
RealacentricFactorPitzer acentric factor
TemperaturetriplePointTemperatureTriple point temperature
AbsolutePressuretriplePointPressureTriple point pressure
TemperaturemeltingPointMelting point at 101325 Pa
TemperaturenormalBoilingPointNormal boiling point (at 101325 Pa)
DipoleMomentdipoleMomentDipole moment of molecule in Debye (1 debye = 3.33564e10-30 C.m)
BooleanhasIdealGasHeatCapacityTrue if ideal gas heat capacity is available
BooleanhasCriticalDataTrue if critical data are known
BooleanhasDipoleMomentTrue if a dipole moment known
BooleanhasFundamentalEquationTrue if a fundamental equation
BooleanhasLiquidHeatCapacityTrue if liquid heat capacity is available
BooleanhasSolidHeatCapacityTrue if solid heat capacity is available
BooleanhasAccurateViscosityDataTrue if accurate data for a viscosity function is available
BooleanhasAccurateConductivityDataTrue if accurate data for thermal conductivity is available
BooleanhasVapourPressureCurveTrue if vapour pressure data, e.g., Antoine coefficients are known
BooleanhasAcentricFactorTrue if Pitzer acentric factor is known
SpecificEnthalpyHCRIT0Critical specific enthalpy of the fundamental equation
SpecificEntropySCRIT0Critical specific entropy of the fundamental equation
SpecificEnthalpydeltahDifference between specific enthalpy model (h_m) and f.eq. (h_f) (h_m - h_f)
SpecificEntropydeltasDifference between specific enthalpy model (s_m) and f.eq. (s_f) (s_m - s_f)

Record Modelica.​Media.​Air.​ReferenceMoistAir.​ThermodynamicState
ThermodynamicState record for moist air

Information

This icon is indicates a record.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​ThermodynamicState (Thermodynamic state variables).

Fields

TypeNameDescription
AbsolutePressurepAbsolute pressure of medium
TemperatureTTemperature of medium
MassFractionX[nX]Mass fractions (= (component mass)/total mass m_i/m)

Model Modelica.​Media.​Air.​ReferenceMoistAir.​BaseProperties
Moist air base properties record

Information

Model BaseProperties is a model within package PartialMedium and contains the declarations of the minimum number of variables that every medium model is supposed to support. A specific medium inherits from model BaseProperties and provides the equations for the basic properties.

The BaseProperties model contains the following 7+nXi variables (nXi is the number of independent mass fractions defined in package PartialMedium):

Variable Unit Description
T K temperature
p Pa absolute pressure
d kg/m3 density
h J/kg specific enthalpy
u J/kg specific internal energy
Xi[nXi] kg/kg independent mass fractions m_i/m
R J/kg.K gas constant
M kg/mol molar mass

In order to implement an actual medium model, one can extend from this base model and add 5 equations that provide relations among these variables. Equations will also have to be added in order to set all the variables within the ThermodynamicState record state.

If standardOrderComponents=true, the full composition vector X[nX] is determined by the equations contained in this base class, depending on the independent mass fraction vector Xi[nXi].

Additional 2 + nXi equations will have to be provided when using the BaseProperties model, in order to fully specify the thermodynamic conditions. The input connector qualifier applied to p, h, and nXi indirectly declares the number of missing equations, permitting advanced equation balance checking by Modelica tools. Please note that this doesn't mean that the additional equations should be connection equations, nor that exactly those variables should be supplied, in order to complete the model. For further information, see the Modelica.Media User's guide, and Section 4.7 (Balanced Models) of the Modelica 3.0 specification.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​BaseProperties (Base properties (p, d, T, h, u, R, MM and, if applicable, X and Xi) of a medium).

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.​ReferenceMoistAir.​setState_pTX
Return thermodynamic state as function of pressure p, temperature T and composition X

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​setState_pTX (Return thermodynamic state as function of p, T and composition X or Xi).

Inputs

TypeNameDescription
AbsolutePressurepPressure
TemperatureTTemperature
MassFractionX[:]Mass fractions

Outputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Function Modelica.​Media.​Air.​ReferenceMoistAir.​setState_phX
Return thermodynamic state as function of pressure p, specific enthalpy h and composition X

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​setState_phX (Return thermodynamic state as function of p, h and composition X or Xi).

Inputs

TypeNameDescription
AbsolutePressurepPressure
SpecificEnthalpyhSpecific enthalpy
MassFractionX[:]Mass fractions

Outputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Function Modelica.​Media.​Air.​ReferenceMoistAir.​setState_psX
Return thermodynamic state as function of pressure p, specific enthalpy h and composition X

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​setState_psX (Return thermodynamic state as function of p, s and composition X or Xi).

Inputs

TypeNameDescription
AbsolutePressurepPressure
SpecificEntropysSpecific entropy
MassFractionX[:]Mass fractions

Outputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Function Modelica.​Media.​Air.​ReferenceMoistAir.​setState_dTX
Return thermodynamic state as function of density d, temperature T and composition X

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​setState_dTX (Return thermodynamic state as function of d, T and composition X or Xi).

Inputs

TypeNameDescription
DensitydDensity
TemperatureTTemperature
MassFractionX[:]Mass fractions

Outputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Function Modelica.​Media.​Air.​ReferenceMoistAir.​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.​PartialRealCondensingGases.​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.​ReferenceMoistAir.​dynamicViscosity
Return dynamic viscosity as a function of the thermodynamic state record, valid from 73.15 K to 373.15 K

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
DynamicViscosityetaDynamic viscosity

Function Modelica.​Media.​Air.​ReferenceMoistAir.​thermalConductivity
Return thermal conductivity as a function of the thermodynamic state record, valid from 73.15 K to 373.15 K

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
ThermalConductivitylambdaThermal conductivity

Function Modelica.​Media.​Air.​ReferenceMoistAir.​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.​ReferenceMoistAir.​pressure
Returns pressure of ideal gas as a function of the thermodynamic state record

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
AbsolutePressurepPressure

Function Modelica.​Media.​Air.​ReferenceMoistAir.​temperature
Return temperature of ideal gas as a function of the thermodynamic state record

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
TemperatureTTemperature

Function Modelica.​Media.​Air.​ReferenceMoistAir.​density
Returns density as a function of the thermodynamic state record

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
DensitydDensity

Function Modelica.​Media.​Air.​ReferenceMoistAir.​specificEnthalpy
Return specific enthalpy of moist air as a function of the thermodynamic state record

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​specificEnthalpy (Return specific enthalpy).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEnthalpyhSpecific enthalpy

Function Modelica.​Media.​Air.​ReferenceMoistAir.​specificInternalEnergy
Return specific internal energy of moist air as a function of the thermodynamic state record

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​specificInternalEnergy (Return specific internal energy).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEnergyuSpecific internal energy

Function Modelica.​Media.​Air.​ReferenceMoistAir.​specificEntropy
Return specific entropy from thermodynamic state record, only valid for phi<1

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​specificEntropy (Return specific entropy).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEntropysSpecific entropy

Function Modelica.​Media.​Air.​ReferenceMoistAir.​specificGibbsEnergy
Return specific Gibbs energy as a function of the thermodynamic state record, only valid for phi<1

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​specificGibbsEnergy (Return specific Gibbs energy).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEnergygSpecific Gibbs energy

Function Modelica.​Media.​Air.​ReferenceMoistAir.​specificHelmholtzEnergy
Return specific Helmholtz energy as a function of the thermodynamic state record, only valid for phi<1

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​specificHelmholtzEnergy (Return specific Helmholtz energy).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEnergyfSpecific Helmholtz energy

Function Modelica.​Media.​Air.​ReferenceMoistAir.​specificHeatCapacityCp
Return specific heat capacity at constant pressure as a function of the thermodynamic state record

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​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.​ReferenceMoistAir.​heatCapacity_cp
Alias for deprecated name

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Air.​ReferenceMoistAir.​specificHeatCapacityCp (Return specific heat capacity at constant pressure as a function of the thermodynamic state record).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificHeatCapacitycpSpecific heat capacity at constant pressure

Function Modelica.​Media.​Air.​ReferenceMoistAir.​specificHeatCapacityCv
Return specific heat capacity at constant volume as a function of the thermodynamic state record

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​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.​ReferenceMoistAir.​heatCapacity_cv
Alias for deprecated name

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Air.​ReferenceMoistAir.​specificHeatCapacityCv (Return specific heat capacity at constant volume as a function of the thermodynamic state record).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificHeatCapacitycvSpecific heat capacity at constant volume

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

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
IsentropicExponentgammaIsentropic exponent

Function Modelica.​Media.​Air.​ReferenceMoistAir.​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.​PartialRealCondensingGases.​isentropicEnthalpy (Return isentropic enthalpy).

Inputs

TypeNameDescription
AbsolutePressurep_downstreamDownstream pressure
ThermodynamicStaterefStateReference state for entropy

Outputs

TypeNameDescription
SpecificEnthalpyh_isIsentropic enthalpy

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

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
VelocityOfSoundaVelocity of sound

Partial Function Modelica.​Media.​Air.​ReferenceMoistAir.​isobaricExpansionCoefficient
Return 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.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
IsobaricExpansionCoefficientbetaIsobaric expansion coefficient

Partial Function Modelica.​Media.​Air.​ReferenceMoistAir.​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.​ReferenceMoistAir.​isobaricExpansionCoefficient (Return overall the isobaric expansion coefficient beta).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
IsobaricExpansionCoefficientbetaIsobaric expansion coefficient

Partial Function Modelica.​Media.​Air.​ReferenceMoistAir.​isothermalCompressibility
Return 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.​Icons.​Function (Icon for functions).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
IsothermalCompressibilitykappaIsothermal compressibility

Partial Function Modelica.​Media.​Air.​ReferenceMoistAir.​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.​ReferenceMoistAir.​isothermalCompressibility (Return overall the isothermal compressibility factor).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
IsothermalCompressibilitykappaIsothermal compressibility

Partial Function Modelica.​Media.​Air.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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

Partial Function Modelica.​Media.​Air.​ReferenceMoistAir.​density_derp_T
Return density derivative w.r.t. pressure at const temperature

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
DerDensityByPressureddpTDensity derivative w.r.t. pressure

Partial Function Modelica.​Media.​Air.​ReferenceMoistAir.​density_derT_p
Return density derivative w.r.t. temperature at constant pressure

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
DerDensityByTemperatureddTpDensity derivative w.r.t. temperature

Partial Function Modelica.​Media.​Air.​ReferenceMoistAir.​density_derX
Return density derivative w.r.t. mass fraction

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

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

Function Modelica.​Media.​Air.​ReferenceMoistAir.​molarMass
Return the molar mass of the medium

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
MolarMassMMMixture molar mass

Function Modelica.​Media.​Air.​ReferenceMoistAir.​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[:]Mass fractions

Outputs

TypeNameDescription
SpecificEnthalpyhSpecific enthalpy

Function Modelica.​Media.​Air.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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[:]Mass fractions

Outputs

TypeNameDescription
TemperatureTTemperature

Function Modelica.​Media.​Air.​ReferenceMoistAir.​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[:]Mass fractions

Outputs

TypeNameDescription
DensitydDensity

Function Modelica.​Media.​Air.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​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.​ReferenceMoistAir.​gasConstant
Return ideal gas constant as a function from thermodynamic state, only valid for phi<1

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​gasConstant (Return the gas constant of the mixture (also for liquids)).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state

Outputs

TypeNameDescription
SpecificHeatCapacityRMixture gas constant

Function Modelica.​Media.​Air.​ReferenceMoistAir.​moleToMassFractions
Return mass fractions X from mole fractions

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
MoleFractionmoleFractions[:]Mole fractions of mixture
MolarMassMMX[:]Molar masses of components

Outputs

TypeNameDescription
MassFractionX[size(moleFractions, 1)]Mass fractions of gas mixture

Function Modelica.​Media.​Air.​ReferenceMoistAir.​massToMoleFractions
Return mole fractions from mass fractions X

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
MassFractionX[:]Mass fractions of mixture
MolarMassMMX[:]Molar masses of components

Outputs

TypeNameDescription
MoleFractionmoleFractions[size(X, 1)]Mole fractions of gas mixture

Function Modelica.​Media.​Air.​ReferenceMoistAir.​saturationPressure
Return saturation pressure of condensing fluid

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​saturationPressure (Return saturation pressure of condensing fluid).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
AbsolutePressurepsatSaturation pressure

Function Modelica.​Media.​Air.​ReferenceMoistAir.​saturationTemperature
Return saturation temperature of condensing fluid

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​saturationTemperature (Return saturation temperature of condensing fluid).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
TemperatureTsatSaturation temperature

Function Modelica.​Media.​Air.​ReferenceMoistAir.​massFractionSaturation
Return saturation mass fractions

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​massFractionSaturation (Return saturation mass fractions).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
MassFractionXsat[:]Saturation mass fractions

Function Modelica.​Media.​Air.​ReferenceMoistAir.​massFraction_pTphi
Return mass fractions as a function of pressure, temperature and relative humidity

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​massFraction_pTphi (Return mass fractions as a function of pressure, temperature and relative humidity).

Inputs

TypeNameDescription
AbsolutePressurepPressure
TemperatureTTemperature
RealphiRelative humidity

Outputs

TypeNameDescription
MassFractionX[:]Mass fractions

Function Modelica.​Media.​Air.​ReferenceMoistAir.​relativeHumidity
Return relative humidity

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​relativeHumidity (Return relative humidity).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
RealphiRelative humidity

Function Modelica.​Media.​Air.​ReferenceMoistAir.​enthalpyOfVaporization
Return enthalpy of vaporization of water

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​enthalpyOfVaporization (Return vaporization enthalpy of condensing fluid).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEnthalpyr0Vaporization enthalpy

Function Modelica.​Media.​Air.​ReferenceMoistAir.​enthalpyOfLiquid
Return enthalpy of liquid water

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​enthalpyOfLiquid (Return liquid enthalpy of condensing fluid).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEnthalpyhLiquid enthalpy

Function Modelica.​Media.​Air.​ReferenceMoistAir.​enthalpyOfGas
Return specific enthalpy of gas (air and steam)

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​enthalpyOfGas (Return enthalpy of non-condensing gas mixture).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEnthalpyhSpecific enthalpy

Function Modelica.​Media.​Air.​ReferenceMoistAir.​enthalpyOfCondensingGas
Return specific enthalpy of steam

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​enthalpyOfCondensingGas (Return enthalpy of condensing gas (most often steam)).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEnthalpyhSpecific enthalpy

Function Modelica.​Media.​Air.​ReferenceMoistAir.​enthalpyOfNonCondensingGas
Return specific enthalpy of dry air

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Interfaces.​PartialRealCondensingGases.​enthalpyOfNonCondensingGas (Return enthalpy of the non-condensing species).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEnthalpyhSpecific enthalpy

Partial Function Modelica.​Media.​Air.​ReferenceMoistAir.​specificEntropy_phX
Return specific entropy as a function of pressure, specific enthalpy and mass fractions

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
AbsolutePressurepPressure
SpecificEnthalpyhSpecific enthalpy
MassFractionX[:]Mass fractions

Outputs

TypeNameDescription
SpecificEntropysSpecific entropy

Function Modelica.​Media.​Air.​ReferenceMoistAir.​Xsaturation
Return absolute humitity per unit mass of moist air at saturation as a function of the thermodynamic state record

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
MassFractionX_satSteam mass fraction of sat. boundary

Function Modelica.​Media.​Air.​ReferenceMoistAir.​xsaturation
Return absolute humitity per unit mass of dry air at saturation as a function of the thermodynamic state record

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
MassFractionx_satAbsolute humidity per unit mass of dry air

Function Modelica.​Media.​Air.​ReferenceMoistAir.​massFractionWaterVapor
Return mass fraction of water vapor

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
MassFractionXMass fraction of water vapor

Function Modelica.​Media.​Air.​ReferenceMoistAir.​massFractionWaterNonVapor
Return mass fraction of liquid and solid water

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
MassFractionXMass fraction of water varpor

Function Modelica.​Media.​Air.​ReferenceMoistAir.​massFractionSaturation_ppsat
Return mass fvraction at saturation boundary given pressure and saturation pressure

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
AbsolutePressurepAmbient pressure
AbsolutePressurepsatSaturation pressure

Outputs

TypeNameDescription
MassFractionX[:]Mass fraction

Function Modelica.​Media.​Air.​ReferenceMoistAir.​massFraction_waterContent
Return mass fractions as a function of pressure, temperature and absolute humidity in kg(water)/kg(dry air)

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
RealxwWater content in kg(water)/kg(dry air)

Outputs

TypeNameDescription
MassFractionX[:]Mass fractions

Function Modelica.​Media.​Air.​ReferenceMoistAir.​waterContent_X
Return water content in kg(water)/kg(dry air) given mass fractions

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
MassFractionX[:]Mass fractions

Outputs

TypeNameDescription
RealxwWater content in kg(water)/kg(dry air)

Function Modelica.​Media.​Air.​ReferenceMoistAir.​saturationPressureLiquid
Return saturation pressure of water as a function of temperature T

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
AbsolutePressurepsatSaturation pressure

Function Modelica.​Media.​Air.​ReferenceMoistAir.​sublimationPressureIce
Return sublimation pressure of water as a function of temperature T between 223.16 and 273.16 K

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
AbsolutePressurepsatSublimation pressure

Function Modelica.​Media.​Air.​ReferenceMoistAir.​enthalpyOfDryAir
Return specific enthalpy of dry air

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Air.​ReferenceMoistAir.​enthalpyOfNonCondensingGas (Return specific enthalpy of dry air).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEnthalpyhSpecific enthalpy

Function Modelica.​Media.​Air.​ReferenceMoistAir.​enthalpyOfWater
Return specific enthalpy of water (solid + liquid + steam)

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEnthalpyhSpecific enthalpy of water

Function Modelica.​Media.​Air.​ReferenceMoistAir.​enthalpyOfWaterVapor
Return specific enthalpy of steam

Information

This icon indicates Modelica functions.

Extends from Modelica.​Media.​Air.​ReferenceMoistAir.​enthalpyOfCondensingGas (Return specific enthalpy of steam).

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEnthalpyhSpecific enthalpy

Function Modelica.​Media.​Air.​ReferenceMoistAir.​enthalpyOfWaterNonVapor
Return enthalpy of liquid and solid water

Information

This icon indicates Modelica functions.

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

Inputs

TypeNameDescription
ThermodynamicStatestateThermodynamic state record

Outputs

TypeNameDescription
SpecificEnthalpyhSpecific enthalpy of water