Click or drag to resize

HelmholtzEquationOfStateOfPureFluidsBySpanEtAl Class

Base class of state equations based on the papers of the group of W.Wagner / Bochum
Inheritance Hierarchy
SystemObject
  Altaxo.Science.Thermodynamics.FluidsHelmholtzEquationOfState
    Altaxo.Science.Thermodynamics.FluidsHelmholtzEquationOfStateOfPureFluids
      Altaxo.Science.Thermodynamics.FluidsHelmholtzEquationOfStateOfPureFluidsBySpanEtAl
        More

Namespace: Altaxo.Science.Thermodynamics.Fluids
Assembly: AltaxoCore (in AltaxoCore.dll) Version: 4.8.3179.0 (4.8.3179.0)
Syntax
C#
public abstract class HelmholtzEquationOfStateOfPureFluidsBySpanEtAl : HelmholtzEquationOfStateOfPureFluids

The HelmholtzEquationOfStateOfPureFluidsBySpanEtAl type exposes the following members.

Constructors
 NameDescription
Protected methodHelmholtzEquationOfStateOfPureFluidsBySpanEtAlInitializes a new instance of the HelmholtzEquationOfStateOfPureFluidsBySpanEtAl class
Top
Properties
 NameDescription
Public propertyAcentricFactorGets the acentric factor.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public propertyCASRegistryNumberGets the CAS registry number.
Public propertyChemicalFormulaThe chemical formula of the fluid.
Public propertyCriticalPointMassDensityGets the mass density at the critical point in kg/m³.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public propertyCriticalPointMoleDensityGets the mole density at the critical point in mol/m³.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public propertyCriticalPointPressureGets the pressure at the critical point in Pa.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public propertyCriticalPointTemperatureGets the temperature at the critical point in Kelvin.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public propertyDipoleMomentGets the dipole moment in Debye.
Public propertyFluidFamilyThe chemical formula of the fluid.
Public propertyFullNameThe full name of the fluid.
Public propertyIsMeltingPressureCurveImplemented 
Public propertyIsSublimationPressureCurveImplemented 
Public propertyLowerTemperatureLimitGets the lower temperature limit of this model in K.
Public propertyMolecularWeight Gets the (typical) molecular weight of the fluid.
(Inherited from HelmholtzEquationOfState)
Public propertyNormalBoilingPointTemperatureGets the boiling temperature at normal pressure (101325 Pa) in K (if existent). If not existent, the return value is null.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public propertyNormalSublimationPointTemperatureGets the sublimation temperature at normal pressure (101325 Pa) in K (if existent). If not existent, the return value is null.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public propertyReducingMassDensity Gets the density (in kg/m³) used to calculate the reduced (dimensionless) density.
(Inherited from HelmholtzEquationOfState)
Public propertyReducingMoleDensity Gets the molar density (in mol/m³) used to calculate the reduced (dimensionless) density.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public propertyReducingTemperature Gets the temperature (in Kelvin) that is used to calculate the inverse reduced temperature.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public propertyShortNameThe short name of the fluid.
Public propertySynonymThe synonym of the name of the fluid.
Public propertyTriplePointPressureGets the triple point pressure in Pa.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public propertyTriplePointSaturatedLiquidMassDensityGets the saturated liquid density at the triple point in kg/m³.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public propertyTriplePointSaturatedLiquidMoleDensityGets the saturated liquid density at the triple point in mol/m³.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public propertyTriplePointSaturatedVaporMassDensityGets the saturated vapor density at the triple point in kg/m³.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public propertyTriplePointSaturatedVaporMoleDensityGets the saturated vapor density at the triple point in mol/m³.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public propertyTriplePointTemperatureGets the triple point temperature in K.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public propertyUN_NumbersThe UN number of the fluid.
Public propertyUpperMoleDensityLimitGets the upper density limit of this model in mol/m³.
Public propertyUpperPressureLimitGets the upper pressure limit of this model in Pa.
Public propertyUpperTemperatureLimitGets the upper temperature limit of this model in K.
Public propertyWorkingSpecificGasConstant Gets the specific gas constant of the fluid. Is calculated from WorkingUniversalGasConstant and MolecularWeight.
(Inherited from HelmholtzEquationOfState)
Public propertyWorkingUniversalGasConstantThe Universal Gas Constant R at the time the model was developed.
(Overrides HelmholtzEquationOfStateWorkingUniversalGasConstant)
Top
Methods
 NameDescription
