Modelica.Media.Interfaces.PartialPureSubstance

Base class for pure substances of one chemical substance

Information

Extends from PartialMedium (Partial medium properties (base package of all media packages)).

Package Content

Name Description
Modelica.Media.Interfaces.PartialPureSubstance.setState_pT setState_pT Return thermodynamic state from p and T
Modelica.Media.Interfaces.PartialPureSubstance.setState_ph setState_ph Return thermodynamic state from p and h
Modelica.Media.Interfaces.PartialPureSubstance.setState_ps setState_ps Return thermodynamic state from p and s
Modelica.Media.Interfaces.PartialPureSubstance.setState_dT setState_dT Return thermodynamic state from d and T
Modelica.Media.Interfaces.PartialPureSubstance.density_ph density_ph Return density from p and h
Modelica.Media.Interfaces.PartialPureSubstance.temperature_ph temperature_ph Return temperature from p and h
Modelica.Media.Interfaces.PartialPureSubstance.pressure_dT pressure_dT Return pressure from d and T
Modelica.Media.Interfaces.PartialPureSubstance.specificEnthalpy_dT specificEnthalpy_dT Return specific enthalpy from d and T
Modelica.Media.Interfaces.PartialPureSubstance.specificEnthalpy_ps specificEnthalpy_ps Return specific enthalpy from p and s
Modelica.Media.Interfaces.PartialPureSubstance.temperature_ps temperature_ps Return temperature from p and s
Modelica.Media.Interfaces.PartialPureSubstance.density_ps density_ps Return density from p and s
Modelica.Media.Interfaces.PartialPureSubstance.specificEnthalpy_pT specificEnthalpy_pT Return specific enthalpy from p and T
Modelica.Media.Interfaces.PartialPureSubstance.density_pT density_pT Return density from p and T
Modelica.Media.Interfaces.PartialPureSubstance.BaseProperties BaseProperties  
Inherited
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=true = 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.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
Modelica.Media.Interfaces.PartialMedium.FluidConstants FluidConstants Critical, triple, molecular and other standard data of fluid
Modelica.Media.Interfaces.PartialMedium.ThermodynamicState ThermodynamicState Minimal variable set that is available as input argument to every medium function
Modelica.Media.Interfaces.PartialMedium.setState_pTX setState_pTX Return thermodynamic state as function of p, T and composition X or Xi
Modelica.Media.Interfaces.PartialMedium.setState_phX setState_phX Return thermodynamic state as function of p, h and composition X or Xi
Modelica.Media.Interfaces.PartialMedium.setState_psX setState_psX Return thermodynamic state as function of p, s and composition X or Xi
Modelica.Media.Interfaces.PartialMedium.setState_dTX setState_dTX Return thermodynamic state as function of d, T and composition X or Xi
Modelica.Media.Interfaces.PartialMedium.setSmoothState setSmoothState Return thermodynamic state so that it smoothly approximates: if x > 0 then state_a else state_b
Modelica.Media.Interfaces.PartialMedium.dynamicViscosity dynamicViscosity Return dynamic viscosity
Modelica.Media.Interfaces.PartialMedium.thermalConductivity thermalConductivity Return thermal conductivity
Modelica.Media.Interfaces.PartialMedium.prandtlNumber prandtlNumber Return the Prandtl number
Modelica.Media.Interfaces.PartialMedium.pressure pressure Return pressure
Modelica.Media.Interfaces.PartialMedium.temperature temperature Return temperature
Modelica.Media.Interfaces.PartialMedium.density density Return density
Modelica.Media.Interfaces.PartialMedium.specificEnthalpy specificEnthalpy Return specific enthalpy
Modelica.Media.Interfaces.PartialMedium.specificInternalEnergy specificInternalEnergy Return specific internal energy
Modelica.Media.Interfaces.PartialMedium.specificEntropy specificEntropy Return specific entropy
Modelica.Media.Interfaces.PartialMedium.specificGibbsEnergy specificGibbsEnergy Return specific Gibbs energy
Modelica.Media.Interfaces.PartialMedium.specificHelmholtzEnergy specificHelmholtzEnergy Return specific Helmholtz energy
Modelica.Media.Interfaces.PartialMedium.specificHeatCapacityCp specificHeatCapacityCp Return specific heat capacity at constant pressure
Modelica.Media.Interfaces.PartialMedium.heatCapacity_cp heatCapacity_cp Alias for deprecated name
Modelica.Media.Interfaces.PartialMedium.specificHeatCapacityCv specificHeatCapacityCv Return specific heat capacity at constant volume
Modelica.Media.Interfaces.PartialMedium.heatCapacity_cv heatCapacity_cv Alias for deprecated name
Modelica.Media.Interfaces.PartialMedium.isentropicExponent isentropicExponent Return isentropic exponent
Modelica.Media.Interfaces.PartialMedium.isentropicEnthalpy isentropicEnthalpy Return isentropic enthalpy
Modelica.Media.Interfaces.PartialMedium.velocityOfSound velocityOfSound Return velocity of sound
Modelica.Media.Interfaces.PartialMedium.isobaricExpansionCoefficient isobaricExpansionCoefficient Return overall the isobaric expansion coefficient beta
Modelica.Media.Interfaces.PartialMedium.beta beta Alias for isobaricExpansionCoefficient for user convenience
Modelica.Media.Interfaces.PartialMedium.isothermalCompressibility isothermalCompressibility Return overall the isothermal compressibility factor
Modelica.Media.Interfaces.PartialMedium.kappa kappa Alias of isothermalCompressibility for user convenience
Modelica.Media.Interfaces.PartialMedium.density_derp_h density_derp_h Return density derivative w.r.t. pressure at const specific enthalpy
Modelica.Media.Interfaces.PartialMedium.density_derh_p density_derh_p Return density derivative w.r.t. specific enthalpy at constant pressure
Modelica.Media.Interfaces.PartialMedium.density_derp_T density_derp_T Return density derivative w.r.t. pressure at const temperature
Modelica.Media.Interfaces.PartialMedium.density_derT_p density_derT_p Return density derivative w.r.t. temperature at constant pressure
Modelica.Media.Interfaces.PartialMedium.density_derX density_derX Return density derivative w.r.t. mass fraction
Modelica.Media.Interfaces.PartialMedium.molarMass molarMass Return the molar mass of the medium
Modelica.Media.Interfaces.PartialMedium.specificEnthalpy_pTX specificEnthalpy_pTX Return specific enthalpy from p, T, and X or Xi
Modelica.Media.Interfaces.PartialMedium.specificEntropy_pTX specificEntropy_pTX Return specific enthalpy from p, T, and X or Xi
Modelica.Media.Interfaces.PartialMedium.density_pTX density_pTX Return density from p, T, and X or Xi
Modelica.Media.Interfaces.PartialMedium.temperature_phX temperature_phX Return temperature from p, h, and X or Xi
Modelica.Media.Interfaces.PartialMedium.density_phX density_phX Return density from p, h, and X or Xi
Modelica.Media.Interfaces.PartialMedium.temperature_psX temperature_psX Return temperature from p,s, and X or Xi
Modelica.Media.Interfaces.PartialMedium.density_psX density_psX Return density from p, s, and X or Xi
Modelica.Media.Interfaces.PartialMedium.specificEnthalpy_psX specificEnthalpy_psX Return specific enthalpy from p, s, and X or Xi
Modelica.Media.Interfaces.PartialMedium.MassFlowRate MassFlowRate Type for mass flow rate with medium specific attributes
Modelica.Media.Interfaces.Types.AbsolutePressure AbsolutePressure Type for absolute pressure with medium specific attributes
Modelica.Media.Interfaces.Types.Density Density Type for density with medium specific attributes
Modelica.Media.Interfaces.Types.DynamicViscosity DynamicViscosity Type for dynamic viscosity with medium specific attributes
Modelica.Media.Interfaces.Types.EnthalpyFlowRate EnthalpyFlowRate Type for enthalpy flow rate with medium specific attributes
Modelica.Media.Interfaces.Types.MassFraction MassFraction Type for mass fraction with medium specific attributes
Modelica.Media.Interfaces.Types.MoleFraction MoleFraction Type for mole fraction with medium specific attributes
Modelica.Media.Interfaces.Types.MolarMass MolarMass Type for molar mass with medium specific attributes
Modelica.Media.Interfaces.Types.MolarVolume MolarVolume Type for molar volume with medium specific attributes
Modelica.Media.Interfaces.Types.IsentropicExponent IsentropicExponent Type for isentropic exponent with medium specific attributes
Modelica.Media.Interfaces.Types.SpecificEnergy SpecificEnergy Type for specific energy with medium specific attributes
Modelica.Media.Interfaces.Types.SpecificInternalEnergy SpecificInternalEnergy Type for specific internal energy with medium specific attributes
Modelica.Media.Interfaces.Types.SpecificEnthalpy SpecificEnthalpy Type for specific enthalpy with medium specific attributes
Modelica.Media.Interfaces.Types.SpecificEntropy SpecificEntropy Type for specific entropy with medium specific attributes
Modelica.Media.Interfaces.Types.SpecificHeatCapacity SpecificHeatCapacity Type for specific heat capacity with medium specific attributes
Modelica.Media.Interfaces.Types.SurfaceTension SurfaceTension Type for surface tension with medium specific attributes
Modelica.Media.Interfaces.Types.Temperature Temperature Type for temperature with medium specific attributes
Modelica.Media.Interfaces.Types.ThermalConductivity ThermalConductivity Type for thermal conductivity with medium specific attributes
Modelica.Media.Interfaces.Types.PrandtlNumber PrandtlNumber Type for Prandtl number with medium specific attributes
Modelica.Media.Interfaces.Types.VelocityOfSound VelocityOfSound Type for velocity of sound with medium specific attributes
Modelica.Media.Interfaces.Types.ExtraProperty ExtraProperty Type for unspecified, mass-specific property transported by flow
Modelica.Media.Interfaces.Types.CumulativeExtraProperty CumulativeExtraProperty Type for conserved integral of unspecified, mass specific property
Modelica.Media.Interfaces.Types.ExtraPropertyFlowRate ExtraPropertyFlowRate Type for flow rate of unspecified, mass-specific property
Modelica.Media.Interfaces.Types.IsobaricExpansionCoefficient IsobaricExpansionCoefficient Type for isobaric expansion coefficient with medium specific attributes
Modelica.Media.Interfaces.Types.DipoleMoment DipoleMoment Type for dipole moment with medium specific attributes
Modelica.Media.Interfaces.Types.DerDensityByPressure DerDensityByPressure Type for partial derivative of density with respect to pressure with medium specific attributes
Modelica.Media.Interfaces.Types.DerDensityByEnthalpy DerDensityByEnthalpy Type for partial derivative of density with respect to enthalpy with medium specific attributes
Modelica.Media.Interfaces.Types.DerEnthalpyByPressure DerEnthalpyByPressure Type for partial derivative of enthalpy with respect to pressure with medium specific attributes
Modelica.Media.Interfaces.Types.DerDensityByTemperature DerDensityByTemperature Type for partial derivative of density with respect to temperature with medium specific attributes
Modelica.Media.Interfaces.Types.DerTemperatureByPressure DerTemperatureByPressure Type for partial derivative of temperature with respect to pressure with medium specific attributes
Modelica.Media.Interfaces.Types.SaturationProperties SaturationProperties Saturation properties of two phase medium
Modelica.Media.Interfaces.Types.FluidLimits FluidLimits Validity limits for fluid model
Modelica.Media.Interfaces.Types.FixedPhase FixedPhase Phase of the fluid: 1 for 1-phase, 2 for two-phase, 0 for not known, e.g., interactive use
Modelica.Media.Interfaces.Types.Basic Basic The most basic version of a record used in several degrees of detail
Modelica.Media.Interfaces.Types.IdealGas IdealGas The ideal gas version of a record used in several degrees of detail
Modelica.Media.Interfaces.Types.TwoPhase TwoPhase The two phase fluid version of a record used in several degrees of detail

