Buildings.Media.Antifreeze.EthyleneGlycolWater
Package with model for ethylene glycol - water with constant properties
Information
This medium package models ethylene glycol - water mixtures.
The mass density, specific heat capacity, thermal conductivity and viscosity are assumed constant and evaluated at a set temperature and mass fraction of ethylene glycol within the mixture. The dependence of the four properties are shown on the figure below.
The accuracy of the thermophysical properties is dependent on the temperature variations encountered during simulations. The figure below shows the relative error of the the four properties over a 10 °C range around the temperature used to evaluate the constant properties. The maximum errors are 0.8 % for mass density, 2.7 % for specific heat capacity, 3.2 % for thermal conductivity and 160 % for dynamic viscosity.
The figure below shows the relative error of the the four properties over a 20 °C range around the temperature used to evaluate the constant proepties. The maximum errors are 1.5 % for mass density, 5.3 % for specific heat capacity, 5.9 % for thermal conductivity and 500 % for dynamic viscosity.
The enthalpy is computed using the convention that h=0 if T=0 °C.
Limitations
Density, specific heat capacity, thermal conductivity and viscosity are constant. The ethylene glycol/water mixture is modeled as an incompressible liquid. There are no phase changes. The medium is limited to temperatures below 100 °C and mass fractions below 0.60. As is the case for Buildings.Media.Water, this medium package should not be used if the simulation relies on the dynamic viscosity.
Typical use and important parameters
The temperature and mass fraction must be specified for the evaluation of the constant thermophysical properties. A typical use of the package is (e.g. for a temperature of 20 °C and a mass fraction of 0.40):
Medium = Buildings.Media.Antifreeze.EthyleneGlycolWater(property_T=293.15, X_a=0.40)
Extends from Modelica.Media.Interfaces.PartialSimpleMedium (Medium model with linear dependency of u, h from temperature. All other quantities, especially density, are constant.).
Package Content
Name | Description |
---|---|
property_T | Temperature for evaluation of constant fluid properties |
X_a | Mass fraction of propylene glycol in water |
BaseProperties | Base properties |
X_a_min=0. | Minimum allowed mass fraction of ethylene glycol in water |
X_a_max=0.6 | Maximum allowed mass fraction of propylene glycol in water |
simpleEthyleneGlycolWaterConstants | |
proCoe | Coefficients for evaluation of thermo-physical properties |
density_TX_a | Evaluate density of antifreeze-water mixture |
dynamicViscosity_TX_a | Evaluate dynamic viscosity of antifreeze-water mixture |
fusionTemperature_TX_a | Evaluate temperature of fusion of antifreeze-water mixture |
polynomialProperty | Evaluates thermophysical property from 2-variable polynomial |
specificHeatCapacityCp_TX_a | Evaluate specific heat capacity of antifreeze-water mixture |
thermalConductivity_TX_a | Evaluate thermal conductivity of antifreeze-water mixture |
Inherited | |
cp_const=specificHeatCapacityCp_TX_a(T=property_T, X_a=X_a) | Constant specific heat capacity at constant pressure |
cv_const=cp_const | Constant specific heat capacity at constant volume |
d_const=density_TX_a(T=property_T, X_a=X_a) | Constant density |
eta_const=dynamicViscosity_TX_a(T=property_T, X_a=X_a) | Constant dynamic viscosity |
lambda_const=thermalConductivity_TX_a(T=property_T, X_a=X_a) | Constant thermal conductivity |
a_const=1484 | Constant velocity of sound |
T_min=fusionTemperature_TX_a(T=property_T, X_a=X_a) | Minimum temperature valid for medium model |
T_max=Modelica.Units.Conversions.from_degC(100) | Maximum temperature valid for medium model |
T0=273.15 | Zero enthalpy temperature |
MM_const=(X_a/simpleEthyleneGlycolWaterConstants[1].molarMass + (1 - X_a)/0.018015268)^(-1) | Molar mass |
fluidConstants=simpleEthyleneGlycolWaterConstants | Fluid constants |
ThermodynamicState | Thermodynamic state |
setState_pTX | Return thermodynamic state from p, T, and X or Xi |
setState_phX | Return thermodynamic state from p, h, and X or Xi |
setState_psX | Return thermodynamic state from p, s, and X or Xi |
setState_dTX | Return thermodynamic state from d, T, and X or Xi |
setSmoothState | Return thermodynamic state so that it smoothly approximates: if x > 0 then state_a else state_b |
dynamicViscosity | Return dynamic viscosity |
thermalConductivity | Return thermal conductivity |
pressure | Return pressure |
temperature | Return temperature |
density | Return density |
specificEnthalpy | Return specific enthalpy |
specificHeatCapacityCp | Return specific heat capacity at constant pressure |
specificHeatCapacityCv | Return specific heat capacity at constant volume |
isentropicExponent | Return isentropic exponent |
velocityOfSound | Return velocity of sound |
specificEnthalpy_pTX | Return specific enthalpy 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 |
specificInternalEnergy | Return specific internal energy |
specificEntropy | Return specific entropy |
specificGibbsEnergy | Return specific Gibbs energy |
specificHelmholtzEnergy | Return specific Helmholtz energy |
isentropicEnthalpy | Return isentropic enthalpy |
isobaricExpansionCoefficient | Returns overall the isobaric expansion coefficient beta |
isothermalCompressibility | Returns overall the isothermal compressibility factor |
density_derp_T | Returns the partial derivative of density with respect to pressure at constant temperature |
density_derT_p | Returns the partial derivative of density with respect to temperature at constant pressure |
density_derX | Returns the partial derivative of density with respect to mass fractions at constant pressure and temperature |
molarMass | Return the molar mass of the medium |
setState_pT | Return thermodynamic state from p and T |
setState_ph | Return thermodynamic state from p and h |
setState_ps | Return thermodynamic state from p and s |
setState_dT | Return thermodynamic state from d and T |
density_ph | Return density from p and h |
temperature_ph | Return temperature from p and h |
pressure_dT | Return pressure from d and T |
specificEnthalpy_dT | Return specific enthalpy from d and T |
specificEnthalpy_ps | Return specific enthalpy from p and s |
temperature_ps | Return temperature from p and s |
density_ps | Return density from p and s |
specificEnthalpy_pT | Return specific enthalpy from p and T |
density_pT | Return density from p and T |
ThermoStates=Modelica.Media.Interfaces.Choices.IndependentVariables.pT | Enumeration type for independent variables |
mediumName="EthyleneGlycolWater(X_a = " + String(X_a) + ", property_T = " + String(property_T) + ")" | 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 | = 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=300000 | 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=300000 | Default value for pressure of medium (for initialization) |
T_default=Modelica.Units.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) |
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 |
prandtlNumber | Return the Prandtl number |
heatCapacity_cp | Alias for deprecated name |
heatCapacity_cv | Alias for deprecated name |
beta | Alias for isobaricExpansionCoefficient for user convenience |
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 |
specificEntropy_pTX | Return specific enthalpy from p, T, and X or Xi |
density_pTX | Return density from p, T, 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 Modelica.Units.SI.Temperature property_T "Temperature for evaluation of constant fluid properties";
constant Modelica.Units.SI.MassFraction X_a "Mass fraction of propylene glycol in water";
constant Modelica.Units.SI.MassFraction X_a_min=0. "Minimum allowed mass fraction of ethylene glycol in water";
constant Modelica.Units.SI.MassFraction X_a_max=0.6 "Maximum allowed mass fraction of propylene glycol in water";
constant Modelica.Media.Interfaces.Types.Basic.FluidConstants[1] simpleEthyleneGlycolWaterConstants( each chemicalFormula="C2H6O2", each structureFormula="HOCH2CH2OH", each casRegistryNumber="107-21-1", each iupacName="Ethane-1,2-diol", each molarMass=0.062068);
constant Buildings.Media.Antifreeze.BaseClasses.PropertyCoefficients proCoe( X_a_ref=0.308462, T_ref=Modelica.Units.Conversions.from_degC(31.728), nX_a=6, nT={4,4,4,3,2,1}, nTot=18, a_d={1.034e3,-4.781e-1,-2.692e-3,4.725e-6,1.311e0,-6.876e-3,4.805e-5, 1.690e-8,7.490e-5,7.855e-5,-3.995e-7,4.982e-9,-1.062e-4,1.229e-6,-1.153e-8, -9.623e-7,-7.221e-8,4.891e-8}, a_eta={4.705e-1,-2.550e-2,1.782e-4,-7.669e-7,2.471e-2,-1.171e-4,1.052e-6,-1.634e-8, 3.328e-6,-1.086e-6,-1.051e-8,-6.475e-10,1.695e-6,3.157e-9,4.063e-10, 3.089e-8,1.831e-10,-1.865e-9}, a_Tf={-1.525e1,-1.566e-6,-2.278e-7,2.169e-9,-8.080e-1,-1.339e-6,2.047e-08,-2.717e-11, -1.334e-2,6.332e-8,2.373e-10,-2.183e-12,-7.293e-5,-1.764e-9,-2.442e-11, 1.006e-6,-7.662e-11,1.140e-9}, a_cp={3.737e3,2.930e0,-4.675e-3,-1.389e-5,-1.799e1,1.046e-1,-4.147e-4, 1.847e-7,-9.933e-2,3.516e-4,5.109e-6,-7.138e-8,2.610e-3,-1.189e-6,-1.643e-7, 1.537e-5,-4.272e-7,-1.618e-6}, a_lambda={4.720e-1,8.903e-4,-1.058e-6,-2.789e-9,-4.286e-3,-1.473e-5, 1.059e-7,-1.142e-10,1.747e-5,6.814e-8,-3.612e-9,2.365e-12,3.017e-8,-2.412e-9, 4.004e-11,-1.322e-09,2.555e-11,2.678e-11}) "Coefficients for evaluation of thermo-physical properties";
Buildings.Media.Antifreeze.EthyleneGlycolWater.BaseProperties
Base properties
Information
This base properties model is identical to
Modelica.Media.Water.ConstantPropertyLiquidWater,
except that the equation
u = cv_const*(T - reference_T)
has been replaced by u=h
because
cp_const=cv_const
.
Also, the model checks if the mass fraction of the mixture is within the
allowed limits.
Parameters
Type | Name | Default | Description |
---|---|---|---|
Advanced | |||
Boolean | preferredMediumStates | false | = true if StateSelect.prefer shall be used for the independent property variables of the medium |
Modelica definition
Buildings.Media.Antifreeze.EthyleneGlycolWater.density_TX_a
Evaluate density of antifreeze-water mixture
Information
Extends from Modelica.Icons.Function (Icon for functions).
Inputs
Type | Name | Default | Description |
---|---|---|---|
Temperature | T | Temperature of antifreeze-water mixture [K] | |
MassFraction | X_a | Mass fraction of antifreeze [1] |
Outputs
Type | Name | Description |
---|---|---|
Density | d | Density of antifreeze-water mixture [kg/m3] |
Modelica definition
Buildings.Media.Antifreeze.EthyleneGlycolWater.dynamicViscosity_TX_a
Evaluate dynamic viscosity of antifreeze-water mixture
Information
Dynamic viscosity of antifreeze-water mixture at specified mass fraction and temperature, based on Melinder (2010).
References
Melinder, Åke. 2010. Properties of Secondary Working Fluids (Secondary Refrigerants or Coolants, Heat Transfer Fluids) for Indirect Systems. Paris: IIR/IIF.
Extends from Modelica.Icons.Function (Icon for functions).
Inputs
Type | Name | Default | Description |
---|---|---|---|
Temperature | T | Temperature of antifreeze-water mixture [K] | |
MassFraction | X_a | Mass fraction of antifreeze [1] |
Outputs
Type | Name | Description |
---|---|---|
DynamicViscosity | eta | Dynamic Viscosity of antifreeze-water mixture [Pa.s] |
Modelica definition
Buildings.Media.Antifreeze.EthyleneGlycolWater.fusionTemperature_TX_a
Evaluate temperature of fusion of antifreeze-water mixture
Information
Fusion temperature of antifreeze-water mixture at specified mass fraction and temperature, based on Melinder (2010).
References
Melinder, Åke. 2010. Properties of Secondary Working Fluids (Secondary Refrigerants or Coolants, Heat Transfer Fluids) for Indirect Systems. Paris: IIR/IIF.
Extends from Modelica.Icons.Function (Icon for functions).
Inputs
Type | Name | Default | Description |
---|---|---|---|
Temperature | T | Temperature of antifreeze-water mixture [K] | |
MassFraction | X_a | Mass fraction of antifreeze [1] |
Outputs
Type | Name | Description |
---|---|---|
Temperature | Tf | Temperature of fusion of antifreeze-water mixture [K] |
Modelica definition
Buildings.Media.Antifreeze.EthyleneGlycolWater.polynomialProperty
Evaluates thermophysical property from 2-variable polynomial
Information
Evaluates a thermophysical property of a mixture, based on correlations proposed by Melinder (2010).
The polynomial has the form
f = a1 (x-xm)0(y-ym)0 + a2 (x-xm)0(y-ym)1 + ... + any[1] (x-xm)0(y-ym)ny[1]-1 + ... + any[1])+1 (x-xm)1(y-ym)0 + ... + any[1]+ny[2] (x-xm)1(y-ym)ny[2]-1 + ...
References
Melinder, Åke. 2010. Properties of Secondary Working Fluids (Secondary Refrigerants or Coolants, Heat Transfer Fluids) for Indirect Systems. Paris: IIR/IIF.
Extends from Modelica.Icons.Function (Icon for functions).
Inputs
Type | Name | Default | Description |
---|---|---|---|
Real | x | First independent variable | |
Real | y | Second independent variable | |
Real | a[sum(proCoe.nT)] | Polynomial coefficients |
Outputs
Type | Name | Description |
---|---|---|
Real | f | Value of thermophysical property |
Modelica definition
Buildings.Media.Antifreeze.EthyleneGlycolWater.specificHeatCapacityCp_TX_a
Evaluate specific heat capacity of antifreeze-water mixture
Information
Specific heat capacity of antifreeze-water mixture at specified mass fraction and temperature, based on Melinder (2010).
References
Melinder, Åke. 2010. Properties of Secondary Working Fluids (Secondary Refrigerants or Coolants, Heat Transfer Fluids) for Indirect Systems. Paris: IIR/IIF.
Extends from Modelica.Icons.Function (Icon for functions).
Inputs
Type | Name | Default | Description |
---|---|---|---|
Temperature | T | Temperature of antifreeze-water mixture [K] | |
MassFraction | X_a | Mass fraction of antifreeze [1] |
Outputs
Type | Name | Description |
---|---|---|
SpecificHeatCapacity | cp | Specific heat capacity of antifreeze-water mixture [J/(kg.K)] |
Modelica definition
Buildings.Media.Antifreeze.EthyleneGlycolWater.thermalConductivity_TX_a
Evaluate thermal conductivity of antifreeze-water mixture
Information
Thermal conductivity of antifreeze-water mixture at specified mass fraction and temperature, based on Melinder (2010).
References
Melinder, Åke. 2010. Properties of Secondary Working Fluids (Secondary Refrigerants or Coolants, Heat Transfer Fluids) for Indirect Systems. Paris: IIR/IIF.
Extends from Modelica.Icons.Function (Icon for functions).
Inputs
Type | Name | Default | Description |
---|---|---|---|
Temperature | T | Temperature of antifreeze-water mixture [K] | |
MassFraction | X_a | Mass fraction of antifreeze [1] |
Outputs
Type | Name | Description |
---|---|---|
ThermalConductivity | lambda | Thermal conductivity of antifreeze-water mixture [W/(m.K)] |
Modelica definition
Buildings.Media.Antifreeze.EthyleneGlycolWater.BaseProperties.InputAbsolutePressure
Pressure as input signal connector
Modelica definition
Buildings.Media.Antifreeze.EthyleneGlycolWater.BaseProperties.InputMassFraction
Mass fraction as input signal connector
Modelica definition
Buildings.Media.Antifreeze.EthyleneGlycolWater.BaseProperties.InputSpecificEnthalpy
Specific enthalpy as input signal connector