Public methodEqualsDetermines whether the specified object is equal to the current object.
(Inherited from Object)
Protected methodFinalizeAllows an object to try to free resources and perform other cleanup operations before it is reclaimed by garbage collection.
(Inherited from Object)
Public methodGetDeltaFromMassDensity Gets the reduced density by density / ReducingMassDensity.
(Inherited from HelmholtzEquationOfState)
Public methodGetDeltaFromMoleDensity Gets the reduced density by density / ReducingMassDensity.
(Inherited from HelmholtzEquationOfState)
Public methodGetHashCodeServes as the default hash function.
(Inherited from Object)
Public methodGetTauFromTemperature Gets the inverse reduced temperature by ReducingTemperature / temperature.
(Inherited from HelmholtzEquationOfState)
Public methodGetTypeGets the Type of the current instance.
(Inherited from Object)
Public methodIsentropicDerivativeOfMassSpecificVolumeWrtPressure_FromMoleDensityAndTemperature Gets the isentropic (adiabatic) derivative of the mass specific volume w.r.t. pressure from mole density and temperature.
(Inherited from HelmholtzEquationOfState)
Public methodIsentropicDerivativeOfMoleSpecificVolumeWrtPressure_FromMoleDensityAndTemperature Gets the isentropic (adiabatic) derivative of the mole specific volume w.r.t. pressure from mole density and temperature.
(Inherited from HelmholtzEquationOfState)
Public methodIsothermalCompressibility_FromMassDensityAndTemperature Gets the isothermal compressibility in 1/Pa from mass density (kg/m³) and temperature (K). Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodIsothermalCompressibility_FromMoleDensityAndTemperature Gets the isothermal compressibility in 1/Pa from mole density (mol/m³) and temperature (K). Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodIsothermalCompressionalModulus_FromMassDensityAndTemperature Gets the isothermal compressional modulus K in Pa from density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodIsothermalCompressionalModulus_FromMoleDensityAndTemperature Gets the isothermal compressional modulus in Pa from density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodIsothermalDerivativePressureWrtMassDensity_FromMassDensityAndTemperature Gets the derivative of pressure w.r.t. the mass density at isothermal conditions. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodIsothermalDerivativePressureWrtMoleDensity_FromMoleDensityAndTemperature Gets the derivative of pressure w.r.t. the mole density at isothermal conditions. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMassDensity_FromMoleDensity Gets the mass density (in kg/m³) from mole density (in mol/m³).
(Inherited from HelmholtzEquationOfState)
Public methodMassDensity_FromPressureAndTemperature(Double, Double, Double) Gets the mass density for a given pressure and temperature.
(Inherited from HelmholtzEquationOfState)
Public methodMassDensity_FromPressureAndTemperature(Double, Double, Double, Double) Gets the mole density from a given pressure and temperature.
(Inherited from HelmholtzEquationOfState)
Public methodMassSpecificEnthalpy_FromMassDensityAndTemperature Get the enthalpy from a given density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMassSpecificEnthalpy_FromMoleDensityAndTemperature Get the enthalpy from a given density and temperature.
(Inherited from HelmholtzEquationOfState)
Public methodMassSpecificEntropy_FromMassDensityAndTemperature Get the entropy from a given mole density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMassSpecificEntropy_FromMoleDensityAndTemperature Get the entropy from a given mole density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMassSpecificGibbsEnergy_FromMassDensityAndTemperature Get the mass specific Gibbs energy from a given mass density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMassSpecificGibbsEnergy_FromMoleDensityAndTemperature Get the mass specific Gibbs energy from a given mass density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMassSpecificHelmholtzEnergy_FromMassDensityAndTemperature Get the Helmholtz energy from a given mass density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMassSpecificHelmholtzEnergy_FromMoleDensityAndTemperature Get the mass specific Helmholtz energy from a given mass density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMassSpecificInternalEnergy_FromMassDensityAndTemperature Get the internal energy from a given density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMassSpecificInternalEnergy_FromMoleDensityAndTemperature Get the internal energy from a given density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMassSpecificIsobaricHeatCapacity_FromMassDensityAndTemperature Gets the isobaric heat capacity from a given density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMassSpecificIsobaricHeatCapacity_FromMoleDensityAndTemperature Gets the isobaric heat capacity from a given density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMassSpecificIsochoricHeatCapacity_FromMassDensityAndTemperature Get the isochoric heat capacity from a given density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMassSpecificIsochoricHeatCapacity_FromMoleDensityAndTemperature Get the isochoric heat capacity from a given density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Protected methodMeltingPressure_Type1 
Protected methodMeltingPressure_Type2 
Protected methodMeltingPressure_TypeH(Double) Melting pressure for water. Note that more than one pressure value is possible for a given temperature. If in doubt, the lowest pressure solution is returned.
Protected methodMeltingPressure_TypeH(Double, Int32) 
Public methodMeltingPressureEstimate_FromTemperature 
Public methodMeltingPressureEstimateAndDerivativeWrtTemperature_FromTemperature Gets an estimate value of the melting pressure and the derivative of the pressure w.r.t. temperature for a given temperature. The estimated value should have an relative accuracy of 5% plus an absolute error of about 100 Pa.
Public methodMeltingTemperatureEstimate_FromPressure Gets an estimate of the melting temperature for a given pressure, using Newton-Raphson iteration.
Protected methodMemberwiseCloneCreates a shallow copy of the current Object.
(Inherited from Object)
Public methodMoleDensity_FromMassDensity Gets the mole density (in mol/m³) from mass density (in kg/m³).
(Inherited from HelmholtzEquationOfState)
Public methodMoleDensity_FromPressureAndTemperature(Double, Double, Double) Get the mole density for a given pressure and temperature.
(Inherited from HelmholtzEquationOfState)
Public methodMoleDensity_FromPressureAndTemperature(Double, Double, Double, Double) Gets the mole density from a given pressure and temperature.
(Inherited from HelmholtzEquationOfState)
Public methodMoleDensityEstimates_FromPressureAndTemperature Gets an estimate of the mole densities at a given pressure and temperature.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public methodMoleSpecificEnthalpy_FromMassDensityAndTemperature Get the enthalpy from a given density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMoleSpecificEnthalpy_FromMoleDensityAndTemperature Get the enthalpy from a given density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMoleSpecificEntropy_FromMassDensityAndTemperature Get the entropy from a given mole density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMoleSpecificEntropy_FromMoleDensityAndTemperature Get the entropy from a given mole density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMoleSpecificGibbsEnergy_FromMassDensityAndTemperature Get the mole specific Gibbs energy from a given mass density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMoleSpecificGibbsEnergy_FromMoleDensityAndTemperature Get the mole specific Gibbs energy from a given mass density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMoleSpecificHelmholtzEnergy_FromMassDensityAndTemperature Get the Helmholtz energy from a given mass density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMoleSpecificHelmholtzEnergy_FromMoleDensityAndTemperature Get the Helmholtz energy from a given mole density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMoleSpecificInternalEnergy_FromMassDensityAndTemperature Get the internal energy from a given density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMoleSpecificInternalEnergy_FromMoleDensityAndTemperature Get the internal energy from a given density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMoleSpecificIsobaricHeatCapacity_FromMassDensityAndTemperature Gets the isobaric heat capacity from a given density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMoleSpecificIsobaricHeatCapacity_FromMoleDensityAndTemperature Gets the isobaric heat capacity from a given density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMoleSpecificIsochoricHeatCapacity_FromMassDensityAndTemperature Get the mole specific isochoric heat capacity from a given density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodMoleSpecificIsochoricHeatCapacity_FromMoleDensityAndTemperature Get the mole specific isochoric heat capacity from a given density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodPhi0_OfReducedVariables Phi0s the of reduced variables. (Page 1541, Table 28 in [2])
(Overrides HelmholtzEquationOfStatePhi0_OfReducedVariables(Double, Double))
Public methodPhi0_tau_OfReducedVariables First derivative of Phi0 the of reduced variables with respect to the inverse reduced temperature. (Page 1541, Table 28)
(Overrides HelmholtzEquationOfStatePhi0_tau_OfReducedVariables(Double, Double))
Public methodPhi0_tautau_OfReducedVariables Second derivative of Phi0 the of reduced variables with respect to the inverse reduced temperature. (Page 1541, Table 28)
(Overrides HelmholtzEquationOfStatePhi0_tautau_OfReducedVariables(Double, Double))
Public methodPhiR_delta_OfReducedVariables Calculates the first derivative of the residual part of the dimensionless Helmholtz energy with respect to the reduced density delta.
(Overrides HelmholtzEquationOfStatePhiR_delta_OfReducedVariables(Double, Double))
Public methodPhiR_deltadelta_OfReducedVariables Calculates the second derivative of the residual part of the dimensionless Helmholtz energy with respect to the reduced density delta.
(Overrides HelmholtzEquationOfStatePhiR_deltadelta_OfReducedVariables(Double, Double))
Public methodPhiR_deltatau_OfReducedVariables Calculates the derivative of the residual part of the dimensionless Helmholtz energy with respect to the reduced density delta and the inverse reduced temperature tau.
(Overrides HelmholtzEquationOfStatePhiR_deltatau_OfReducedVariables(Double, Double))
Public methodPhiR_OfReducedVariables Calculates the residual part of the dimensionless Helmholtz energy in dependence on reduced density and reduced inverse temperature.
(Overrides HelmholtzEquationOfStatePhiR_OfReducedVariables(Double, Double))
Public methodPhiR_tau_OfReducedVariables Calculates the first derivative of the residual part of the dimensionless Helmholtz energy with respect to the inverse reduced temperature.
(Overrides HelmholtzEquationOfStatePhiR_tau_OfReducedVariables(Double, Double))
Public methodPhiR_tautau_OfReducedVariables Calculates the second derivative of the residual part of the dimensionless Helmholtz energy with respect to the inverse reduced temperature.
(Overrides HelmholtzEquationOfStatePhiR_tautau_OfReducedVariables(Double, Double))
Protected methodStatic memberPow 
Public methodPressure_FromMassDensityAndTemperature Get the pressure from a given density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodPressure_FromMoleDensityAndTemperature Gets the pressure from a given molar density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodSaturatedLiquidAndVaporMoleDensitiesAndPressure_FromTemperature(Double, Double) Gets the saturated liquid mole density, the saturated vapor mole density, and the pressure for a given temperature. This is done by iteration, using multivariate Newton-Raphson.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public methodSaturatedLiquidAndVaporMoleDensitiesAndPressure_FromTemperature(Double, Double, Double, Double) Gets the saturated liquid mole density, the saturated vapor mole density, and the pressure for a given temperature. This is done by iteration, using multivariate Newton-Raphson.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public methodSaturatedLiquidAndVaporMoleDensitiesAndTemperature_FromPressure Gets the saturated liquid mole density, the saturated vapor mole density, and the temperature for a given pressure. This is done by iteration, using multivariate Newton-Raphson.
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public methodSaturatedLiquidMoleDensityEstimate_FromTemperature Gets an estimate for the saturated liquid mole density in dependence on the temperature.
(Overrides HelmholtzEquationOfStateOfPureFluidsSaturatedLiquidMoleDensityEstimate_FromTemperature(Double))
Protected methodSaturatedMoleDensity_Type1 
Protected methodSaturatedMoleDensity_Type2 
Protected methodSaturatedMoleDensity_Type3 
Protected methodSaturatedMoleDensity_Type4 
Protected methodSaturatedMoleDensity_Type5 
Protected methodSaturatedMoleDensity_Type6 
Public methodSaturatedVaporMoleDensityEstimate_FromTemperature Gets an estimate for the saturated vapor mole density in dependence on the temperature.
(Overrides HelmholtzEquationOfStateOfPureFluidsSaturatedVaporMoleDensityEstimate_FromTemperature(Double))
Protected methodSaturatedVaporPressure_Type1 
Protected methodSaturatedVaporPressure_Type2 
Protected methodSaturatedVaporPressure_Type3 
Protected methodSaturatedVaporPressure_Type4 
Protected methodSaturatedVaporPressure_Type5 
Protected methodSaturatedVaporPressure_Type6 
Public methodSaturatedVaporPressureEstimate_FromTemperature Gets an estimate for the saturated vapor pressure in dependence on the temperature.
(Overrides HelmholtzEquationOfStateOfPureFluidsSaturatedVaporPressureEstimate_FromTemperature(Double))
Public methodSaturatedVaporPressureEstimateAndDerivativeWrtTemperature_FromTemperature Gets an estimate for the saturated vapor pressure in dependence on the temperature as well as for the derivative of the saturated vapor pressure with respect to the temperature.
(Overrides HelmholtzEquationOfStateOfPureFluidsSaturatedVaporPressureEstimateAndDerivativeWrtTemperature_FromTemperature(Double))
Public methodSaturatedVaporTemperature_FromPressure Get the temperature at the liquid/vapor interface for a given pressure by iteration (Newton-Raphson).
(Inherited from HelmholtzEquationOfStateOfPureFluids)
Public methodSpeedOfSound_FromMassDensityAndTemperature Get the speed of sound from a given density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Public methodSpeedOfSound_FromMoleDensityAndTemperature Get the speed of sound from a given density and temperature. Attention - unchecked function: it is presumed, but not checked (!), that the given parameter combination describes a single phase fluid!.
(Inherited from HelmholtzEquationOfState)
Protected methodSublimationPressure_Type1 
Protected methodSublimationPressure_Type2 
Protected methodSublimationPressure_Type3 
Public methodSublimationPressureEstimate_FromTemperature 
Public methodSublimationPressureEstimateAndDerivativeWrtTemperature_FromTemperature 
Public methodSublimationTemperatureEstimate_FromPressure Gets an estimate of the sublimation temperature for a given pressure, using Newton-Raphson iteration.
Public methodToStringReturns a string that represents the current object.
(Inherited from Object)
Top
Fields
 NameDescription