Modelica.Media.Interfaces.PartialPureSubstance.setState_pT Modelica.Media.Interfaces.PartialPureSubstance.setState_pT

Return thermodynamic state from p and T

Information

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

Inputs

NameDescription
pPressure [Pa]
TTemperature [K]

Outputs

NameDescription
stateThermodynamic state record

Modelica.Media.Interfaces.PartialPureSubstance.setState_ph Modelica.Media.Interfaces.PartialPureSubstance.setState_ph

Return thermodynamic state from p and h

Information

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

Inputs

NameDescription
pPressure [Pa]
hSpecific enthalpy [J/kg]

Outputs

NameDescription
stateThermodynamic state record

Modelica.Media.Interfaces.PartialPureSubstance.setState_ps Modelica.Media.Interfaces.PartialPureSubstance.setState_ps

Return thermodynamic state from p and s

Information

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

Inputs

NameDescription
pPressure [Pa]
sSpecific entropy [J/(kg.K)]

Outputs

NameDescription
stateThermodynamic state record

Modelica.Media.Interfaces.PartialPureSubstance.setState_dT Modelica.Media.Interfaces.PartialPureSubstance.setState_dT

Return thermodynamic state from d and T

Information

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

Inputs

NameDescription
dDensity [kg/m3]
TTemperature [K]

