Model for air as a perfect gas
This package contains a thermally perfect model of moist air.
A medium is called thermally perfect if
In addition, this medium model is calorically perfect, i.e., the specific heat capacities at constant pressure cp and constant volume cv are both constant (Bower 1998).
This medium uses the ideal gas law
ρ = p ⁄(R T),
where ρ is the density, p is the pressure, R is the gas constant and T is the temperature.
The enthalpy is computed using the convention that h=0 if T=0 °C and no water vapor is present.
Note that for typical building simulations, the media Annex60.Media.Air should be used as it leads generally to faster simulation.
Bower, William B. A primer in fluid mechanics: Dynamics of flows in one space dimension. CRC Press. 1998.
Extends from Modelica.Media.Interfaces.PartialCondensingGases (Base class for mixtures of condensing and non-condensing gases), Modelica.Icons.Package (Icon for standard packages).
Name | Description |
---|---|
Water=1 | Index of water (in substanceNames, massFractions X, etc.) |
Air=2 | Index of air (in substanceNames, massFractions X, etc.) |
ThermodynamicState | ThermodynamicState record for moist air |
BaseProperties | |
Xsaturation | Steam water mass fraction of saturation boundary in kg_water/kg_moistair |
setState_pTX | Thermodynamic state as function of p, T and composition X |
setState_phX | Thermodynamic state as function of p, h and composition X |
setState_dTX | Thermodynamic state as function of d, T and composition X |
gasConstant | Gas constant |
saturationPressureLiquid | Return saturation pressure of water as a function of temperature T in the range of 273.16 to 373.16 K |
saturationPressureLiquid_der | Time derivative of saturationPressureLiquid |
sublimationPressureIce | Saturation curve valid for 223.16 <= T <= 273.16. Outside of these limits a (less accurate) result is returned |
sublimationPressureIce_der | Derivative function for 'sublimationPressureIce' |
saturationPressure | Saturation curve valid for 223.16 <= T <= 373.16 (and slightly outside with less accuracy) |
pressure | Gas pressure |
temperature | Gas temperature |
density | Gas density |
specificEntropy | Specific entropy (liquid part neglected, mixing entropy included) |
enthalpyOfVaporization | Enthalpy of vaporization of water |
HeatCapacityOfWater | Specific heat capacity of water (liquid only) which is constant |
enthalpyOfLiquid | Enthalpy of liquid (per unit mass of liquid) which is linear in the temperature |
der_enthalpyOfLiquid | Temperature derivative of enthalpy of liquid per unit mass of liquid |
enthalpyOfCondensingGas | Enthalpy of steam per unit mass of steam |
der_enthalpyOfCondensingGas | Derivative of enthalpy of steam per unit mass of steam |
enthalpyOfNonCondensingGas | Enthalpy of non-condensing gas per unit mass of steam |
der_enthalpyOfNonCondensingGas | Derivative of enthalpy of non-condensing gas per unit mass of steam |
enthalpyOfGas | Enthalpy of gas mixture per unit mass of gas mixture |
enthalpyOfDryAir | Enthalpy of dry air per unit mass of dry air |
der_enthalpyOfDryAir | Derivative of enthalpy of dry air per unit mass of dry air |
specificHeatCapacityCp | Specific heat capacity of gas mixture at constant pressure |
der_specificHeatCapacityCp | Derivative of specific heat capacity of gas mixture at constant pressure |
specificHeatCapacityCv | Specific heat capacity of gas mixture at constant volume |
der_specificHeatCapacityCv | Derivative of specific heat capacity of gas mixture at constant volume |
dynamicViscosity | dynamic viscosity of dry air |
thermalConductivity | Thermal conductivity of dry air as a polynomial in the temperature |
specificEnthalpy | Specific enthalpy |
specificEnthalpy_pTX | Specific enthalpy |
specificInternalEnergy | Specific internal energy |
specificGibbsEnergy | Specific Gibbs energy |
specificHelmholtzEnergy | Specific Helmholtz energy |
temperature_phX | Compute temperature from specific enthalpy and mass fraction |
GasProperties | Coefficient data record for properties of perfect gases |
dryair | Dry air properties |
steam | Steam properties |
k_mair=steam.MM/dryair.MM | Ratio of molar weights |
h_fg=Annex60.Utilities.Psychrometrics.Constants.h_fg | Latent heat of evaporation of water |
cpWatLiq=Annex60.Utilities.Psychrometrics.Constants.cpWatLiq | Specific heat capacity of liquid water |
s_pTX | Return specific entropy of moist air as a function of pressure p, temperature T and composition X (only valid for phi<1) |
s_pTX_der | Return specific entropy of moist air as a function of pressure p, temperature T and composition X (only valid for phi<1) |
Inherited | |
fluidConstants | Constant data for the fluid |
moleToMassFractions | Return mass fractions X from mole fractions |
massToMoleFractions | Return mole fractions from mass fractions X |
ThermoStates | Enumeration type for independent variables |
mediumName="unusablePartialMedium" | Name of the medium |
substanceNames={mediumName} | Names of the mixture substances. Set substanceNames={mediumName} if only one substance. |
extraPropertiesNames=fill("", 0) | Names of the additional (extra) transported properties. Set extraPropertiesNames=fill("",0) if unused |
singleState | = true, if u and d are not a function of pressure |
reducedX=true | = true if medium contains the equation sum(X) = 1.0; set reducedX=true if only one substance (see docu for details) |
fixedX=false | = true if medium contains the equation X = reference_X |
reference_p=101325 | Reference pressure of Medium: default 1 atmosphere |
reference_T=298.15 | Reference temperature of Medium: default 25 deg Celsius |
reference_X=fill(1/nX, nX) | Default mass fractions of medium |
p_default=101325 | Default value for pressure of medium (for initialization) |
T_default=Modelica.SIunits.Conversions.from_degC(20) | Default value for temperature of medium (for initialization) |
h_default=specificEnthalpy_pTX(p_default, T_default, X_default) | Default value for specific enthalpy of medium (for initialization) |
X_default=reference_X | Default value for mass fractions of medium (for initialization) |
nS=size(substanceNames, 1) | Number of substances |
nX=nS | Number of mass fractions |
nXi=if fixedX then 0 else if reducedX then nS - 1 else nS | Number of structurally independent mass fractions (see docu for details) |
nC=size(extraPropertiesNames, 1) | Number of extra (outside of standard mass-balance) transported properties |
C_nominal=1.0e-6*ones(nC) | Default for the nominal values for the extra properties |
FluidConstants | Critical, triple, molecular and other standard data of fluid |
setState_psX | Return thermodynamic state as function of p, s and composition X or Xi |
setSmoothState | Return thermodynamic state so that it smoothly approximates: if x > 0 then state_a else state_b |
prandtlNumber | Return the Prandtl number |
heatCapacity_cp | Alias for deprecated name |
heatCapacity_cv | Alias for deprecated name |
isentropicExponent | Return isentropic exponent |
isentropicEnthalpy | Return isentropic enthalpy |
velocityOfSound | Return velocity of sound |
isobaricExpansionCoefficient | Return overall the isobaric expansion coefficient beta |
beta | Alias for isobaricExpansionCoefficient for user convenience |
isothermalCompressibility | Return overall the isothermal compressibility factor |
kappa | Alias of isothermalCompressibility for user convenience |
density_derp_h | Return density derivative w.r.t. pressure at const specific enthalpy |
density_derh_p | Return density derivative w.r.t. specific enthalpy at constant pressure |
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 |
molarMass | Return the molar mass of the medium |
specificEntropy_pTX | Return specific enthalpy from p, T, and X or Xi |
density_pTX | Return density from p, T, and X or Xi |
density_phX | Return density from p, h, and X or Xi |
temperature_psX | Return temperature from p,s, and X or Xi |
density_psX | Return density from p, s, and X or Xi |
specificEnthalpy_psX | Return specific enthalpy from p, s, and X or Xi |
MassFlowRate | Type for mass flow rate with medium specific attributes |
AbsolutePressure | Type for absolute pressure with medium specific attributes |
Density | Type for density with medium specific attributes |
DynamicViscosity | Type for dynamic viscosity with medium specific attributes |
EnthalpyFlowRate | Type for enthalpy flow rate with medium specific attributes |
MassFraction | Type for mass fraction with medium specific attributes |
MoleFraction | Type for mole fraction with medium specific attributes |
MolarMass | Type for molar mass with medium specific attributes |
MolarVolume | Type for molar volume with medium specific attributes |
IsentropicExponent | Type for isentropic exponent with medium specific attributes |
SpecificEnergy | Type for specific energy with medium specific attributes |
SpecificInternalEnergy | Type for specific internal energy with medium specific attributes |
SpecificEnthalpy | Type for specific enthalpy with medium specific attributes |
SpecificEntropy | Type for specific entropy with medium specific attributes |
SpecificHeatCapacity | Type for specific heat capacity with medium specific attributes |
SurfaceTension | Type for surface tension with medium specific attributes |
Temperature | Type for temperature with medium specific attributes |
ThermalConductivity | Type for thermal conductivity with medium specific attributes |
PrandtlNumber | Type for Prandtl number with medium specific attributes |
VelocityOfSound | Type for velocity of sound with medium specific attributes |
ExtraProperty | Type for unspecified, mass-specific property transported by flow |
CumulativeExtraProperty | Type for conserved integral of unspecified, mass specific property |
ExtraPropertyFlowRate | Type for flow rate of unspecified, mass-specific property |
IsobaricExpansionCoefficient | Type for isobaric expansion coefficient with medium specific attributes |
DipoleMoment | Type for dipole moment with medium specific attributes |
DerDensityByPressure | Type for partial derivative of density with respect to pressure with medium specific attributes |
DerDensityByEnthalpy | Type for partial derivative of density with respect to enthalpy with medium specific attributes |
DerEnthalpyByPressure | Type for partial derivative of enthalpy with respect to pressure with medium specific attributes |
DerDensityByTemperature | Type for partial derivative of density with respect to temperature with medium specific attributes |
DerTemperatureByPressure | Type for partial derivative of temperature with respect to pressure with medium specific attributes |
SaturationProperties | Saturation properties of two phase medium |
FluidLimits | Validity limits for fluid model |
FixedPhase | Phase of the fluid: 1 for 1-phase, 2 for two-phase, 0 for not known, e.g., interactive use |
Basic | The most basic version of a record used in several degrees of detail |
IdealGas | The ideal gas version of a record used in several degrees of detail |
TwoPhase | The two phase fluid version of a record used in several degrees of detail |
constant Integer Water=1 "Index of water (in substanceNames, massFractions X, etc.)";
constant Integer Air=2 "Index of air (in substanceNames, massFractions X, etc.)";
constant GasProperties dryair( R = Modelica.Media.IdealGases.Common.SingleGasesData.Air.R, MM = Modelica.Media.IdealGases.Common.SingleGasesData.Air.MM, cp = Annex60.Utilities.Psychrometrics.Constants.cpAir, cv = Annex60.Utilities.Psychrometrics.Constants.cpAir -Modelica.Media.IdealGases.Common.SingleGasesData.Air.R) "Dry air properties";
constant GasProperties steam( R = Modelica.Media.IdealGases.Common.SingleGasesData.H2O.R, MM = Modelica.Media.IdealGases.Common.SingleGasesData.H2O.MM, cp = Annex60.Utilities.Psychrometrics.Constants.cpSte, cv = Annex60.Utilities.Psychrometrics.Constants.cpSte -Modelica.Media.IdealGases.Common.SingleGasesData.H2O.R) "Steam properties";
constant Real k_mair = steam.MM/dryair.MM "Ratio of molar weights";
constant Modelica.SIunits.SpecificEnergy h_fg= Annex60.Utilities.Psychrometrics.Constants.h_fg "Latent heat of evaporation of water";
constant Modelica.SIunits.SpecificHeatCapacity cpWatLiq= Annex60.Utilities.Psychrometrics.Constants.cpWatLiq "Specific heat capacity of liquid water";
ThermodynamicState record for moist air
Extends from (Thermodynamic state variables).
Extends from (Base properties (p, d, T, h, u, R, MM and, if applicable, X and Xi) of a medium).
Type | Name | Default | Description |
---|---|---|---|
Boolean | standardOrderComponents | true | If true, and reducedX = true, the last element of X will be computed from the other ones |
Advanced | |||
Boolean | preferredMediumStates | false | = true if StateSelect.prefer shall be used for the independent property variables of the medium |
Steam water mass fraction of saturation boundary in kg_water/kg_moistair
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
MassFraction | X_sat | Steam mass fraction of sat. boundary [kg/kg] |
Thermodynamic state as function of p, T and composition X
Extends from Modelica.Media.Air.MoistAir.setState_pTX (Return thermodynamic state as function of pressure p, temperature T and composition X).
Type | Name | Default | Description |
---|---|---|---|
AbsolutePressure | p | Pressure [Pa] | |
Temperature | T | Temperature [K] | |
MassFraction | X[:] | reference_X | Mass fractions [kg/kg] |
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state |
Thermodynamic state as function of p, h and composition X
Extends from Modelica.Icons.Function (Icon for functions).
Type | Name | Default | Description |
---|---|---|---|
AbsolutePressure | p | Pressure [Pa] | |
SpecificEnthalpy | h | Specific enthalpy [J/kg] | |
MassFraction | X[:] | Mass fractions [kg/kg] |
Type | Name | Description |
---|---|---|
ThermodynamicState | state |
Thermodynamic state as function of d, T and composition X
Extends from Modelica.Icons.Function (Icon for functions).
Type | Name | Default | Description |
---|---|---|---|
Density | d | Density [kg/m3] | |
Temperature | T | Temperature [K] | |
MassFraction | X[:] | reference_X | Mass fractions [kg/kg] |
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state |
Gas constant
Extends from (Return the gas constant of the mixture (also for liquids)).
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state |
Type | Name | Description |
---|---|---|
SpecificHeatCapacity | R | Mixture gas constant [J/(kg.K)] |
Return saturation pressure of water as a function of temperature T in the range of 273.16 to 373.16 K
Extends from Modelica.Icons.Function (Icon for functions).
Type | Name | Default | Description |
---|---|---|---|
Temperature | Tsat | saturation temperature [K] |
Type | Name | Description |
---|---|---|
AbsolutePressure | psat | saturation pressure [Pa] |
Time derivative of saturationPressureLiquid
Extends from Modelica.Icons.Function (Icon for functions).
Type | Name | Default | Description |
---|---|---|---|
Temperature | Tsat | Saturation temperature [K] | |
Real | dTsat | Saturation temperature derivative [K/s] |
Type | Name | Description |
---|---|---|
Real | psat_der | Saturation pressure [Pa/s] |
Saturation curve valid for 223.16 <= T <= 273.16. Outside of these limits a (less accurate) result is returned
Type | Name | Default | Description |
---|---|---|---|
Temperature | Tsat | Sublimation temperature [K] |
Type | Name | Description |
---|---|---|
AbsolutePressure | psat | Sublimation pressure [Pa] |
Derivative function for 'sublimationPressureIce'
Type | Name | Default | Description |
---|---|---|---|
Temperature | Tsat | Sublimation temperature [K] | |
Real | dTsat | Sublimation temperature derivative [K/s] |
Type | Name | Description |
---|---|---|
Real | psat_der | Sublimation pressure derivative [Pa/s] |
Saturation curve valid for 223.16 <= T <= 373.16 (and slightly outside with less accuracy)
Extends from (Return saturation pressure of condensing fluid).
Type | Name | Default | Description |
---|---|---|---|
Temperature | Tsat | Saturation temperature [K] |
Type | Name | Description |
---|---|---|
AbsolutePressure | psat | Saturation pressure [Pa] |
Gas pressure
Extends from (Return pressure).
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Pressure [Pa] |
Gas temperature
Extends from (Return temperature).
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
Temperature | T | Temperature [K] |
Gas density
Extends from (Return density).
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
Density | d | Density [kg/m3] |
Specific entropy (liquid part neglected, mixing entropy included)
Extends from (Return specific entropy).
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEntropy | s | Specific entropy [J/(kg.K)] |
Enthalpy of vaporization of water
Extends from (Return vaporization enthalpy of condensing fluid).
Type | Name | Default | Description |
---|---|---|---|
Temperature | T | Temperature [K] |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | r0 | Vaporization enthalpy [J/kg] |
Specific heat capacity of water (liquid only) which is constant
Extends from Modelica.Icons.Function (Icon for functions).
Type | Name | Default | Description |
---|---|---|---|
Temperature | T | [K] |
Type | Name | Description |
---|---|---|
SpecificHeatCapacity | cp_fl | [J/(kg.K)] |
Enthalpy of liquid (per unit mass of liquid) which is linear in the temperature
Extends from (Return liquid enthalpy of condensing fluid).
Type | Name | Default | Description |
---|---|---|---|
Temperature | T | Temperature [K] |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | Liquid enthalpy [J/kg] |
Temperature derivative of enthalpy of liquid per unit mass of liquid
Extends from Modelica.Icons.Function (Icon for functions).
Type | Name | Default | Description |
---|---|---|---|
Temperature | T | temperature [K] | |
Real | der_T | temperature derivative |
Type | Name | Description |
---|---|---|
Real | der_h | derivative of liquid enthalpy |
Enthalpy of steam per unit mass of steam
Extends from Modelica.Icons.Function (Icon for functions).
Type | Name | Default | Description |
---|---|---|---|
Temperature | T | temperature [K] |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | steam enthalpy [J/kg] |
Derivative of enthalpy of steam per unit mass of steam
Extends from Modelica.Icons.Function (Icon for functions).
Type | Name | Default | Description |
---|---|---|---|
Temperature | T | temperature [K] | |
Real | der_T | temperature derivative |
Type | Name | Description |
---|---|---|
Real | der_h | derivative of steam enthalpy |
Enthalpy of non-condensing gas per unit mass of steam
Extends from Modelica.Icons.Function (Icon for functions).
Type | Name | Default | Description |
---|---|---|---|
Temperature | T | temperature [K] |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | enthalpy [J/kg] |
Derivative of enthalpy of non-condensing gas per unit mass of steam
Extends from Modelica.Icons.Function (Icon for functions).
Type | Name | Default | Description |
---|---|---|---|
Temperature | T | temperature [K] | |
Real | der_T | temperature derivative |
Type | Name | Description |
---|---|---|
Real | der_h | derivative of steam enthalpy |
Enthalpy of gas mixture per unit mass of gas mixture
Extends from (Return enthalpy of non-condensing gas mixture).
Type | Name | Default | Description |
---|---|---|---|
Temperature | T | Temperature [K] | |
MassFraction | X[:] | Vector of mass fractions [kg/kg] |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | Specific enthalpy [J/kg] |
Enthalpy of dry air per unit mass of dry air
Extends from Modelica.Icons.Function (Icon for functions).
Type | Name | Default | Description |
---|---|---|---|
Temperature | T | temperature [K] |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | dry air enthalpy [J/kg] |
Derivative of enthalpy of dry air per unit mass of dry air
Extends from Modelica.Icons.Function (Icon for functions).
Type | Name | Default | Description |
---|---|---|---|
Temperature | T | temperature [K] | |
Real | der_T | temperature derivative |
Type | Name | Description |
---|---|---|
Real | der_h | derivative of dry air enthalpy |
Specific heat capacity of gas mixture at constant pressure
Extends from (Return specific heat capacity at constant pressure).
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificHeatCapacity | cp | Specific heat capacity at constant pressure [J/(kg.K)] |
Derivative of specific heat capacity of gas mixture at constant pressure
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | ||
ThermodynamicState | der_state |
Type | Name | Description |
---|---|---|
Real | der_cp | [J/(kg.K.s)] |
Specific heat capacity of gas mixture at constant volume
Extends from (Return specific heat capacity at constant volume).
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificHeatCapacity | cv | Specific heat capacity at constant volume [J/(kg.K)] |
Derivative of specific heat capacity of gas mixture at constant volume
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | ||
ThermodynamicState | der_state |
Type | Name | Description |
---|---|---|
Real | der_cv | [J/(kg.K.s)] |
dynamic viscosity of dry air
Extends from (Return dynamic viscosity).
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
DynamicViscosity | eta | Dynamic viscosity [Pa.s] |
Thermal conductivity of dry air as a polynomial in the temperature
Extends from (Return thermal conductivity).
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
ThermalConductivity | lambda | Thermal conductivity [W/(m.K)] |
Specific enthalpy
Extends from (Return specific enthalpy).
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | Specific enthalpy [J/kg] |
Specific enthalpy
Extends from Modelica.Icons.Function (Icon for functions).
Type | Name | Default | Description |
---|---|---|---|
Pressure | p | Pressure [Pa] | |
Temperature | T | Temperature [K] | |
MassFraction | X[:] | Mass fractions of moist air [1] |
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | Specific enthalpy at p, T, X [J/kg] |
Specific internal energy
Extends from Modelica.Icons.Function (Icon for functions), (Return specific internal energy).
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEnergy | u | Specific internal energy [J/kg] |
Specific Gibbs energy
Extends from Modelica.Icons.Function (Icon for functions), (Return specific Gibbs energy).
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEnergy | g | Specific Gibbs energy [J/kg] |
Specific Helmholtz energy
Extends from Modelica.Icons.Function (Icon for functions), (Return specific Helmholtz energy).
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Type | Name | Description |
---|---|---|
SpecificEnergy | f | Specific Helmholtz energy [J/kg] |
Compute temperature from specific enthalpy and mass fraction
Extends from Modelica.Icons.Function (Icon for functions).
Type | Name | Default | Description |
---|---|---|---|
AbsolutePressure | p | Pressure [Pa] | |
SpecificEnthalpy | h | specific enthalpy [J/kg] | |
MassFraction | X[:] | mass fractions of composition [kg/kg] |
Type | Name | Description |
---|---|---|
Temperature | T | temperature [K] |
Coefficient data record for properties of perfect gases
This data record contains the coefficients for perfect gases.
Extends from Modelica.Icons.Record (Icon for records).
Return specific entropy of moist air as a function of pressure p, temperature T and composition X (only valid for phi<1)
Type | Name | Default | Description |
---|---|---|---|
Pressure | p | Pressure [Pa] | |
Temperature | T | Temperature [K] | |
MassFraction | X[:] | Mass fractions of moist air [1] |
Type | Name | Description |
---|---|---|
SpecificEntropy | s | Specific entropy at p, T, X [J/(kg.K)] |
Return specific entropy of moist air as a function of pressure p, temperature T and composition X (only valid for phi<1)
Type | Name | Default | Description |
---|---|---|---|
Pressure | p | Pressure [Pa] | |
Temperature | T | Temperature [K] | |
MassFraction | X[:] | Mass fractions of moist air [1] | |
Real | dp | Derivative of pressure [Pa/s] | |
Real | dT | Derivative of temperature [K/s] | |
Real | dX[nX] | Derivative of mass fractions [1/s] |
Type | Name | Description |
---|---|---|
Real | ds | Specific entropy at p, T, X [J/(kg.K.s)] |