Protected field_alpha0_CoshThe prefactors outside and inside the argument of the Cosh terms in the equation of the ideal part of the reduced Helmholtz energy.
Protected field_alpha0_Exp Prefactor and exponent of the exponential terms in the ideal part of the residual Helmholtz energy. Page 429 Table 6.1 in [2]
Protected field_alpha0_n_constThe constant term in the equation of the ideal part of the reduced Helmholtz energy.
Protected field_alpha0_n_lntauThe term with the factor ln(tau) in the equation of the ideal part of the reduced Helmholtz energy.
Protected field_alpha0_n_tauThe term with the factor tau in the equation of the ideal part of the reduced Helmholtz energy.
Protected field_alpha0_n_taulntauThe term with the factor tau*ln(tau) in the equation of the ideal part of the reduced Helmholtz energy.
Protected field_alpha0_Poly 
Protected field_alpha0_SinhThe prefactors outside and inside the argument of the Sinh terms in the equation of the ideal part of the reduced Helmholtz energy.
Protected field_alphaR_Exp Parameter for the exponential terms of the reduced Helmholtz energy. term = ni * tau^ti * delta^di * Exp(gi * delta^li) with gi normally equal to -1.
Protected field_alphaR_Gauss 
Protected field_alphaR_Nonanalytical 
Protected field_alphaR_Poly Parameter for the polynomial terms of the reduced Helmholtz energy.
Protected fieldStatic member_emptyDoubleArray 
Protected fieldStatic member_emptyDoubleDoubleArray 
Protected field_meltingPressure_Coefficients 
Protected field_meltingPressure_ReducingPressure 
Protected field_meltingPressure_ReducingTemperature 
Protected field_meltingPressure_Type 
Protected field_saturatedLiquidDensity_Coefficients 
Protected field_saturatedLiquidDensity_Type 
Protected field_saturatedVaporDensity_Coefficients 
Protected field_saturatedVaporDensity_Type 
Protected field_saturatedVaporPressure_Coefficients 
Protected field_saturatedVaporPressure_Type 
Protected field_sublimationPressure_PolynomialCoefficients1 
Protected field_sublimationPressure_PolynomialCoefficients2 
Protected field_sublimationPressure_PolynomialCoefficients3 
Protected field_sublimationPressure_ReducingPressure 
Protected field_sublimationPressure_ReducingTemperature 
Protected field_sublimationPressure_Type 
Top
Remarks
References:

[1] R. Span and W. Wagner, A New Equation of State for Carbon Dioxide Covering the Fluid Region from the Triple-Point Temperature to 1100 K at Pressures up to 800 MPa, J. Phys. Chern. Ref. Data, Vol. 25, No.6, 1996

[2] W. Wagner and A.Pruß The IAPWS Formulation 1995 for the Thermodynamic Properties of Ordinary Water Substance for General and Scientific Use, J. Phys. Chem. Ref. Data, Vol. 31, No. 2, 2002

See Also
Inheritance Hierarchy
SystemObject
  Altaxo.Science.Thermodynamics.FluidsHelmholtzEquationOfState
    Altaxo.Science.Thermodynamics.FluidsHelmholtzEquationOfStateOfPureFluids
      Altaxo.Science.Thermodynamics.FluidsHelmholtzEquationOfStateOfPureFluidsBySpanEtAl
        Altaxo.Science.Thermodynamics.FluidsAmmonia
        Altaxo.Science.Thermodynamics.FluidsArgon
        Altaxo.Science.Thermodynamics.FluidsBenzene
        Altaxo.Science.Thermodynamics.FluidsCarbonDioxide
        Altaxo.Science.Thermodynamics.FluidsCarbonMonoxide
        Altaxo.Science.Thermodynamics.FluidsCarbonOxideSulfide
        Altaxo.Science.Thermodynamics.FluidsChlorine
        Altaxo.Science.Thermodynamics.FluidsChlorobenzene
        Altaxo.Science.Thermodynamics.FluidsChlorodifluoromethane
        Altaxo.Science.Thermodynamics.FluidsChloroethylene
        Altaxo.Science.Thermodynamics.FluidsChloropentafluoroethane
        Altaxo.Science.Thermodynamics.FluidsCis_1_3_3_3_tetrafluoropropene
        Altaxo.Science.Thermodynamics.FluidsCis_2_butene
        Altaxo.Science.Thermodynamics.FluidsCyclohexane
        Altaxo.Science.Thermodynamics.FluidsCyclopentane
        Altaxo.Science.Thermodynamics.FluidsCyclopropane
        Altaxo.Science.Thermodynamics.FluidsDecamethylcyclopentasiloxane
        Altaxo.Science.Thermodynamics.FluidsDecamethyltetrasiloxane
        Altaxo.Science.Thermodynamics.FluidsDecane
        Altaxo.Science.Thermodynamics.FluidsDeuterium
        Altaxo.Science.Thermodynamics.FluidsDeuteriumOxide
        Altaxo.Science.Thermodynamics.FluidsDichlorodifluoromethane
        Altaxo.Science.Thermodynamics.FluidsDichloroethane
        Altaxo.Science.Thermodynamics.FluidsDichlorofluoromethane
        Altaxo.Science.Thermodynamics.FluidsDiethanolamine
        Altaxo.Science.Thermodynamics.FluidsDiethylEther
        Altaxo.Science.Thermodynamics.FluidsDifluoromethane
        Altaxo.Science.Thermodynamics.FluidsDimethylEsterCarbonicAcid
        Altaxo.Science.Thermodynamics.FluidsDinitrogenMonoxide
        Altaxo.Science.Thermodynamics.FluidsDodecafluoro_2_methylpentan_3_one
        Altaxo.Science.Thermodynamics.FluidsDodecamethylcyclohexasiloxane
        Altaxo.Science.Thermodynamics.FluidsDodecamethylpentasiloxane
        Altaxo.Science.Thermodynamics.FluidsDodecane
        Altaxo.Science.Thermodynamics.FluidsEthane
        Altaxo.Science.Thermodynamics.FluidsEthene
        Altaxo.Science.Thermodynamics.FluidsEthylAlcohol
        Altaxo.Science.Thermodynamics.FluidsEthyleneOxide
        Altaxo.Science.Thermodynamics.FluidsFluid_1_1_1_2_3_3_3_heptafluoropropane
        Altaxo.Science.Thermodynamics.FluidsFluid_1_1_1_2_3_3_hexafluoropropane
        Altaxo.Science.Thermodynamics.FluidsFluid_1_1_1_3_3_3_hexafluoropropane
        Altaxo.Science.Thermodynamics.FluidsFluid_1_1_1_3_3_pentafluorobutane
        Altaxo.Science.Thermodynamics.FluidsFluid_1_1_1_trifluoroethane
        Altaxo.Science.Thermodynamics.FluidsFluid_1_1_2_2_3_pentafluoropropane
        Altaxo.Science.Thermodynamics.FluidsFluid_1_1_2_trichloro_1_2_2_trifluoroethane
        Altaxo.Science.Thermodynamics.FluidsFluid_1_1_dichloro_1_fluoroethane
        Altaxo.Science.Thermodynamics.FluidsFluid_1_2_dichloro_1_1_2_2_tetrafluoroethane
        Altaxo.Science.Thermodynamics.FluidsFluid_1_2_dimethylbenzene
        Altaxo.Science.Thermodynamics.FluidsFluid_1_3_dimethylbenzene
        Altaxo.Science.Thermodynamics.FluidsFluid_1_4_dimethylbenzene
        Altaxo.Science.Thermodynamics.FluidsFluid_1_butene
        Altaxo.Science.Thermodynamics.FluidsFluid_1_chloro_1_1_difluoroethane
        Altaxo.Science.Thermodynamics.FluidsFluid_1_chloro_1_2_2_2_tetrafluoroethane
        Altaxo.Science.Thermodynamics.FluidsFluid_1_chloro_3_3_3_trifluoroprop_1_ene
        Altaxo.Science.Thermodynamics.FluidsFluid_2_2_2_trifluoroethyl_difluoromethyl_ether
        Altaxo.Science.Thermodynamics.FluidsFluid_2_2_4_trimethylpentane
        Altaxo.Science.Thermodynamics.FluidsFluid_2_2_dimethylpropane
        Altaxo.Science.Thermodynamics.FluidsFluid_2_3_3_3_tetrafluoroprop_1_ene
        Altaxo.Science.Thermodynamics.FluidsFluid_2_methyl_1_propene
        Altaxo.Science.Thermodynamics.FluidsFluid_2_methylbutane
        Altaxo.Science.Thermodynamics.FluidsFluid_2_methylpentane
        Altaxo.Science.Thermodynamics.FluidsFluid_2_methylpropane
        Altaxo.Science.Thermodynamics.FluidsFluoromethane
        Altaxo.Science.Thermodynamics.FluidsHelium_4
        Altaxo.Science.Thermodynamics.FluidsHeptane
        Altaxo.Science.Thermodynamics.FluidsHexadecane
        Altaxo.Science.Thermodynamics.FluidsHexafluoroethane
        Altaxo.Science.Thermodynamics.FluidsHexafluoropropene
        Altaxo.Science.Thermodynamics.FluidsHexamethyldisiloxane
        Altaxo.Science.Thermodynamics.FluidsHexane
        Altaxo.Science.Thermodynamics.FluidsHydrogen_Normal
        Altaxo.Science.Thermodynamics.FluidsHydrogenChloride
        Altaxo.Science.Thermodynamics.FluidsHydrogenSulfide
        Altaxo.Science.Thermodynamics.FluidsKrypton
        Altaxo.Science.Thermodynamics.FluidsMethane
        Altaxo.Science.Thermodynamics.FluidsMethoxymethane
        Altaxo.Science.Thermodynamics.FluidsMethyl_heptafluoropropyl_ether
        Altaxo.Science.Thermodynamics.FluidsMethyl_pentafluoroethyl_ether
        Altaxo.Science.Thermodynamics.FluidsMethyl_Z_Z__9_12_octadecadienoate
        Altaxo.Science.Thermodynamics.FluidsMethyl_Z_Z_Z__9_12_15_octadecatrienoate
        Altaxo.Science.Thermodynamics.FluidsMethylbenzene
        Altaxo.Science.Thermodynamics.FluidsMethylCis_9_octadecenoate
        Altaxo.Science.Thermodynamics.FluidsMethylcyclohexane
        Altaxo.Science.Thermodynamics.FluidsMethylHexadecanoate
        Altaxo.Science.Thermodynamics.FluidsMethylOctadecanoate
        Altaxo.Science.Thermodynamics.FluidsMethylTrifluoromethylEther
        Altaxo.Science.Thermodynamics.FluidsN_butane
        Altaxo.Science.Thermodynamics.FluidsN_propylcyclohexane
        Altaxo.Science.Thermodynamics.FluidsNeon
        Altaxo.Science.Thermodynamics.FluidsNitrogen
        Altaxo.Science.Thermodynamics.FluidsNonane
        Altaxo.Science.Thermodynamics.FluidsOctafluorocyclobutane
        Altaxo.Science.Thermodynamics.FluidsOctafluoropropane
        Altaxo.Science.Thermodynamics.FluidsOctamethylcyclotetrasiloxane
        Altaxo.Science.Thermodynamics.FluidsOctamethyltrisiloxane
        Altaxo.Science.Thermodynamics.FluidsOctane
        Altaxo.Science.Thermodynamics.FluidsOrthohydrogen
        Altaxo.Science.Thermodynamics.FluidsOxygen
        Altaxo.Science.Thermodynamics.FluidsPentane
        Altaxo.Science.Thermodynamics.FluidsPhenylethane
        Altaxo.Science.Thermodynamics.FluidsPropane
        Altaxo.Science.Thermodynamics.FluidsPropanone
        Altaxo.Science.Thermodynamics.FluidsPropene
        Altaxo.Science.Thermodynamics.FluidsPropyne
        Altaxo.Science.Thermodynamics.FluidsSulfurDioxide
        Altaxo.Science.Thermodynamics.FluidsTetradecamethylhexasiloxane
        Altaxo.Science.Thermodynamics.FluidsTetrafluoromethane
        Altaxo.Science.Thermodynamics.FluidsTrans_1_3_3_3_tetrafluoropropene
        Altaxo.Science.Thermodynamics.FluidsTrans_2_butene
        Altaxo.Science.Thermodynamics.FluidsTrichlorofluoromethane
        Altaxo.Science.Thermodynamics.FluidsTrifluoroiodomethane
        Altaxo.Science.Thermodynamics.FluidsTrifluoromethane
        Altaxo.Science.Thermodynamics.FluidsUndecane
        Altaxo.Science.Thermodynamics.FluidsWater
        Altaxo.Science.Thermodynamics.FluidsXenon