Outputs

NameDescription
stateThermodynamic state record

Modelica.Media.Interfaces.PartialPureSubstance.density_ph Modelica.Media.Interfaces.PartialPureSubstance.density_ph

Return density from p and h

Information

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

Inputs

NameDescription
pPressure [Pa]
hSpecific enthalpy [J/kg]

Outputs

NameDescription
dDensity [kg/m3]

Modelica.Media.Interfaces.PartialPureSubstance.temperature_ph Modelica.Media.Interfaces.PartialPureSubstance.temperature_ph

Return temperature from p and h

Information

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

Inputs

NameDescription
pPressure [Pa]
hSpecific enthalpy [J/kg]

Outputs

NameDescription
TTemperature [K]

Modelica.Media.Interfaces.PartialPureSubstance.pressure_dT Modelica.Media.Interfaces.PartialPureSubstance.pressure_dT

Return pressure from d and T

Information

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

Inputs

NameDescription
dDensity [kg/m3]
TTemperature [K]

Outputs

NameDescription
pPressure [Pa]

Modelica.Media.Interfaces.PartialPureSubstance.specificEnthalpy_dT Modelica.Media.Interfaces.PartialPureSubstance.specificEnthalpy_dT

Return specific enthalpy from d and T

Information

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

Inputs

NameDescription
dDensity [kg/m3]
TTemperature [K]

