Buildings.Media.Steam
Package with model for pure steam water vapor
Information
This medium package models water vapor (pure steam, region 2, quality=1).
Thermodynamic properties are calculated primarily in terms of pressure and temperature. For thermodynamic property functions, the IAPWS-IF97 formulations are adapted, and approximate relationships are provided for commonly used functions to improve computational efficiency and provide backward compatability.
Detailed functions from Modelica.Media.Water.WaterIF97_R2pT are generally used, except for Buildings.Media.Steam.specificEnthalpy and Buildings.Media.Steam.specificEntropy (both "forward" functions), as well as their "backward" inverse functions Buildings.Media.Steam.temperature_ph and Buildings.Media.Steam.temperature_ps, which are numerically consistent with the forward functions. The following modifications were made relative to the Modelica.Media.Water.WaterIF97_R2pT medium package:
- Analytic expressions for the derivatives are provided for all thermodynamic property functions.
- The implementation is generally simpler in order to increase the likelihood of more efficient simulations.
Limitations
- The valid temperature range is 100°C ≤ T ≤ 160°C, and the valid pressure range is 100 kPa ≤ p ≤ 550 kPa.
- When phase change is required, this model is to be used in combination with
Buildings.Media.Water
for the liquid phase (quality=0). Please note that the maximum temperature for liquid
water is
T_max=130°C
. This is suitable for real-world condensate return and boiler feedwater systems, which are typically vented to the atmosphere with steam contained via steam traps (thus,T_max=100°C
for the condensate or feedwater in properly functioning systems).
Applications
This model is intended for first generation district heating systems and other steam heating processes involving low and medium pressure steam.
References
W. Wagner et al., “The IAPWS industrial formulation 1997 for the thermodynamic properties of water and steam,” J. Eng. Gas Turbines Power, vol. 122, no. 1, pp. 150–180, 2000.
Kathryn Hinkelman, Saranya Anbarasu, Michael Wetter, Antoine Gautier, Wangda Zuo. 2022. “A Fast and Accurate Modeling Approach for Water and Steam Thermodynamics with Practical Applications in District Heating System Simulation,” Energy, 254(A), pp. 124227. 10.1016/j.energy.2022.124227
Kathryn Hinkelman, Saranya Anbarasu, Michael Wetter, Antoine Gautier, Baptiste Ravache, Wangda Zuo 2022. “Towards Open-Source Modelica Models For Steam-Based District Heating Systems.” Proc. of the 1st International Workshop On Open Source Modelling And Simulation Of Energy Systems (OSMSES 2022), Aachen, German, April 4-5, 2022. 10.1109/OSMSES54027.2022.9769121
Extends from Modelica.Media.Interfaces.PartialMedium (Partial medium properties (base package of all media packages)), Modelica.Icons.Package (Icon for standard packages).
Package Content
Name | Description |
---|---|
ThermodynamicState | Thermodynamic state variables |
BaseProperties | Base properties (p, d, T, h, u, R, MM) of water |
density | Returns density |
dynamicViscosity | Return dynamic viscosity |
molarMass | Return the molar mass of the medium |
pressure | Return pressure |
saturationPressure | Return saturation pressure of condensing fluid |
saturationTemperature | Return saturation temperature |
specificEnthalpy | Returns specific enthalpy |
specificEntropy | Return specific entropy |
specificInternalEnergy | Return specific internal energy |
specificHeatCapacityCp | Specific heat capacity at constant pressure |
specificHeatCapacityCv | Specific heat capacity at constant volume |
specificGibbsEnergy | Specific Gibbs energy |
specificHelmholtzEnergy | Specific Helmholtz energy |
setState_dTX | Return the thermodynamic state as function of d and T |
setState_pTX | Return the thermodynamic state as function of p and T |
setState_phX | Return the thermodynamic state as function of p and h |
setState_psX | Return the thermodynamic state as function of p and s |
temperature | Return temperature |
thermalConductivity | Return thermal conductivity |
density_derh_p | Density derivative by specific enthalpy |
density_derp_h | Density derivative by pressure |
isentropicExponent | Return isentropic exponent |
isothermalCompressibility | Isothermal compressibility of water |
isobaricExpansionCoefficient | Isobaric expansion coefficient of water |
isentropicEnthalpy | Isentropic enthalpy |
GasProperties | Coefficient data record for properties of perfect gases |
steam | Steam properties |
g2 | Gibbs function for region 2: g(p,T) |
temperature_ph | Return temperature from p and h, inverse function of h(p,T) |
temperature_ps | Return temperature from p and s, inverse function of s(p,T) |
rho_pT | Density as function of temperature and pressure |
pressure_dT | Computes pressure as a function of density and temperature |
Inherited | |
ThermoStates=Modelica.Media.Interfaces.Choices.IndependentVariables.pTX | Enumeration type for independent variables |
mediumName="steam" | Name of the medium |
substanceNames={"water"} | 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 | = 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=true | = true if medium contains the equation X = reference_X |
reference_p=101325 | Reference pressure of Medium: default 1 atmosphere |
reference_T=273.15 | Reference temperature of Medium: default 25 deg Celsius |
reference_X={1} | Default mass fractions of medium |
p_default=100000 | Default value for pressure of medium (for initialization) |
T_default=Modelica.Units.Conversions.from_degC(100) | 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) |
C_default=fill(0, nC) | Default value for trace substances 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 |
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 |
velocityOfSound | Return velocity of sound |
beta | Alias for isobaricExpansionCoefficient for user convenience |
kappa | Alias of isothermalCompressibility for user convenience |
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 |
specificEnthalpy_pTX | Return specific enthalpy from p, T, and X or Xi |
specificEntropy_pTX | Return specific enthalpy from p, T, and X or Xi |
density_pTX | Return density from p, T, and X or Xi |
temperature_phX | Return temperature from p, h, 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 |
Types and constants
constant GasProperties steam(R=Modelica.Media.IdealGases.Common.SingleGasesData.H2O.R_s, MM=Modelica.Media.IdealGases.Common.SingleGasesData.H2O.MM) "Steam properties";
Buildings.Media.Steam.ThermodynamicState
Thermodynamic state variables
Modelica definition
Buildings.Media.Steam.BaseProperties
Base properties (p, d, T, h, u, R, MM) of water
Information
Extends from (Base properties (p, d, T, h, u, R_s, MM and, if applicable, X and Xi) of a medium).
Parameters
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 | true | = true if StateSelect.prefer shall be used for the independent property variables of the medium |
Modelica definition
Buildings.Media.Steam.density
Returns density
Information
Density is computed from temperature and pressure using the IAPWS-IF97 relationship via the Gibbs free energy for region 2.
Extends from (Return density).
Inputs
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Outputs
Type | Name | Description |
---|---|---|
Density | d | Density [kg/m3] |
Modelica definition
Buildings.Media.Steam.dynamicViscosity
Return dynamic viscosity
Information
Dynamic viscosity is computed from density, temperature and pressure using the IAPWS-IF97 formulation.
Extends from (Return dynamic viscosity).
Inputs
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Outputs
Type | Name | Description |
---|---|---|
DynamicViscosity | eta | Dynamic viscosity [Pa.s] |
Modelica definition
Buildings.Media.Steam.molarMass
Return the molar mass of the medium
Information
Returns the molar mass.
Extends from (Return the molar mass of the medium).
Inputs
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Outputs
Type | Name | Description |
---|---|---|
MolarMass | MM | Mixture molar mass [kg/mol] |
Modelica definition
Buildings.Media.Steam.pressure
Return pressure
Information
Pressure is returned from the thermodynamic state record input as a simple assignment.
Extends from (Return pressure).
Inputs
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Outputs
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Pressure [Pa] |
Modelica definition
Buildings.Media.Steam.saturationPressure
Return saturation pressure of condensing fluid
Information
Saturation pressure is computed from temperature using the IAPWS-IF97 formulation.
Extends from Modelica.Icons.Function (Icon for functions).
Inputs
Type | Name | Default | Description |
---|---|---|---|
Temperature | Tsat | Saturation temperature [K] |
Outputs
Type | Name | Description |
---|---|---|
AbsolutePressure | psat | Saturation pressure [Pa] |
Modelica definition
Buildings.Media.Steam.saturationTemperature
Return saturation temperature
Information
Saturation temperature is computed from pressure using the IAPWS-IF97 formulation.
Inputs
Type | Name | Default | Description |
---|---|---|---|
AbsolutePressure | psat | Saturation pressure [Pa] |
Outputs
Type | Name | Description |
---|---|---|
Temperature | Tsat | Saturation temperature [K] |
Modelica definition
Buildings.Media.Steam.specificEnthalpy
Returns specific enthalpy
Information
Returns the specific enthalpy.
Implementation
The function is based on Modelica.Media.Water.WaterIF97_base.specificEnthalpy_pT. However, for the typical range of temperatures and pressures encountered in building and district energy applications, a linear function sufficies. This implementation is therefore a linear surface fit of the IF97 formulation h(p,T) in the ranges of 100°C ≤ T ≤ 160°C and 100 kPa ≤ p ≤ 550 kPa. The fit is scaled by the dataset's mean and standard deviation values to improve conditioning. The largest error of this linearization is 2.42 kJ/kg (0.09%), which occurs at 100.6°C and 100 kPa. The root mean square error (RMSE) is 0.76 kJ/kg.
Extends from (Return specific enthalpy).
Inputs
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Outputs
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h | Specific enthalpy [J/kg] |
Modelica definition
Buildings.Media.Steam.specificEntropy
Return specific entropy
Information
Returns the specific entropy.
Implementation
The function is based on Modelica.Media.Water.WaterIF97_base.specificEntropy. However, for the typical range of temperatures and pressures encountered in building and district energy applications, an invertible polynomial fit sufficies. This implementation is therefore a polynomial fit (quadratic in pressure, linear in temperature) of the IF97 formulation s(p,T) in the ranges of 100°C ≤ T ≤ 160°C and 100 kPa ≤ p ≤ 550 kPa. The fit is scaled by the dataset's mean and standard deviation values to improve conditioning. The largest error of this approximation is 0.047 kJ/kg-K (0.70%), which occurs at 160°C and 550 kPa. The root mean square error (RMSE) is 12.56 J/kg-K.
Extends from (Return specific entropy).
Inputs
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Outputs
Type | Name | Description |
---|---|---|
SpecificEntropy | s | Specific entropy [J/(kg.K)] |
Modelica definition
Buildings.Media.Steam.specificInternalEnergy
Return specific internal energy
Information
Returns the specific internal energy for a given state.
Extends from (Return specific internal energy).
Inputs
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Outputs
Type | Name | Description |
---|---|---|
SpecificEnergy | u | Specific internal energy [J/kg] |
Modelica definition
Buildings.Media.Steam.specificHeatCapacityCp
Specific heat capacity at constant pressure
Information
Specific heat at constant pressure is computed from temperature and pressure using the IAPWS-IF97 relationship via the Gibbs free energy for region 2.
Extends from (Return specific heat capacity at constant pressure).
Inputs
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Outputs
Type | Name | Description |
---|---|---|
SpecificHeatCapacity | cp | Specific heat capacity at constant pressure [J/(kg.K)] |
Modelica definition
Buildings.Media.Steam.specificHeatCapacityCv
Specific heat capacity at constant volume
Information
Specific heat at constant volume is computed from temperature and pressure using the IAPWS-IF97 relationship via the Gibbs free energy for region 2.
Extends from (Return specific heat capacity at constant volume).
Inputs
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Outputs
Type | Name | Description |
---|---|---|
SpecificHeatCapacity | cv | Specific heat capacity at constant volume [J/(kg.K)] |
Modelica definition
Buildings.Media.Steam.specificGibbsEnergy
Specific Gibbs energy
Information
Extends from (Return specific Gibbs energy).
Inputs
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Outputs
Type | Name | Description |
---|---|---|
SpecificEnergy | g | Specific Gibbs energy [J/kg] |
Modelica definition
Buildings.Media.Steam.specificHelmholtzEnergy
Specific Helmholtz energy
Information
Returns the specific Helmholtz energy for a given state.
Extends from (Return specific Helmholtz energy).
Inputs
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Outputs
Type | Name | Description |
---|---|---|
SpecificEnergy | f | Specific Helmholtz energy [J/kg] |
Modelica definition
Buildings.Media.Steam.setState_dTX
Return the thermodynamic state as function of d and T
Information
The thermodynamic state record
is computed from density d
and temperature T
.
Extends from (Return thermodynamic state as function of d, T and composition X or Xi).
Inputs
Type | Name | Default | Description |
---|---|---|---|
Density | d | Density [kg/m3] | |
Temperature | T | Temperature [K] | |
MassFraction | X[:] | reference_X | Mass fractions [kg/kg] |
Outputs
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Modelica definition
Buildings.Media.Steam.setState_pTX
Return the thermodynamic state as function of p and T
Information
The thermodynamic state record
is computed from pressure p
and temperature T
.
Extends from (Return thermodynamic state as function of p, T and composition X or Xi).
Inputs
Type | Name | Default | Description |
---|---|---|---|
AbsolutePressure | p | Pressure [Pa] | |
Temperature | T | Temperature [K] | |
MassFraction | X[:] | reference_X | Mass fractions [kg/kg] |
Outputs
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Modelica definition
Buildings.Media.Steam.setState_phX
Return the thermodynamic state as function of p and h
Information
The thermodynamic state record
is computed from pressure p
and specific enthalpy h
.
Extends from (Return thermodynamic state as function of p, h and composition X or Xi).
Inputs
Type | Name | Default | Description |
---|---|---|---|
AbsolutePressure | p | Pressure [Pa] | |
SpecificEnthalpy | h | Specific enthalpy [J/kg] | |
MassFraction | X[:] | reference_X | Mass fractions [kg/kg] |
Outputs
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Modelica definition
Buildings.Media.Steam.setState_psX
Return the thermodynamic state as function of p and s
Information
The thermodynamic state record
is computed from pressure p
and specific entropy s
.
Extends from (Return thermodynamic state as function of p, s and composition X or Xi).
Inputs
Type | Name | Default | Description |
---|---|---|---|
AbsolutePressure | p | Pressure [Pa] | |
SpecificEntropy | s | Specific entropy [J/(kg.K)] | |
MassFraction | X[:] | reference_X | Mass fractions [kg/kg] |
Outputs
Type | Name | Description |
---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Modelica definition
Buildings.Media.Steam.temperature
Return temperature
Information
Temperature is returned from the thermodynamic state record input as a simple assignment.
Extends from (Return temperature).
Inputs
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Outputs
Type | Name | Description |
---|---|---|
Temperature | T | Temperature [K] |
Modelica definition
Buildings.Media.Steam.thermalConductivity
Return thermal conductivity
Information
Thermal conductivity is computed from density, temperature and pressure using the IAPWS-IF97 formulation.
Extends from (Return thermal conductivity).
Inputs
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Outputs
Type | Name | Description |
---|---|---|
ThermalConductivity | lambda | Thermal conductivity [W/(m.K)] |
Modelica definition
Buildings.Media.Steam.density_derh_p
Density derivative by specific enthalpy
Information
Returns the partial derivative of density with respect to specific enthalpy at constant pressure using the IAPWS-IF97 formulation.
Extends from (Return density derivative w.r.t. specific enthalpy at constant pressure).
Inputs
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Outputs
Type | Name | Description |
---|---|---|
DerDensityByEnthalpy | ddhp | Density derivative w.r.t. specific enthalpy [kg.s2/m5] |
Modelica definition
Buildings.Media.Steam.density_derp_h
Density derivative by pressure
Information
Returns the partial derivative of density with respect to pressure at constant specific enthalpy using the IAPWS-IF97 formulation.
Extends from (Return density derivative w.r.t. pressure at const specific enthalpy).
Inputs
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Outputs
Type | Name | Description |
---|---|---|
DerDensityByPressure | ddph | Density derivative w.r.t. pressure [s2/m2] |
Modelica definition
Buildings.Media.Steam.isentropicExponent
Return isentropic exponent
Information
Isentropic exponent is computed from temperature and pressure using the IAPWS-IF97 formulation.
Extends from (Return isentropic exponent).
Inputs
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Outputs
Type | Name | Description |
---|---|---|
IsentropicExponent | gamma | Isentropic exponent [1] |
Modelica definition
Buildings.Media.Steam.isothermalCompressibility
Isothermal compressibility of water
Information
Isothermal compressibility is computed from temperature and pressure using the IAPWS-IF97 formulation.
Extends from (Return overall the isothermal compressibility factor).
Inputs
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Outputs
Type | Name | Description |
---|---|---|
IsothermalCompressibility | kappa | Isothermal compressibility [1/Pa] |
Modelica definition
Buildings.Media.Steam.isobaricExpansionCoefficient
Isobaric expansion coefficient of water
Information
Isobaric expansion coefficient is computed from temperature and pressure using the IAPWS-IF97 formulation.
Extends from (Return overall the isobaric expansion coefficient beta).
Inputs
Type | Name | Default | Description |
---|---|---|---|
ThermodynamicState | state | Thermodynamic state record |
Outputs
Type | Name | Description |
---|---|---|
IsobaricExpansionCoefficient | beta | Isobaric expansion coefficient [1/K] |
Modelica definition
Buildings.Media.Steam.isentropicEnthalpy
Isentropic enthalpy
Information
Isentropic enthalpy is computed using the IAPWS-IF97 formulation:
- A medium is in a particular state,
refState
. - The enthalpy at another state
h_is
shall be computed under the assumption that the state transformation fromrefState
toh_is
is performed with a change of specific entropy ds = 0 and the pressure of stateh_is
isp_downstream
and the compositionX
upstream and downstream is assumed to be the same.
Extends from (Return isentropic enthalpy).
Inputs
Type | Name | Default | Description |
---|---|---|---|
AbsolutePressure | p_downstream | Downstream pressure [Pa] | |
ThermodynamicState | refState | Reference state for entropy |
Outputs
Type | Name | Description |
---|---|---|
SpecificEnthalpy | h_is | Isentropic enthalpy [J/kg] |
Modelica definition
Buildings.Media.Steam.GasProperties
Coefficient data record for properties of perfect gases
Information
Extends from Modelica.Icons.Record (Icon for records).
Modelica definition
Buildings.Media.Steam.g2
Gibbs function for region 2: g(p,T)
Information
This function is identical to Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic.g2 except that
- it contains the
smoothOrder
annotation, and - it removes the assertions on the temperature and pressure because the applicability of this medium is steam heating which has medium states that are inside these values.
The smoothOrder
is needed for Optimica to differentiate the specific heat capacity,
which is used in
Buildings.Media.Examples.SteamDerivativeCheck.
The function is differentiable except at p=0
, which is far away from the state for which
this function is used.
Extends from Modelica.Icons.Function (Icon for functions).
Inputs
Type | Name | Default | Description |
---|---|---|---|
Pressure | p | Pressure [Pa] | |
Temperature | T | Temperature (K) [K] |
Outputs
Type | Name | Description |
---|---|---|
GibbsDerivs | g | Dimensionless Gibbs function and derivatives w.r.t. pi and tau |
Modelica definition
Buildings.Media.Steam.temperature_ph
Return temperature from p and h, inverse function of h(p,T)
Information
Returns temperature from specific enthalpy and pressure.
Implementation
This linear approximation is the inverse or backward function of Buildings.Media.Steam.specificEnthalpy and is numerically consistent with that forward function.
The largest error of this linearization is 1.17°C (0.31%), which occurs at 100°C and 100 kPa.
Inputs
Type | Name | Default | Description |
---|---|---|---|
AbsolutePressure | p | Pressure [Pa] | |
SpecificEnthalpy | h | Specific Enthalpy [J/kg] |
Outputs
Type | Name | Description |
---|---|---|
Temperature | T | Temperature [K] |
Modelica definition
Buildings.Media.Steam.temperature_ps
Return temperature from p and s, inverse function of s(p,T)
Information
Returns temperature from specific entropy and pressure.
Implementation
This polynomial approximation is the inverse or backward function of Buildings.Media.Steam.specificEntropy and is numerically consistent with that forward function.
The largest error of this linearization is 7.70°C (1.86%), which occurs at 137.4°C and 100 kPa.
Inputs
Type | Name | Default | Description |
---|---|---|---|
AbsolutePressure | p | Pressure [Pa] | |
SpecificEntropy | s | Specific Entropy [J/(kg.K)] |
Outputs
Type | Name | Description |
---|---|---|
Temperature | T | Temperature [K] |
Modelica definition
Buildings.Media.Steam.rho_pT
Density as function of temperature and pressure
Information
Density is computed from temperature and pressure using the IAPWS-IF97 relationship via the Gibbs free energy for region 2.
Extends from Modelica.Icons.Function (Icon for functions).
Inputs
Type | Name | Default | Description |
---|---|---|---|
AbsolutePressure | p | Pressure [Pa] | |
Temperature | T | Temperature [K] |
Outputs
Type | Name | Description |
---|---|---|
Density | rho | Density [kg/m3] |
Modelica definition
Buildings.Media.Steam.pressure_dT
Computes pressure as a function of density and temperature
Inputs
Type | Name | Default | Description |
---|---|---|---|
Density | d | Density [kg/m3] | |
Temperature | T | Temperature [K] |
Outputs
Type | Name | Description |
---|---|---|
AbsolutePressure | p | Pressure [Pa] |