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.
The functions provided by this package shall be used inside of the restricted limits according to the referenced literature.
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. |
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) |
Ideal mixture of dry air and steam
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
The saturation pressure pds of water in moist air is calculated by pds = f*psat, where
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.
The verification report for the development of this library is provided here.
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-2018, Modelica Association and contributors
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases
(Base class for mixtures of real condensing and non-condensing gases).
Name | Description |
---|---|
AbsolutePressure | Type for absolute pressure with medium specific attributes |
BaseProperties | Moist air base properties record |
Basic … | The most basic version of a record used in several degrees of detail |
beta | Alias for isobaricExpansionCoefficient for user convenience |
Choices … |   |
CumulativeExtraProperty | Type for conserved integral of unspecified, mass specific property |
Density | Type for density with medium specific attributes |
density | Returns density as a function of the thermodynamic state record |
density_derh_p | Return density derivative w.r.t. specific enthalpy at constant pressure |
density_derp_h | Return density derivative w.r.t. pressure at const specific enthalpy |
density_derp_T | Return density derivative w.r.t. pressure at const temperature |
density_derT_p | Return density derivative w.r.t. temperature at constant pressure |
density_derX | Return density derivative w.r.t. mass fraction |
density_phX | Return density from p, h, and X or Xi |
density_psX | Return density from p, s, and X or Xi |
density_pTX | Return density from p, T, and X or Xi |
DerDensityByEnthalpy | Type for partial derivative of density with respect to enthalpy with medium specific attributes |
DerDensityByPressure | Type for partial derivative of density with respect to pressure with medium specific attributes |
DerDensityByTemperature | Type for partial derivative of density with respect to temperature with medium specific attributes |
DerEnthalpyByPressure | Type for partial derivative of enthalpy with respect to pressure with medium specific attributes |
DerTemperatureByPressure | Type for partial derivative of temperature with respect to pressure with medium specific attributes |
DipoleMoment | Type for dipole moment with medium specific attributes |
DynamicViscosity | Type for dynamic viscosity with medium specific attributes |
dynamicViscosity | Return dynamic viscosity as a function of the thermodynamic state record, valid from 73.15 K to 373.15 K |
EnthalpyFlowRate | Type for enthalpy flow rate with medium specific attributes |
enthalpyOfCondensingGas | Return specific enthalpy of steam |
enthalpyOfDryAir | Return specific enthalpy of dry air |
enthalpyOfGas | Return specific enthalpy of gas (air and steam) |
enthalpyOfLiquid | Return enthalpy of liquid water |
enthalpyOfNonCondensingGas | Return specific enthalpy of dry air |
enthalpyOfVaporization | Return enthalpy of vaporization of water |
enthalpyOfWater | Return specific enthalpy of water (solid + liquid + steam) |
enthalpyOfWaterNonVapor | Return enthalpy of liquid and solid water |
enthalpyOfWaterVapor | Return specific enthalpy of steam |
ExtraProperty | Type for unspecified, mass-specific property transported by flow |
ExtraPropertyFlowRate | Type for flow rate of unspecified, mass-specific property |
FixedPhase | Phase of the fluid: 1 for 1-phase, 2 for two-phase, 0 for not known, e.g., interactive use |
FluidConstants |   |
FluidLimits | Validity limits for fluid model |
gasConstant | Return ideal gas constant as a function from thermodynamic state, only valid for phi<1 |
heatCapacity_cp | Alias for deprecated name |
heatCapacity_cv | Alias for deprecated name |
IdealGas … | The ideal gas version of a record used in several degrees of detail |
isentropicEnthalpy | Return isentropic enthalpy |
IsentropicExponent | Type for isentropic exponent with medium specific attributes |
isentropicExponent | Return isentropic exponent |
IsobaricExpansionCoefficient | Type for isobaric expansion coefficient with medium specific attributes |
isobaricExpansionCoefficient | Return overall the isobaric expansion coefficient beta |
isothermalCompressibility | Return overall the isothermal compressibility factor |
kappa | Alias of isothermalCompressibility for user convenience |
MassFlowRate | Type for mass flow rate with medium specific attributes |
MassFraction | Type for mass fraction with medium specific attributes |
massFraction_pTphi | Return mass fractions as a function of pressure, temperature and relative humidity |
massFraction_waterContent | Return mass fractions as a function of pressure, temperature and absolute humidity in kg(water)/kg(dry air) |
massFractionSaturation | Return saturation mass fractions |
massFractionSaturation_ppsat | Return mass fvraction at saturation boundary given pressure and saturation pressure |
massFractionWaterNonVapor | Return mass fraction of liquid and solid water |
massFractionWaterVapor | Return mass fraction of water vapor |
massToMoleFractions | Return mole fractions from mass fractions X |
MolarMass | Type for molar mass with medium specific attributes |
molarMass | Return the molar mass of the medium |
MolarVolume | Type for molar volume with medium specific attributes |
MoleFraction | Type for mole fraction with medium specific attributes |
moleToMassFractions | Return mass fractions X from mole fractions |
PrandtlNumber | Type for Prandtl number with medium specific attributes |
prandtlNumber | Return the Prandtl number |
pressure | Returns pressure of ideal gas as a function of the thermodynamic state record |
relativeHumidity | Return relative humidity |
saturationPressure | Return saturation pressure of condensing fluid |
saturationPressureLiquid | Return saturation pressure of water as a function of temperature T |
SaturationProperties | Saturation properties of two phase medium |
saturationTemperature | Return saturation temperature of condensing fluid |
setSmoothState | Return thermodynamic state so that it smoothly approximates: if x > 0 then state_a else state_b |
setState_dTX | Return thermodynamic state as function of density d, temperature T and composition X |
setState_phX | Return thermodynamic state as function of pressure p, specific enthalpy h and composition X |
setState_psX | Return thermodynamic state as function of pressure p, specific enthalpy h and composition X |
setState_pTX | Return thermodynamic state as function of pressure p, temperature T and composition X |
SpecificEnergy | Type for specific energy with medium specific attributes |
SpecificEnthalpy | Type for specific enthalpy with medium specific attributes |
specificEnthalpy | Return specific enthalpy of moist air as a function of the thermodynamic state record |
specificEnthalpy_psX | Return specific enthalpy from p, s, and X or Xi |
specificEnthalpy_pTX | Return specific enthalpy from p, T, and X or Xi |
SpecificEntropy | Type for specific entropy with medium specific attributes |
specificEntropy | Return specific entropy from thermodynamic state record, only valid for phi<1 |
specificEntropy_phX | Return specific entropy as a function of pressure, specific enthalpy and mass fractions |
specificEntropy_pTX | Return specific enthalpy from p, T, and X or Xi |
specificGibbsEnergy | Return specific Gibbs energy as a function of the thermodynamic state record, only valid for phi<1 |
SpecificHeatCapacity | Type for specific heat capacity with medium specific attributes |
specificHeatCapacityCp | Return specific heat capacity at constant pressure as a function of the thermodynamic state record |
specificHeatCapacityCv | Return specific heat capacity at constant volume as a function of the thermodynamic state record |
specificHelmholtzEnergy | Return specific Helmholtz energy as a function of the thermodynamic state record, only valid for phi<1 |
SpecificInternalEnergy | Type for specific internal energy with medium specific attributes |
specificInternalEnergy | Return specific internal energy of moist air as a function of the thermodynamic state record |
sublimationPressureIce | Return sublimation pressure of water as a function of temperature T between 223.16 and 273.16 K |
SurfaceTension | Type for surface tension with medium specific attributes |
Temperature | Type for temperature with medium specific attributes |
temperature | Return temperature of ideal gas as a function of the thermodynamic state record |
temperature_phX | Return temperature from p, h, and X or Xi |
temperature_psX | Return temperature from p,s, and X or Xi |
ThermalConductivity | Type for thermal conductivity with medium specific attributes |
thermalConductivity | Return thermal conductivity as a function of the thermodynamic state record, valid from 73.15 K to 373.15 K |
ThermodynamicState | ThermodynamicState record for moist air |
TwoPhase … | The two phase fluid version of a record used in several degrees of detail |
Utilities … | Utility package for moist air |
VelocityOfSound | Type for velocity of sound with medium specific attributes |
velocityOfSound | Return velocity of sound |
waterContent_X | Return water content in kg(water)/kg(dry air) given mass fractions |
Xsaturation | Return absolute humitity per unit mass of moist air at saturation as a function of the thermodynamic state record |
xsaturation | Return absolute humitity per unit mass of dry air at saturation as a function of the thermodynamic state record |
Type | Name | Value | Description |
---|---|---|---|
Integer | Air | 2 | Index of air (in substanceNames, massFractions X, etc.) |
ExtraProperty | C_default[nC] | fill(0, nC) | Default value for trace substances of medium (for initialization) |
Real | C_nominal[nC] | 1e-6 * ones(nC) | Default for the nominal values for the extra properties |
FundamentalConstants | dryair | ReferenceAir.Air_Utilities.Basic.Constants |   |
String | extraPropertiesNames[:] | fill("", 0) | Names of the additional (extra) transported properties. Set extraPropertiesNames=fill("",0) if unused |
final Boolean | fixedX | false | = true if medium contains the equation X = reference_X |
FluidConstants | fluidConstants[nS] | {Utilities.Water95_Utilities.waterConstants, Modelica.Media.Air.ReferenceAir.airConstants} | Constant data for the fluid |
SpecificEnthalpy | h_default | specificEnthalpy_pTX(p_default, T_default, X_default) | Default value for specific enthalpy of medium (for initialization) |
Real | k_mair | steam.MM / dryair.MM | Ratio of molar weights |
String | mediumName | "Moist air" | Name of the medium |
MolarMass | MMX[2] | {steam.MM, dryair.MM} | Molar masses of components |
final Integer | nC | size(extraPropertiesNames, 1) | Number of extra (outside of standard mass-balance) transported properties |
final Integer | nS | size(substanceNames, 1) | Number of substances |
Integer | nX | nS | Number of mass fractions |
Integer | nXi | if fixedX then 0 else if reducedX then nS - 1 else nS | Number of structurally independent mass fractions (see docu for details) |
AbsolutePressure | p_default | 101325 | Default value for pressure of medium (for initialization) |
final Boolean | reducedX | true | = true if medium contains the equation sum(X) = 1.0; set reducedX=true if only one substance (see docu for details) |
AbsolutePressure | reference_p | 101325 | Reference pressure of Medium: default 1 atmosphere |
Temperature | reference_T | 298.15 | Reference temperature of Medium: default 25 deg Celsius |
MassFraction | reference_X[nX] | {0.01, 0.99} | Default mass fractions of medium |
final Boolean | singleState | false | = true, if u and d are not a function of pressure |
FundamentalConstants | steam | Utilities.Water95_Utilities.Constants |   |
String | substanceNames[:] | {"Water", "Air"} | Names of the mixture substances. Set substanceNames={mediumName} if only one substance. |
Temperature | T_default | Modelica.SIunits.Conversions.from_degC(20) | Default value for temperature of medium (for initialization) |
IndependentVariables | ThermoStates | Modelica.Media.Interfaces.Choices.IndependentVariables.pTX | Enumeration type for independent variables |
Boolean | useDissociation | true | Take dissociation into account for high temperatures |
Boolean | useEnhancementFactor | false | Use the enhancement factor in the calculations |
Integer | Water | 1 | Index of water (in substanceNames, massFractions X, etc.) |
MassFraction | X_default[nX] | reference_X | Default value for mass fractions of medium (for initialization) |
Extends from Modelica.SIunits.AbsolutePressure
.
Name | Value |
---|---|
quantity | "Pressure" |
unit | "Pa" |
displayUnit | "bar" |
min | 0 |
max | 1e+8 |
start | 100000 |
nominal | 100000 |
Extends from Modelica.SIunits.Density
.
Name | Value |
---|---|
quantity | "Density" |
unit | "kg/m3" |
displayUnit | "g/cm3" |
min | 0 |
max | 100000 |
start | 1 |
nominal | 1 |
Extends from Modelica.SIunits.DynamicViscosity
.
Name | Value |
---|---|
quantity | "DynamicViscosity" |
unit | "Pa.s" |
min | 0 |
max | 1e+8 |
start | 0.001 |
nominal | 0.001 |
Extends from Modelica.SIunits.EnthalpyFlowRate
.
Name | Value |
---|---|
quantity | "EnthalpyFlowRate" |
unit | "W" |
min | -1e+8 |
max | 1e+8 |
start | 0. |
nominal | 1000 |
Extends from Real
.
Name | Value |
---|---|
quantity | "MassFraction" |
unit | "kg/kg" |
min | 0 |
max | 1 |
start | 0. |
nominal | 0.1 |
Extends from Real
.
Name | Value |
---|---|
quantity | "MoleFraction" |
unit | "mol/mol" |
min | 0 |
max | 1 |
start | 0. |
nominal | 0.1 |
Extends from Modelica.SIunits.MolarMass
.
Name | Value |
---|---|
quantity | "MolarMass" |
unit | "kg/mol" |
min | 0.001 |
max | 0.25 |
start | 0. |
nominal | 0.032 |
Extends from Modelica.SIunits.MolarVolume
.
Name | Value |
---|---|
quantity | "MolarVolume" |
unit | "m3/mol" |
min | 1e-6 |
max | 1000000 |
start | 0. |
nominal | 1 |
Extends from Modelica.SIunits.RatioOfSpecificHeatCapacities
.
Name | Value |
---|---|
quantity | "RatioOfSpecificHeatCapacities" |
unit | "1" |
min | 1 |
max | 500000 |
start | 1.2 |
nominal | 1.2 |
Extends from Modelica.SIunits.SpecificEnergy
.
Name | Value |
---|---|
quantity | "SpecificEnergy" |
unit | "J/kg" |
min | -1e+8 |
max | 1e+8 |
start | 0. |
nominal | 1000000 |
Extends from Modelica.Media.Air.ReferenceMoistAir.SpecificEnergy
(Type for specific energy with medium specific attributes).
Name | Value |
---|---|
quantity | "SpecificEnergy" |
unit | "J/kg" |
min | -1e+8 |
max | 1e+8 |
start | 0. |
nominal | 1000000 |
Extends from Modelica.SIunits.SpecificEnthalpy
.
Name | Value |
---|---|
quantity | "SpecificEnergy" |
unit | "J/kg" |
min | -1e+10 |
max | 1e+10 |
start | 0. |
nominal | 1000000 |
Extends from Modelica.SIunits.SpecificEntropy
.
Name | Value |
---|---|
quantity | "SpecificEntropy" |
unit | "J/(kg.K)" |
min | -1e+7 |
max | 1e+7 |
start | 0. |
nominal | 1000 |
Extends from Modelica.SIunits.SpecificHeatCapacity
.
Name | Value |
---|---|
quantity | "SpecificHeatCapacity" |
unit | "J/(kg.K)" |
min | 0 |
max | 1e+7 |
start | 1000 |
nominal | 1000 |
Extends from Modelica.SIunits.SurfaceTension
.
Name | Value |
---|---|
quantity | "SurfaceTension" |
unit | "N/m" |
min | -Modelica.Constants.inf |
max | Modelica.Constants.inf |
start | 0. |
Extends from Modelica.SIunits.Temperature
.
Name | Value |
---|---|
quantity | "ThermodynamicTemperature" |
unit | "K" |
displayUnit | "degC" |
min | 1 |
max | 10000 |
start | 288.15 |
nominal | 300 |
Extends from Modelica.SIunits.ThermalConductivity
.
Name | Value |
---|---|
quantity | "ThermalConductivity" |
unit | "W/(m.K)" |
min | 0 |
max | 500 |
start | 1 |
nominal | 1 |
Extends from Modelica.SIunits.PrandtlNumber
.
Name | Value |
---|---|
quantity | "PrandtlNumber" |
unit | "1" |
min | 0.001 |
max | 100000 |
start | 0. |
nominal | 1 |
Extends from Modelica.SIunits.Velocity
.
Name | Value |
---|---|
quantity | "Velocity" |
unit | "m/s" |
min | 0 |
max | 100000 |
start | 1000 |
nominal | 1000 |
Extends from Real
.
Name | Value |
---|---|
min | 0 |
max | Modelica.Constants.inf |
start | 1 |
Extends from Real
.
Name | Value |
---|---|
min | 0 |
max | Modelica.Constants.inf |
start | 1 |
Extends from Real
.
Name | Value |
---|---|
unit | "kg/s" |
min | -Modelica.Constants.inf |
max | Modelica.Constants.inf |
start | 0. |
Extends from Real
.
Name | Value |
---|---|
unit | "1/K" |
min | 0 |
max | 1e+8 |
start | 0. |
Extends from Real
.
Name | Value |
---|---|
quantity | "ElectricDipoleMoment" |
unit | "debye" |
min | 0 |
max | 2 |
start | 0. |
Extends from Modelica.SIunits.DerDensityByPressure
.
Name | Value |
---|---|
unit | "s2/m2" |
min | -Modelica.Constants.inf |
max | Modelica.Constants.inf |
start | 0. |
Extends from Modelica.SIunits.DerDensityByEnthalpy
.
Name | Value |
---|---|
unit | "kg.s2/m5" |
min | -Modelica.Constants.inf |
max | Modelica.Constants.inf |
start | 0. |
Extends from Modelica.SIunits.DerEnthalpyByPressure
.
Name | Value |
---|---|
unit | "J.m.s2/kg2" |
min | -Modelica.Constants.inf |
max | Modelica.Constants.inf |
start | 0. |
Extends from Modelica.SIunits.DerDensityByTemperature
.
Name | Value |
---|---|
unit | "kg/(m3.K)" |
min | -Modelica.Constants.inf |
max | Modelica.Constants.inf |
start | 0. |
Extends from Real
.
Name | Value |
---|---|
unit | "K/Pa" |
min | -Modelica.Constants.inf |
max | Modelica.Constants.inf |
start | 0. |
This icon is indicates a record.
Extends from Modelica.Icons.Record
(Icon for records).
Type | Name | Description |
---|---|---|
AbsolutePressure | psat | Saturation pressure |
Temperature | Tsat | Saturation temperature |
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).
Type | Name | Description |
---|---|---|
Temperature | TMIN | Minimum temperature |
Temperature | TMAX | Maximum temperature |
Density | DMIN | Minimum density |
Density | DMAX | Maximum density |
AbsolutePressure | PMIN | Minimum pressure |
AbsolutePressure | PMAX | Maximum pressure |
SpecificEnthalpy | HMIN | Minimum enthalpy |
SpecificEnthalpy | HMAX | Maximum enthalpy |
SpecificEntropy | SMIN | Minimum entropy |
SpecificEntropy | SMAX | Maximum entropy |
Extends from Integer
.
Name | Value |
---|---|
min | 0 |
max | 2 |
start | 0 |
This icon is indicates a record.
Extends from Modelica.Media.Interfaces.Types.TwoPhase.FluidConstants
(Extended fluid constants).
Type | Name | Description |
---|---|---|
String | iupacName | Complete IUPAC name (or common name, if non-existent) |
String | casRegistryNumber | Chemical abstracts sequencing number (if it exists) |
String | chemicalFormula | Chemical formula, (brutto, nomenclature according to Hill |
String | structureFormula | Chemical structure formula |
MolarMass | molarMass | Molar mass |
Temperature | criticalTemperature | Critical temperature |
AbsolutePressure | criticalPressure | Critical pressure |
MolarVolume | criticalMolarVolume | Critical molar Volume |
Real | acentricFactor | Pitzer acentric factor |
Temperature | triplePointTemperature | Triple point temperature |
AbsolutePressure | triplePointPressure | Triple point pressure |
Temperature | meltingPoint | Melting point at 101325 Pa |
Temperature | normalBoilingPoint | Normal boiling point (at 101325 Pa) |
DipoleMoment | dipoleMoment | Dipole moment of molecule in Debye (1 debye = 3.33564e10-30 C.m) |
Boolean | hasIdealGasHeatCapacity | True if ideal gas heat capacity is available |
Boolean | hasCriticalData | True if critical data are known |
Boolean | hasDipoleMoment | True if a dipole moment known |
Boolean | hasFundamentalEquation | True if a fundamental equation |
Boolean | hasLiquidHeatCapacity | True if liquid heat capacity is available |
Boolean | hasSolidHeatCapacity | True if solid heat capacity is available |
Boolean | hasAccurateViscosityData | True if accurate data for a viscosity function is available |
Boolean | hasAccurateConductivityData | True if accurate data for thermal conductivity is available |
Boolean | hasVapourPressureCurve | True if vapour pressure data, e.g., Antoine coefficients are known |
Boolean | hasAcentricFactor | True if Pitzer acentric factor is known |
SpecificEnthalpy | HCRIT0 | Critical specific enthalpy of the fundamental equation |
SpecificEntropy | SCRIT0 | Critical specific entropy of the fundamental equation |
SpecificEnthalpy | deltah | Difference between specific enthalpy model (h_m) and f.eq. (h_f) (h_m - h_f) |
SpecificEntropy | deltas | Difference between specific enthalpy model (s_m) and f.eq. (s_f) (s_m - s_f) |
This icon is indicates a record.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.ThermodynamicState
(Thermodynamic state variables).
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Absolute pressure of medium |
Temperature | T | Temperature of medium |
MassFraction | X[nX] | Mass fractions (= (component mass)/total mass m_i/m) |
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).
Type | Name | Default | Description |
---|---|---|---|
Boolean | preferredMediumStates | false | = true if StateSelect.prefer shall be used for the independent property variables of the medium |
final Boolean | standardOrderComponents | true | If true, and reducedX = true, the last element of X will be computed from the other ones |
Type | Name | Description |
---|---|---|
input InputAbsolutePressure | p | Absolute pressure of medium |
input InputMassFraction | Xi[nXi] | Structurally independent mass fractions |
input InputSpecificEnthalpy | h | Specific enthalpy of medium |
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).
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Pressure |
Temperature | T | Temperature |
MassFraction | X[:] | Mass fractions |
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
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).
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Pressure |
SpecificEnthalpy | h | Specific enthalpy |
MassFraction | X[:] | Mass fractions |
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
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).
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Pressure |
SpecificEntropy | s | Specific entropy |
MassFraction | X[:] | Mass fractions |
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
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).
Type | Name | Description |
---|---|---|
Density | d | Density |
Temperature | T | Temperature |
MassFraction | X[:] | Mass fractions |
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
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).
Type | Name | Description |
---|---|---|
Real | x | m_flow or dp |
ThermodynamicState | state_a | Thermodynamic state if x > 0 |
ThermodynamicState | state_b | Thermodynamic state if x < 0 |
Real | x_small | Smooth transition in the region -x_small < x < x_small |
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Smooth thermodynamic state for all x (continuous and differentiable) |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.dynamicViscosity
(Return dynamic viscosity).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
DynamicViscosity | eta | Dynamic viscosity |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.thermalConductivity
(Return thermal conductivity).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
ThermalConductivity | lambda | Thermal conductivity |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
PrandtlNumber | Pr | Prandtl number |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.pressure
(Return pressure).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Pressure |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.temperature
(Return temperature).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
Temperature | T | Temperature |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.density
(Return density).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
Density | d | Density |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.specificEnthalpy
(Return specific enthalpy).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | Specific enthalpy |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.specificInternalEnergy
(Return specific internal energy).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEnergy | u | Specific internal energy |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.specificEntropy
(Return specific entropy).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEntropy | s | Specific entropy |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.specificGibbsEnergy
(Return specific Gibbs energy).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEnergy | g | Specific Gibbs energy |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.specificHelmholtzEnergy
(Return specific Helmholtz energy).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEnergy | f | Specific Helmholtz energy |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.specificHeatCapacityCp
(Return specific heat capacity at constant pressure).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificHeatCapacity | cp | Specific heat capacity at constant pressure |
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).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificHeatCapacity | cp | Specific heat capacity at constant pressure |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.specificHeatCapacityCv
(Return specific heat capacity at constant volume).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificHeatCapacity | cv | Specific heat capacity at constant volume |
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).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificHeatCapacity | cv | Specific heat capacity at constant volume |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.isentropicExponent
(Return isentropic exponent).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
IsentropicExponent | gamma | Isentropic exponent |
This function computes an isentropic state transformation:
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.isentropicEnthalpy
(Return isentropic enthalpy).
Type | Name | Description |
---|---|---|
AbsolutePressure | p_downstream | Downstream pressure |
ThermodynamicState | refState | Reference state for entropy |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h_is | Isentropic enthalpy |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.velocityOfSound
(Return velocity of sound).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
VelocityOfSound | a | Velocity of sound |
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).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
IsobaricExpansionCoefficient | beta | Isobaric expansion coefficient |
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).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
IsobaricExpansionCoefficient | beta | Isobaric expansion coefficient |
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).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
IsothermalCompressibility | kappa | Isothermal compressibility |
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).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
IsothermalCompressibility | kappa | Isothermal compressibility |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
DerDensityByPressure | ddph | Density derivative w.r.t. pressure |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
DerDensityByEnthalpy | ddhp | Density derivative w.r.t. specific enthalpy |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
DerDensityByPressure | ddpT | Density derivative w.r.t. pressure |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
DerDensityByTemperature | ddTp | Density derivative w.r.t. temperature |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
Density | dddX[nX] | Derivative of density w.r.t. mass fraction |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.molarMass
(Return the molar mass of the medium).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
MolarMass | MM | Mixture molar mass |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Pressure |
Temperature | T | Temperature |
MassFraction | X[:] | Mass fractions |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | Specific enthalpy |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Pressure |
Temperature | T | Temperature |
MassFraction | X[:] | Mass fractions |
Type | Name | Description |
---|---|---|
SpecificEntropy | s | Specific entropy |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Pressure |
Temperature | T | Temperature |
MassFraction | X[:] | Mass fractions |
Type | Name | Description |
---|---|---|
Density | d | Density |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Pressure |
SpecificEnthalpy | h | Specific enthalpy |
MassFraction | X[:] | Mass fractions |
Type | Name | Description |
---|---|---|
Temperature | T | Temperature |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Pressure |
SpecificEnthalpy | h | Specific enthalpy |
MassFraction | X[:] | Mass fractions |
Type | Name | Description |
---|---|---|
Density | d | Density |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Pressure |
SpecificEntropy | s | Specific entropy |
MassFraction | X[:] | Mass fractions |
Type | Name | Description |
---|---|---|
Temperature | T | Temperature |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Pressure |
SpecificEntropy | s | Specific entropy |
MassFraction | X[:] | Mass fractions |
Type | Name | Description |
---|---|---|
Density | d | Density |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Pressure |
SpecificEntropy | s | Specific entropy |
MassFraction | X[:] | Mass fractions |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | Specific enthalpy |
Extends from Modelica.SIunits.MassFlowRate
.
Name | Value |
---|---|
quantity | "MassFlowRate." + mediumName |
unit | "kg/s" |
min | -100000 |
max | 100000 |
start | 0. |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.gasConstant
(Return the gas constant of the mixture (also for liquids)).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state |
Type | Name | Description |
---|---|---|
SpecificHeatCapacity | R | Mixture gas constant |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
MoleFraction | moleFractions[:] | Mole fractions of mixture |
MolarMass | MMX[:] | Molar masses of components |
Type | Name | Description |
---|---|---|
MassFraction | X[size(moleFractions, 1)] | Mass fractions of gas mixture |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
MassFraction | X[:] | Mass fractions of mixture |
MolarMass | MMX[:] | Molar masses of components |
Type | Name | Description |
---|---|---|
MoleFraction | moleFractions[size(X, 1)] | Mole fractions of gas mixture |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.saturationPressure
(Return saturation pressure of condensing fluid).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
AbsolutePressure | psat | Saturation pressure |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.saturationTemperature
(Return saturation temperature of condensing fluid).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
Temperature | Tsat | Saturation temperature |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.massFractionSaturation
(Return saturation mass fractions).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
MassFraction | Xsat[:] | Saturation mass fractions |
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).
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Pressure |
Temperature | T | Temperature |
Real | phi | Relative humidity |
Type | Name | Description |
---|---|---|
MassFraction | X[:] | Mass fractions |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.relativeHumidity
(Return relative humidity).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
Real | phi | Relative humidity |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.enthalpyOfVaporization
(Return vaporization enthalpy of condensing fluid).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | r0 | Vaporization enthalpy |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.enthalpyOfLiquid
(Return liquid enthalpy of condensing fluid).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | Liquid enthalpy |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.enthalpyOfGas
(Return enthalpy of non-condensing gas mixture).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | Specific enthalpy |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.enthalpyOfCondensingGas
(Return enthalpy of condensing gas (most often steam)).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | Specific enthalpy |
This icon indicates Modelica functions.
Extends from Modelica.Media.Interfaces.PartialRealCondensingGases.enthalpyOfNonCondensingGas
(Return enthalpy of the non-condensing species).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | Specific enthalpy |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Pressure |
SpecificEnthalpy | h | Specific enthalpy |
MassFraction | X[:] | Mass fractions |
Type | Name | Description |
---|---|---|
SpecificEntropy | s | Specific entropy |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
MassFraction | X_sat | Steam mass fraction of sat. boundary |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
MassFraction | x_sat | Absolute humidity per unit mass of dry air |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
MassFraction | X | Mass fraction of water vapor |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
MassFraction | X | Mass fraction of water varpor |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Ambient pressure |
AbsolutePressure | psat | Saturation pressure |
Type | Name | Description |
---|---|---|
MassFraction | X[:] | Mass fraction |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
Real | xw | Water content in kg(water)/kg(dry air) |
Type | Name | Description |
---|---|---|
MassFraction | X[:] | Mass fractions |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
MassFraction | X[:] | Mass fractions |
Type | Name | Description |
---|---|---|
Real | xw | Water content in kg(water)/kg(dry air) |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
AbsolutePressure | psat | Saturation pressure |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
AbsolutePressure | psat | Sublimation pressure |
This icon indicates Modelica functions.
Extends from Modelica.Media.Air.ReferenceMoistAir.enthalpyOfNonCondensingGas
(Return specific enthalpy of dry air).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | Specific enthalpy |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | Specific enthalpy of water |
This icon indicates Modelica functions.
Extends from Modelica.Media.Air.ReferenceMoistAir.enthalpyOfCondensingGas
(Return specific enthalpy of steam).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | Specific enthalpy |
This icon indicates Modelica functions.
Extends from Modelica.Icons.Function
(Icon for functions).
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | Specific enthalpy of water |
Generated 2018-12-12 12:13:51 EST by MapleSim.