Outputs

NameDescription
hSpecific enthalpy [J/kg]

Modelica.Media.Interfaces.PartialPureSubstance.specificEnthalpy_ps Modelica.Media.Interfaces.PartialPureSubstance.specificEnthalpy_ps

Return specific enthalpy from p and s

Information

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

Inputs

NameDescription
pPressure [Pa]
sSpecific entropy [J/(kg.K)]

Outputs

NameDescription
hSpecific enthalpy [J/kg]

Modelica.Media.Interfaces.PartialPureSubstance.temperature_ps Modelica.Media.Interfaces.PartialPureSubstance.temperature_ps

Return temperature from p and s

Information

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

Inputs

NameDescription
pPressure [Pa]
sSpecific entropy [J/(kg.K)]

Outputs

NameDescription
TTemperature [K]

Modelica.Media.Interfaces.PartialPureSubstance.density_ps Modelica.Media.Interfaces.PartialPureSubstance.density_ps

Return density from p and s

Information

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

Inputs

NameDescription
pPressure [Pa]
sSpecific entropy [J/(kg.K)]

Outputs

NameDescription
dDensity [kg/m3]

Modelica.Media.Interfaces.PartialPureSubstance.specificEnthalpy_pT Modelica.Media.Interfaces.PartialPureSubstance.specificEnthalpy_pT

Return specific enthalpy from p and T

Information

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

Inputs

NameDescription
pPressure [Pa]
TTemperature [K]

Outputs

NameDescription
hSpecific enthalpy [J/kg]

Modelica.Media.Interfaces.PartialPureSubstance.density_pT Modelica.Media.Interfaces.PartialPureSubstance.density_pT

Return density from p and T

Information

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

Inputs

NameDescription
pPressure [Pa]
TTemperature [K]

Outputs

NameDescription
dDensity [kg/m3]

Modelica.Media.Interfaces.PartialPureSubstance.BaseProperties Modelica.Media.Interfaces.PartialPureSubstance.BaseProperties

Information

Extends from (Base properties (p, d, T, h, u, R_s, MM and, if applicable, X and Xi) of a medium).

Parameters

NameDescription
standardOrderComponentsIf true, and reducedX = true, the last element of X will be computed from the other ones
Advanced
preferredMediumStates= true if StateSelect.prefer shall be used for the independent property variables of the medium
Automatically generated Thu Oct 1 16:08:01 2020.