Equilibrium State (thermo.equilibrium)¶
This module contains an object designed to store the result of a flash calculation and provide convinient access to all properties of the calculated phases and bulks.
For reporting bugs, adding feature requests, or submitting pull requests, please use the GitHub issue tracker.
EquilibriumState¶
- class thermo.equilibrium.EquilibriumState(T, P, zs, gas, liquids, solids, betas, flash_specs=None, flash_convergence=None, constants=None, correlations=None, flasher=None, settings=BulkSettings(dP_dT='MOLE_WEIGHTED', dP_dV='MOLE_WEIGHTED', d2P_dV2='MOLE_WEIGHTED', d2P_dT2='MOLE_WEIGHTED', d2P_dTdV='MOLE_WEIGHTED', mu_LL='LOG_PROP_MASS_WEIGHTED', mu_LL_power_exponent=0.4, mu_VL='McAdams', mu_VL_power_exponent=0.4, k_LL='MASS_WEIGHTED', k_LL_power_exponent=0.4, k_VL='MASS_WEIGHTED', k_VL_power_exponent=0.4, sigma_LL='MASS_WEIGHTED', sigma_LL_power_exponent=0.4, T_liquid_volume_ref=298.15, T_normal=273.15, P_normal=101325.0, T_standard=288.15, P_standard=101325.0, T_gas_ref=288.15, P_gas_ref=101325.0, speed_of_sound='MOLE_WEIGHTED', kappa='MOLE_WEIGHTED', isobaric_expansion='MOLE_WEIGHTED', Joule_Thomson='MOLE_WEIGHTED', VL_ID='PIP', S_ID='d2P_dVdT', solid_sort_method='prop', liquid_sort_method='prop', liquid_sort_cmps=[], solid_sort_cmps=[], liquid_sort_cmps_neg=[], solid_sort_cmps_neg=[], liquid_sort_prop='DENSITY_MASS', solid_sort_prop='DENSITY_MASS', phase_sort_higher_first=True, water_sort='water not special', equilibrium_perturbation=1e-07))[source]¶
Class to represent a thermodynamic equilibrium state with one or more phases in it. This object is designed to be the output of the
thermo.flash.Flash
interface and to provide easy acess to all properties of the mixture.Properties like
Cp
are calculated using the mixing rules configured by theBulkSettings
object. For states with a single phase, this will always reduce to the properties of that phase.This interface allows calculation of thermodynamic properties, and transport properties. Both molar and mass outputs are provided, as separate calls (ex.
Cp
andCp_mass
).- Parameters
- T
float
Temperature of state, [K]
- P
float
Pressure of state, [Pa]
- zs
list
[float
] Overall mole fractions of all species in the state, [-]
- gas
Phase
The calcualted gas phase object, if one was found, [-]
- liquids
list
[Phase
] A list of liquid phase objects, if any were found, [-]
- solids
list
[Phase
] A list of solid phase objects, if any were found, [-]
- betas
list
[float
] Molar phase fractions of every phase, ordered [gas beta, liquid beta0, liquid beta1, …, solid beta0, solid beta1, …]
- flash_specs
dict
[str
float
],optional
A dictionary containing the specifications for the flash calculations, [-]
- flash_convergence
dict
[str
float
],optional
A dictionary containing the convergence results for the flash calculations; this is to help support development of the library only and the contents of this dictionary is subject to change, [-]
- constants
ChemicalConstantsPackage
,optional
Package of chemical constants; all cases these properties are accessible as attributes of this object, [-]
EquilibriumState
object, [-]- correlations
PropertyCorrelationsPackage
,optional
Package of chemical T-dependent properties; these properties are accessible as attributes of this object object, [-]
- flasher
Flash
object
,optional
This reference can be provided to this object to allow the object to return properties which are themselves calculated from results of flash calculations, [-]
- settings
BulkSettings
,optional
Object containing settings for calculating bulk and transport properties, [-]
- T
Examples
The following sample shows a flash for the CO2-n-hexane system with all constants provided, using no data from thermo.
>>> from thermo import * >>> constants = ChemicalConstantsPackage(names=['carbon dioxide', 'hexane'], CASs=['124-38-9', '110-54-3'], MWs=[44.0095, 86.17536], omegas=[0.2252, 0.2975], Pcs=[7376460.0, 3025000.0], Tbs=[194.67, 341.87], Tcs=[304.2, 507.6], Tms=[216.65, 178.075]) >>> correlations = PropertyCorrelationsPackage(constants=constants, skip_missing=True, ... HeatCapacityGases=[HeatCapacityGas(poly_fit=(50.0, 1000.0, [-3.1115474168865828e-21, 1.39156078498805e-17, -2.5430881416264243e-14, 2.4175307893014295e-11, -1.2437314771044867e-08, 3.1251954264658904e-06, -0.00021220221928610925, 0.000884685506352987, 29.266811602924644])), ... HeatCapacityGas(poly_fit=(200.0, 1000.0, [1.3740654453881647e-21, -8.344496203280677e-18, 2.2354782954548568e-14, -3.4659555330048226e-11, 3.410703030634579e-08, -2.1693611029230923e-05, 0.008373280796376588, -1.356180511425385, 175.67091124888998]))]) >>> eos_kwargs = {'Pcs': constants.Pcs, 'Tcs': constants.Tcs, 'omegas': constants.omegas} >>> gas = CEOSGas(PRMIX, eos_kwargs, HeatCapacityGases=correlations.HeatCapacityGases) >>> liq = CEOSLiquid(PRMIX, eos_kwargs, HeatCapacityGases=correlations.HeatCapacityGases) >>> flasher = FlashVL(constants, correlations, liquid=liq, gas=gas) >>> state = flasher.flash(P=1e5, T=196.0, zs=[0.5, 0.5]) >>> type(state) is EquilibriumState True >>> state.phase_count 2 >>> state.bulk.Cp() 108.3164692 >>> state.flash_specs {'zs': [0.5, 0.5], 'T': 196.0, 'P': 100000.0} >>> state.Tms [216.65, 178.075] >>> state.liquid0.H() -34376.4853 >>> state.gas.H() -3608.0551
- Attributes
- gas_count
int
Number of gas phases present (0 or 1), [-]
- liquid_count
int
Number of liquid phases present, [-]
- solid_count
int
Number of solid phases present, [-]
- phase_count
int
Number of phases present, [-]
- gas_beta
float
Molar phase fraction of the gas phase; 0 if no gas phase is present, [-]
- liquids_betas
list
[float
] Liquid molar phase fractions, [-]
- solids_betas
list
[float
] Solid molar phase fractions, [-]
- liquid_zs
list
[float
] Overall mole fractions of each component in the overall liquid phase, [-]
- liquid_bulk
Bulk
Liquid phase bulk, [-]
- solid_zs
list
[float
] Overall mole fractions of each component in the overall solid phase, [-]
- solid_bulk
Bulk
Solid phase bulk, [-]
- bulk
Bulk
Overall phase bulk, [-]
IDs
Alias of CASs.
LF
Method to return the liquid fraction of the equilibrium state.
VF
Method to return the vapor fraction of the equilibrium state.
betas_liquids
Method to calculate and return the fraction of the liquid phase that each liquid phase is, by molar phase fraction.
betas_mass
Method to calculate and return the mass fraction of all of the phases in the system.
betas_mass_liquids
Method to calculate and return the fraction of the liquid phase that each liquid phase is, by mass phase fraction.
betas_mass_states
Method to return the mass phase fractions of each of the three fundamental types of phases.
betas_states
Method to return the molar phase fractions of each of the three fundamental types of phases.
betas_volume
Method to calculate and return the volume fraction of all of the phases in the system.
betas_volume_liquid_ref
Method to calculate and return the standard liquid volume fraction of all of the phases in the bulk.
betas_volume_liquids
Method to calculate and return the fraction of the liquid phase that each liquid phase is, by volume phase fraction.
betas_volume_states
Method to return the volume phase fractions of each of the three fundamental types of phases.
heaviest_liquid
The liquid-like phase with the highest mass density, [-]
lightest_liquid
The liquid-like phase with the lowest mass density, [-]
phase
Method to calculate and return a string representing the phase of the mixture.
quality
Method to return the mass vapor fraction of the equilibrium state.
water_index
The index of the component water in the components.
water_phase
The liquid-like phase with the highest water mole fraction, [-]
water_phase_index
The liquid-like phase with the highest mole fraction of water, [-]
atomss
Breakdown of each component into its elements and their counts, as a dict, [-].
Carcinogens
Status of each component in cancer causing registries, [-].
CASs
CAS registration numbers for each component, [-].
CASis
CAS registration numbers as integeres for each component, [-].
Ceilings
Ceiling exposure limits to chemicals (and their units; ppm or mg/m^3), [various].
charges
Charge number (valence) for each component, [-].
conductivities
Electrical conductivities for each component, [S/m].
dipoles
Dipole moments for each component, [debye].
economic_statuses
Status of each component in in relation to import and export from various regions, [-].
formulas
Formulas of each component, [-].
Gfgs
Ideal gas standard molar Gibbs free energy of formation for each component, [J/mol].
Gfgs_mass
Ideal gas standard Gibbs free energy of formation for each component, [J/kg].
GWPs
Global Warming Potentials for each component (impact/mass chemical)/(impact/mass CO2), [-].
Hcs
Higher standard molar heats of combustion for each component, [J/mol].
Hcs_lower
Lower standard molar heats of combustion for each component, [J/mol].
Hcs_lower_mass
Lower standard heats of combustion for each component, [J/kg].
Hcs_mass
Higher standard heats of combustion for each component, [J/kg].
Hfgs
Ideal gas standard molar enthalpies of formation for each component, [J/mol].
Hfgs_mass
Ideal gas standard enthalpies of formation for each component, [J/kg].
Hfus_Tms
Molar heats of fusion for each component at their respective melting points, [J/mol].
Hfus_Tms_mass
Heats of fusion for each component at their respective melting points, [J/kg].
Hsub_Tts
Heats of sublimation for each component at their respective triple points, [J/mol].
Hsub_Tts_mass
Heats of sublimation for each component at their respective triple points, [J/kg].
Hvap_298s
Molar heats of vaporization for each component at 298.15 K, [J/mol].
Hvap_298s_mass
Heats of vaporization for each component at 298.15 K, [J/kg].
Hvap_Tbs
Molar heats of vaporization for each component at their respective normal boiling points, [J/mol].
Hvap_Tbs_mass
Heats of vaporization for each component at their respective normal boiling points, [J/kg].
InChI_Keys
InChI Keys for each component, [-].
InChIs
InChI strings for each component, [-].
legal_statuses
Status of each component in in relation to import and export rules from various regions, [-].
LFLs
Lower flammability limits for each component, [-].
logPs
Octanol-water partition coefficients for each component, [-].
molecular_diameters
Lennard-Jones molecular diameters for each component, [angstrom].
MWs
Molecular weights for each component, [g/mol].
names
Names for each component, [-].
aliases
Aliases for each component, [-].
ODPs
Ozone Depletion Potentials for each component (impact/mass chemical)/(impact/mass CFC-11), [-].
omegas
Acentric factors for each component, [-].
Parachors
Parachors for each component, [N^0.25*m^2.75/mol].
Pcs
Critical pressures for each component, [Pa].
phase_STPs
Standard states (‘g’, ‘l’, or ‘s’) for each component, [-].
Psat_298s
Vapor pressures for each component at 298.15 K, [Pa].
PSRK_groups
PSRK subgroup: count groups for each component, [-].
Pts
Triple point pressures for each component, [Pa].
PubChems
Pubchem IDs for each component, [-].
rhocs
Molar densities at the critical point for each component, [mol/m^3].
rhocs_mass
Densities at the critical point for each component, [kg/m^3].
rhol_STPs
Molar liquid densities at STP for each component, [mol/m^3].
rhol_STPs_mass
Liquid densities at STP for each component, [kg/m^3].
RIs
Refractive indexes for each component, [-].
S0gs
Ideal gas absolute molar entropies at 298.15 K at 1 atm for each component, [J/(mol*K)].
S0gs_mass
Ideal gas absolute entropies at 298.15 K at 1 atm for each component, [J/(kg*K)].
Sfgs
Ideal gas standard molar entropies of formation for each component, [J/(mol*K)].
Sfgs_mass
Ideal gas standard entropies of formation for each component, [J/(kg*K)].
similarity_variables
Similarity variables for each component, [mol/g].
Skins
Whether each compound can be absorbed through the skin or not, [-].
smiless
SMILES identifiers for each component, [-].
STELs
Short term exposure limits to chemicals (and their units; ppm or mg/m^3), [various].
StielPolars
Stiel polar factors for each component, [-].
Stockmayers
Lennard-Jones Stockmayer parameters (depth of potential-energy minimum over k) for each component, [K].
Tautoignitions
Autoignition temperatures for each component, [K].
Tbs
Boiling temperatures for each component, [K].
Tcs
Critical temperatures for each component, [K].
Tflashs
Flash point temperatures for each component, [K].
Tms
Melting temperatures for each component, [K].
Tts
Triple point temperatures for each component, [K].
TWAs
Time-weighted average exposure limits to chemicals (and their units; ppm or mg/m^3), [various].
UFLs
Upper flammability limits for each component, [-].
UNIFAC_Dortmund_groups
UNIFAC_Dortmund_group: count groups for each component, [-].
UNIFAC_groups
UNIFAC_group: count groups for each component, [-].
Van_der_Waals_areas
Unnormalized Van der Waals areas for each component, [m^2/mol].
Van_der_Waals_volumes
Unnormalized Van der Waals volumes for each component, [m^3/mol].
Vcs
Critical molar volumes for each component, [m^3/mol].
Vml_STPs
Liquid molar volumes for each component at STP, [m^3/mol].
Vml_Tms
Liquid molar volumes for each component at their respective melting points, [m^3/mol].
Zcs
Critical compressibilities for each component, [-].
UNIFAC_Rs
UNIFAC R parameters for each component, [-].
UNIFAC_Qs
UNIFAC Q parameters for each component, [-].
rhos_Tms
Solid molar densities for each component at their respective melting points, [mol/m^3].
Vms_Tms
Solid molar volumes for each component at their respective melting points, [m^3/mol].
rhos_Tms_mass
Solid mass densities for each component at their melting point, [kg/m^3].
solubility_parameters
Solubility parameters for each component at 298.15 K, [Pa^0.5].
Vml_60Fs
Liquid molar volumes for each component at 60 °F, [m^3/mol].
rhol_60Fs
Liquid molar densities for each component at 60 °F, [mol/m^3].
rhol_60Fs_mass
Liquid mass densities for each component at 60 °F, [kg/m^3].
conductivity_Ts
Temperatures at which the electrical conductivities for each component were measured, [K].
RI_Ts
Temperatures at which the refractive indexes were reported for each component, [K].
Vmg_STPs
Gas molar volumes for each component at STP; metastable if normally another state, [m^3/mol].
rhog_STPs
Molar gas densities at STP for each component; metastable if normally another state, [mol/m^3].
rhog_STPs_mass
Gas densities at STP for each component; metastable if normally another state, [kg/m^3].
sigma_STPs
Liquid-air surface tensions at 298.15 K and the higher of 101325 Pa or the saturation pressure, [N/m].
sigma_Tms
Liquid-air surface tensions at the melting point and 101325 Pa, [N/m].
sigma_Tbs
Liquid-air surface tensions at the normal boiling point and 101325 Pa, [N/m].
Hf_STPs
Standard state molar enthalpies of formation for each component, [J/mol].
Hf_STPs_mass
Standard state mass enthalpies of formation for each component, [J/kg].
functional_groups
Set of functional group constants present in each component, [-].
VaporPressures
Wrapper to obtain the list of VaporPressures objects of the associated
PropertyCorrelationsPackage
.VolumeLiquids
Wrapper to obtain the list of VolumeLiquids objects of the associated
PropertyCorrelationsPackage
.VolumeGases
Wrapper to obtain the list of VolumeGases objects of the associated
PropertyCorrelationsPackage
.VolumeSolids
Wrapper to obtain the list of VolumeSolids objects of the associated
PropertyCorrelationsPackage
.HeatCapacityGases
Wrapper to obtain the list of HeatCapacityGases objects of the associated
PropertyCorrelationsPackage
.HeatCapacitySolids
Wrapper to obtain the list of HeatCapacitySolids objects of the associated
PropertyCorrelationsPackage
.HeatCapacityLiquids
Wrapper to obtain the list of HeatCapacityLiquids objects of the associated
PropertyCorrelationsPackage
.EnthalpyVaporizations
Wrapper to obtain the list of EnthalpyVaporizations objects of the associated
PropertyCorrelationsPackage
.EnthalpySublimations
Wrapper to obtain the list of EnthalpySublimations objects of the associated
PropertyCorrelationsPackage
.SublimationPressures
Wrapper to obtain the list of SublimationPressures objects of the associated
PropertyCorrelationsPackage
.PermittivityLiquids
Wrapper to obtain the list of PermittivityLiquids objects of the associated
PropertyCorrelationsPackage
.ViscosityLiquids
Wrapper to obtain the list of ViscosityLiquids objects of the associated
PropertyCorrelationsPackage
.ViscosityGases
Wrapper to obtain the list of ViscosityGases objects of the associated
PropertyCorrelationsPackage
.ThermalConductivityLiquids
Wrapper to obtain the list of ThermalConductivityLiquids objects of the associated
PropertyCorrelationsPackage
.ThermalConductivityGases
Wrapper to obtain the list of ThermalConductivityGases objects of the associated
PropertyCorrelationsPackage
.ThermalConductivitySolids
Wrapper to obtain the list of ThermalConductivitySolids objects of the associated
PropertyCorrelationsPackage
.SurfaceTensions
Wrapper to obtain the list of SurfaceTensions objects of the associated
PropertyCorrelationsPackage
.VolumeGasMixture
Wrapper to obtain the list of VolumeGasMixture objects of the associated
PropertyCorrelationsPackage
.VolumeLiquidMixture
Wrapper to obtain the list of VolumeLiquidMixture objects of the associated
PropertyCorrelationsPackage
.VolumeSolidMixture
Wrapper to obtain the list of VolumeSolidMixture objects of the associated
PropertyCorrelationsPackage
.HeatCapacityGasMixture
Wrapper to obtain the list of HeatCapacityGasMixture objects of the associated
PropertyCorrelationsPackage
.HeatCapacityLiquidMixture
Wrapper to obtain the list of HeatCapacityLiquidMixture objects of the associated
PropertyCorrelationsPackage
.HeatCapacitySolidMixture
Wrapper to obtain the list of HeatCapacitySolidMixture objects of the associated
PropertyCorrelationsPackage
.ViscosityGasMixture
Wrapper to obtain the list of ViscosityGasMixture objects of the associated
PropertyCorrelationsPackage
.ViscosityLiquidMixture
Wrapper to obtain the list of ViscosityLiquidMixture objects of the associated
PropertyCorrelationsPackage
.ThermalConductivityGasMixture
Wrapper to obtain the list of ThermalConductivityGasMixture objects of the associated
PropertyCorrelationsPackage
.ThermalConductivityLiquidMixture
Wrapper to obtain the list of ThermalConductivityLiquidMixture objects of the associated
PropertyCorrelationsPackage
.SurfaceTensionMixture
Wrapper to obtain the list of SurfaceTensionMixture objects of the associated
PropertyCorrelationsPackage
.
- gas_count
Methods
A
()Method to calculate and return the Helmholtz energy of the phase.
API
([phase])Method to calculate and return the API of the phase.
A_dep
()Method to calculate and return the departure Helmholtz energy of the phase.
A_dep_flow
([phase])Method to return the flow rate of the difference between the ideal-gas Helmholtz energy of this phase and the Helmholtz energy of the phase This method is only available when the phase is linked to an EquilibriumStream.
Method to calculate and return the departure mass Helmholtz energy of the phase.
A_flow
([phase])Method to return the flow rate of Helmholtz energy of this phase.
A_formation_ideal_gas
([phase])Method to calculate and return the ideal-gas Helmholtz energy of formation of the phase (as if the phase was an ideal gas).
Method to calculate and return the ideal-gas formation mass Helmholtz energy of the phase.
A_ideal_gas
([phase])Method to calculate and return the ideal-gas Helmholtz energy of the phase.
Method to calculate and return the mass ideal-gas Helmholtz energy of the phase.
A_mass
([phase])Method to calculate and return mass Helmholtz energy of the phase.
Method to calculate and return the Helmholtz free energy of the phase on a reactive basis.
Method to calculate and return mass Helmholtz energy on a reactive basis of the phase.
Method to calculate and return the number of atoms in the flow which are Actinium, [atoms/s]
Method to calculate and return the mole flow that is Actinium, [mol/s]
Method to calculate and return the mole fraction that is Actinium element, [-]
Method to calculate and return the mass flow of atoms that are Actinium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Actinium element, [-]
Method to calculate and return the number of atoms in the flow which are Aluminium, [atoms/s]
Method to calculate and return the mole flow that is Aluminium, [mol/s]
Method to calculate and return the mole fraction that is Aluminium element, [-]
Method to calculate and return the mass flow of atoms that are Aluminium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Aluminium element, [-]
Method to calculate and return the number of atoms in the flow which are Americium, [atoms/s]
Method to calculate and return the mole flow that is Americium, [mol/s]
Method to calculate and return the mole fraction that is Americium element, [-]
Method to calculate and return the mass flow of atoms that are Americium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Americium element, [-]
Method to calculate and return the number of atoms in the flow which are Antimony, [atoms/s]
Method to calculate and return the mole flow that is Antimony, [mol/s]
Method to calculate and return the mole fraction that is Antimony element, [-]
Method to calculate and return the mass flow of atoms that are Antimony element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Antimony element, [-]
Method to calculate and return the number of atoms in the flow which are Argon, [atoms/s]
Method to calculate and return the mole flow that is Argon, [mol/s]
Method to calculate and return the mole fraction that is Argon element, [-]
Method to calculate and return the mass flow of atoms that are Argon element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Argon element, [-]
Method to calculate and return the number of atoms in the flow which are Arsenic, [atoms/s]
Method to calculate and return the mole flow that is Arsenic, [mol/s]
Method to calculate and return the mole fraction that is Arsenic element, [-]
Method to calculate and return the mass flow of atoms that are Arsenic element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Arsenic element, [-]
Method to calculate and return the number of atoms in the flow which are Astatine, [atoms/s]
Method to calculate and return the mole flow that is Astatine, [mol/s]
Method to calculate and return the mole fraction that is Astatine element, [-]
Method to calculate and return the mass flow of atoms that are Astatine element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Astatine element, [-]
Method to calculate and return the number of atoms in the flow which are Barium, [atoms/s]
Method to calculate and return the mole flow that is Barium, [mol/s]
Method to calculate and return the mole fraction that is Barium element, [-]
Method to calculate and return the mass flow of atoms that are Barium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Barium element, [-]
Method to calculate and return the number of atoms in the flow which are Berkelium, [atoms/s]
Method to calculate and return the mole flow that is Berkelium, [mol/s]
Method to calculate and return the mole fraction that is Berkelium element, [-]
Method to calculate and return the mass flow of atoms that are Berkelium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Berkelium element, [-]
Method to calculate and return the number of atoms in the flow which are Beryllium, [atoms/s]
Method to calculate and return the mole flow that is Beryllium, [mol/s]
Method to calculate and return the mole fraction that is Beryllium element, [-]
Method to calculate and return the mass flow of atoms that are Beryllium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Beryllium element, [-]
Method to calculate and return the number of atoms in the flow which are Bismuth, [atoms/s]
Method to calculate and return the mole flow that is Bismuth, [mol/s]
Method to calculate and return the mole fraction that is Bismuth element, [-]
Method to calculate and return the mass flow of atoms that are Bismuth element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Bismuth element, [-]
Method to calculate and return the number of atoms in the flow which are Bohrium, [atoms/s]
Method to calculate and return the mole flow that is Bohrium, [mol/s]
Method to calculate and return the mole fraction that is Bohrium element, [-]
Method to calculate and return the mass flow of atoms that are Bohrium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Bohrium element, [-]
Method to calculate and return the number of atoms in the flow which are Boron, [atoms/s]
Method to calculate and return the mole flow that is Boron, [mol/s]
Method to calculate and return the mole fraction that is Boron element, [-]
Method to calculate and return the mass flow of atoms that are Boron element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Boron element, [-]
Method to calculate and return the number of atoms in the flow which are Bromine, [atoms/s]
Method to calculate and return the mole flow that is Bromine, [mol/s]
Method to calculate and return the mole fraction that is Bromine element, [-]
Method to calculate and return the mass flow of atoms that are Bromine element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Bromine element, [-]
Method to calculate and return the number of atoms in the flow which are Cadmium, [atoms/s]
Method to calculate and return the mole flow that is Cadmium, [mol/s]
Method to calculate and return the mole fraction that is Cadmium element, [-]
Method to calculate and return the mass flow of atoms that are Cadmium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Cadmium element, [-]
Method to calculate and return the number of atoms in the flow which are Caesium, [atoms/s]
Method to calculate and return the mole flow that is Caesium, [mol/s]
Method to calculate and return the mole fraction that is Caesium element, [-]
Method to calculate and return the mass flow of atoms that are Caesium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Caesium element, [-]
Method to calculate and return the number of atoms in the flow which are Calcium, [atoms/s]
Method to calculate and return the mole flow that is Calcium, [mol/s]
Method to calculate and return the mole fraction that is Calcium element, [-]
Method to calculate and return the mass flow of atoms that are Calcium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Calcium element, [-]
Method to calculate and return the number of atoms in the flow which are Californium, [atoms/s]
Method to calculate and return the mole flow that is Californium, [mol/s]
Method to calculate and return the mole fraction that is Californium element, [-]
Method to calculate and return the mass flow of atoms that are Californium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Californium element, [-]
Method to calculate and return the number of atoms in the flow which are Carbon, [atoms/s]
Method to calculate and return the mole flow that is Carbon, [mol/s]
Method to calculate and return the mole fraction that is Carbon element, [-]
Method to calculate and return the mass flow of atoms that are Carbon element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Carbon element, [-]
Method to calculate and return the number of atoms in the flow which are Cerium, [atoms/s]
Method to calculate and return the mole flow that is Cerium, [mol/s]
Method to calculate and return the mole fraction that is Cerium element, [-]
Method to calculate and return the mass flow of atoms that are Cerium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Cerium element, [-]
Method to calculate and return the number of atoms in the flow which are Chlorine, [atoms/s]
Method to calculate and return the mole flow that is Chlorine, [mol/s]
Method to calculate and return the mole fraction that is Chlorine element, [-]
Method to calculate and return the mass flow of atoms that are Chlorine element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Chlorine element, [-]
Method to calculate and return the number of atoms in the flow which are Chromium, [atoms/s]
Method to calculate and return the mole flow that is Chromium, [mol/s]
Method to calculate and return the mole fraction that is Chromium element, [-]
Method to calculate and return the mass flow of atoms that are Chromium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Chromium element, [-]
Method to calculate and return the number of atoms in the flow which are Cobalt, [atoms/s]
Method to calculate and return the mole flow that is Cobalt, [mol/s]
Method to calculate and return the mole fraction that is Cobalt element, [-]
Method to calculate and return the mass flow of atoms that are Cobalt element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Cobalt element, [-]
Method to calculate and return the number of atoms in the flow which are Copernicium, [atoms/s]
Method to calculate and return the mole flow that is Copernicium, [mol/s]
Method to calculate and return the mole fraction that is Copernicium element, [-]
Method to calculate and return the mass flow of atoms that are Copernicium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Copernicium element, [-]
Method to calculate and return the number of atoms in the flow which are Copper, [atoms/s]
Method to calculate and return the mole flow that is Copper, [mol/s]
Method to calculate and return the mole fraction that is Copper element, [-]
Method to calculate and return the mass flow of atoms that are Copper element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Copper element, [-]
Cp
()Method to calculate and return the constant-temperature and constant phase-fraction heat capacity of the bulk phase.
Method to calculate and return the Cp/Cv ratio of the phase.
Cp_Cv_ratio_ideal_gas
([phase])Method to calculate and return the ratio of the ideal-gas heat capacity to its constant-volume heat capacity.
Cp_dep
([phase])Method to calculate and return the difference between the actual Cp and the ideal-gas heat capacity of the phase.
Method to calculate and return mass constant pressure departure heat capacity of the phase.
Cp_ideal_gas
([phase])Method to calculate and return the ideal-gas heat capacity of the phase.
Method to calculate and return mass constant pressure departure heat capacity of the phase.
Cp_mass
([phase])Method to calculate and return mass constant pressure heat capacity of the phase.
Cpgs
()Method to calculate and return the pure-component ideal gas heat capacities of each species from the
thermo.heat_capacity.HeatCapacityGas
objects.Cpls
()Method to calculate and return the pure-component liquid temperature-dependent heat capacities of each species from the
thermo.heat_capacity.HeatCapacityLiquid
objects.Cpss
()Method to calculate and return the pure-component solid heat capacities of each species from the
thermo.heat_capacity.HeatCapacitySolid
objects.Method to calculate and return the number of atoms in the flow which are Curium, [atoms/s]
Method to calculate and return the mole flow that is Curium, [mol/s]
Method to calculate and return the mole fraction that is Curium element, [-]
Method to calculate and return the mass flow of atoms that are Curium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Curium element, [-]
Cv
()Method to calculate and return the constant-volume heat capacity Cv of the phase.
Cv_dep
([phase])Method to calculate and return the difference between the actual Cv and the ideal-gas constant volume heat capacity of the phase.
Method to calculate and return mass constant pressure departure heat capacity of the phase.
Cv_ideal_gas
([phase])Method to calculate and return the ideal-gas constant volume heat capacity of the phase.
Cv_mass
([phase])Method to calculate and return mass constant volume heat capacity of the phase.
Method to calculate and return the number of atoms in the flow which are Darmstadtium, [atoms/s]
Method to calculate and return the mole flow that is Darmstadtium, [mol/s]
Method to calculate and return the mole fraction that is Darmstadtium element, [-]
Method to calculate and return the mass flow of atoms that are Darmstadtium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Darmstadtium element, [-]
Method to calculate and return the number of atoms in the flow which are Dubnium, [atoms/s]
Method to calculate and return the mole flow that is Dubnium, [mol/s]
Method to calculate and return the mole fraction that is Dubnium element, [-]
Method to calculate and return the mass flow of atoms that are Dubnium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Dubnium element, [-]
Method to calculate and return the number of atoms in the flow which are Dysprosium, [atoms/s]
Method to calculate and return the mole flow that is Dysprosium, [mol/s]
Method to calculate and return the mole fraction that is Dysprosium element, [-]
Method to calculate and return the mass flow of atoms that are Dysprosium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Dysprosium element, [-]
Method to calculate and return the number of atoms in the flow which are Einsteinium, [atoms/s]
Method to calculate and return the mole flow that is Einsteinium, [mol/s]
Method to calculate and return the mole fraction that is Einsteinium element, [-]
Method to calculate and return the mass flow of atoms that are Einsteinium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Einsteinium element, [-]
Method to calculate and return the number of atoms in the flow which are Erbium, [atoms/s]
Method to calculate and return the mole flow that is Erbium, [mol/s]
Method to calculate and return the mole fraction that is Erbium element, [-]
Method to calculate and return the mass flow of atoms that are Erbium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Erbium element, [-]
Method to calculate and return the number of atoms in the flow which are Europium, [atoms/s]
Method to calculate and return the mole flow that is Europium, [mol/s]
Method to calculate and return the mole fraction that is Europium element, [-]
Method to calculate and return the mass flow of atoms that are Europium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Europium element, [-]
Method to calculate and return the number of atoms in the flow which are Fermium, [atoms/s]
Method to calculate and return the mole flow that is Fermium, [mol/s]
Method to calculate and return the mole fraction that is Fermium element, [-]
Method to calculate and return the mass flow of atoms that are Fermium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Fermium element, [-]
Method to calculate and return the number of atoms in the flow which are Flerovium, [atoms/s]
Method to calculate and return the mole flow that is Flerovium, [mol/s]
Method to calculate and return the mole fraction that is Flerovium element, [-]
Method to calculate and return the mass flow of atoms that are Flerovium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Flerovium element, [-]
Method to calculate and return the number of atoms in the flow which are Fluorine, [atoms/s]
Method to calculate and return the mole flow that is Fluorine, [mol/s]
Method to calculate and return the mole fraction that is Fluorine element, [-]
Method to calculate and return the mass flow of atoms that are Fluorine element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Fluorine element, [-]
Method to calculate and return the number of atoms in the flow which are Francium, [atoms/s]
Method to calculate and return the mole flow that is Francium, [mol/s]
Method to calculate and return the mole fraction that is Francium element, [-]
Method to calculate and return the mass flow of atoms that are Francium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Francium element, [-]
G
()Method to calculate and return the Gibbs free energy of the phase.
G_dep
()Method to calculate and return the departure Gibbs free energy of the phase.
G_dep_flow
([phase])Method to return the flow rate of the difference between the ideal-gas Gibbs free energy of this phase and the actual Gibbs free energy of the phase This method is only available when the phase is linked to an EquilibriumStream.
Method to calculate and return the mass departure Gibbs free energy of the phase.
G_flow
([phase])Method to return the flow rate of Gibbs free energy of this phase.
G_formation_ideal_gas
([phase])Method to calculate and return the ideal-gas Gibbs free energy of formation of the phase (as if the phase was an ideal gas).
Method to calculate and return the mass ideal-gas formation Gibbs free energy of the phase.
G_ideal_gas
([phase])Method to calculate and return the ideal-gas Gibbs free energy of the phase.
Method to calculate and return the mass ideal-gas Gibbs free energy of the phase.
G_mass
([phase])Method to calculate and return mass Gibbs energy of the phase.
Method to calculate and return the Gibbs energy criteria required for comparing phase stability.
Method to calculate and return the Gibbs free energy of the phase on a reactive basis.
Method to calculate and return mass Gibbs free energy on a reactive basis of the phase.
Method to calculate and return the number of atoms in the flow which are Gadolinium, [atoms/s]
Method to calculate and return the mole flow that is Gadolinium, [mol/s]
Method to calculate and return the mole fraction that is Gadolinium element, [-]
Method to calculate and return the mass flow of atoms that are Gadolinium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Gadolinium element, [-]
Method to calculate and return the number of atoms in the flow which are Gallium, [atoms/s]
Method to calculate and return the mole flow that is Gallium, [mol/s]
Method to calculate and return the mole fraction that is Gallium element, [-]
Method to calculate and return the mass flow of atoms that are Gallium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Gallium element, [-]
Method to calculate and return the number of atoms in the flow which are Germanium, [atoms/s]
Method to calculate and return the mole flow that is Germanium, [mol/s]
Method to calculate and return the mole fraction that is Germanium element, [-]
Method to calculate and return the mass flow of atoms that are Germanium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Germanium element, [-]
Method to calculate and return the number of atoms in the flow which are Gold, [atoms/s]
Method to calculate and return the mole flow that is Gold, [mol/s]
Method to calculate and return the mole fraction that is Gold element, [-]
Method to calculate and return the mass flow of atoms that are Gold element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Gold element, [-]
H
()Method to calculate and return the constant-temperature and constant phase-fraction enthalpy of the bulk phase.
H_C_ratio
([phase])Method to calculate and return the atomic ratio of hydrogen atoms to carbon atoms, based on the current composition of the phase.
H_C_ratio_mass
([phase])Method to calculate and return the mass ratio of hydrogen atoms to carbon atoms, based on the current composition of the phase.
H_dep
([phase])Method to calculate and return the difference between the actual H and the ideal-gas enthalpy of the phase.
H_dep_flow
([phase])Method to return the flow rate of the difference between the ideal-gas energy of this phase and the actual energy of the phase This method is only available when the phase is linked to an EquilibriumStream.
Method to calculate and return the mass departure enthalpy of the phase.
H_flow
([phase])Method to return the flow rate of enthalpy of this phase.
H_formation_ideal_gas
([phase])Method to calculate and return the ideal-gas enthalpy of formation of the phase (as if the phase was an ideal gas).
Method to calculate and return the mass ideal-gas formation enthalpy of the phase.
H_ideal_gas
([phase])Method to calculate and return the ideal-gas enthalpy of the phase.
Method to calculate and return the mass ideal-gas enthalpy of the phase.
H_mass
([phase])Method to calculate and return mass enthalpy of the phase.
Method to calculate and return the constant-temperature and constant phase-fraction reactive enthalpy of the bulk phase.
Method to calculate and return mass enthalpy on a reactive basis of the phase.
Method to calculate and return the number of atoms in the flow which are Hafnium, [atoms/s]
Method to calculate and return the mole flow that is Hafnium, [mol/s]
Method to calculate and return the mole fraction that is Hafnium element, [-]
Method to calculate and return the mass flow of atoms that are Hafnium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Hafnium element, [-]
Method to calculate and return the number of atoms in the flow which are Hassium, [atoms/s]
Method to calculate and return the mole flow that is Hassium, [mol/s]
Method to calculate and return the mole fraction that is Hassium element, [-]
Method to calculate and return the mass flow of atoms that are Hassium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Hassium element, [-]
Hc
([phase])Method to calculate and return the molar ideal-gas higher heat of combustion of the object, [J/mol]
Hc_lower
([phase])Method to calculate and return the molar ideal-gas lower heat of combustion of the object, [J/mol]
Hc_lower_mass
([phase])Method to calculate and return the mass ideal-gas lower heat of combustion of the object, [J/mol]
Hc_lower_normal
([phase])Method to calculate and return the volumetric ideal-gas lower heat of combustion of the object using the normal gas volume, [J/m^3]
Hc_lower_standard
([phase])Method to calculate and return the volumetric ideal-gas lower heat of combustion of the object using the standard gas volume, [J/m^3]
Hc_mass
([phase])Method to calculate and return the mass ideal-gas higher heat of combustion of the object, [J/mol]
Hc_normal
([phase])Method to calculate and return the volumetric ideal-gas higher heat of combustion of the object using the normal gas volume, [J/m^3]
Hc_standard
([phase])Method to calculate and return the volumetric ideal-gas higher heat of combustion of the object using the standard gas volume, [J/m^3]
Method to calculate and return the number of atoms in the flow which are Helium, [atoms/s]
Method to calculate and return the mole flow that is Helium, [mol/s]
Method to calculate and return the mole fraction that is Helium element, [-]
Method to calculate and return the mass flow of atoms that are Helium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Helium element, [-]
Method to calculate and return the number of atoms in the flow which are Holmium, [atoms/s]
Method to calculate and return the mole flow that is Holmium, [mol/s]
Method to calculate and return the mole fraction that is Holmium element, [-]
Method to calculate and return the mass flow of atoms that are Holmium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Holmium element, [-]
Hsubs
()Method to calculate and return the pure-component enthalpy of sublimation of each species from the
thermo.phase_change.EnthalpySublimation
objects.Hvaps
()Method to calculate and return the pure-component enthalpy of vaporization of each species from the
thermo.phase_change.EnthalpyVaporization
objects.Method to calculate and return the number of atoms in the flow which are Hydrogen, [atoms/s]
Method to calculate and return the mole flow that is Hydrogen, [mol/s]
Method to calculate and return the mole fraction that is Hydrogen element, [-]
Method to calculate and return the mass flow of atoms that are Hydrogen element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Hydrogen element, [-]
Method to calculate and return the number of atoms in the flow which are Indium, [atoms/s]
Method to calculate and return the mole flow that is Indium, [mol/s]
Method to calculate and return the mole fraction that is Indium element, [-]
Method to calculate and return the mass flow of atoms that are Indium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Indium element, [-]
Method to calculate and return the number of atoms in the flow which are Iodine, [atoms/s]
Method to calculate and return the mole flow that is Iodine, [mol/s]
Method to calculate and return the mole fraction that is Iodine element, [-]
Method to calculate and return the mass flow of atoms that are Iodine element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Iodine element, [-]
Method to calculate and return the number of atoms in the flow which are Iridium, [atoms/s]
Method to calculate and return the mole flow that is Iridium, [mol/s]
Method to calculate and return the mole fraction that is Iridium element, [-]
Method to calculate and return the mass flow of atoms that are Iridium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Iridium element, [-]
Method to calculate and return the number of atoms in the flow which are Iron, [atoms/s]
Method to calculate and return the mole flow that is Iron, [mol/s]
Method to calculate and return the mole fraction that is Iron element, [-]
Method to calculate and return the mass flow of atoms that are Iron element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Iron element, [-]
Method to calculate and return the Joule-Thomson coefficient of the bulk according to the selected calculation methodology.
Method to calculate and return the number of atoms in the flow which are Krypton, [atoms/s]
Method to calculate and return the mole flow that is Krypton, [mol/s]
Method to calculate and return the mole fraction that is Krypton element, [-]
Method to calculate and return the mass flow of atoms that are Krypton element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Krypton element, [-]
Ks
(phase[, ref_phase])Method to calculate and return the K-values of each phase.
Method to calculate and return the number of atoms in the flow which are Lanthanum, [atoms/s]
Method to calculate and return the mole flow that is Lanthanum, [mol/s]
Method to calculate and return the mole fraction that is Lanthanum element, [-]
Method to calculate and return the mass flow of atoms that are Lanthanum element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Lanthanum element, [-]
Method to calculate and return the number of atoms in the flow which are Lawrencium, [atoms/s]
Method to calculate and return the mole flow that is Lawrencium, [mol/s]
Method to calculate and return the mole fraction that is Lawrencium element, [-]
Method to calculate and return the mass flow of atoms that are Lawrencium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Lawrencium element, [-]
Method to calculate and return the number of atoms in the flow which are Lead, [atoms/s]
Method to calculate and return the mole flow that is Lead, [mol/s]
Method to calculate and return the mole fraction that is Lead element, [-]
Method to calculate and return the mass flow of atoms that are Lead element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Lead element, [-]
Method to calculate and return the number of atoms in the flow which are Lithium, [atoms/s]
Method to calculate and return the mole flow that is Lithium, [mol/s]
Method to calculate and return the mole fraction that is Lithium element, [-]
Method to calculate and return the mass flow of atoms that are Lithium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Lithium element, [-]
Method to calculate and return the number of atoms in the flow which are Livermorium, [atoms/s]
Method to calculate and return the mole flow that is Livermorium, [mol/s]
Method to calculate and return the mole fraction that is Livermorium element, [-]
Method to calculate and return the mass flow of atoms that are Livermorium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Livermorium element, [-]
Method to calculate and return the number of atoms in the flow which are Lutetium, [atoms/s]
Method to calculate and return the mole flow that is Lutetium, [mol/s]
Method to calculate and return the mole fraction that is Lutetium element, [-]
Method to calculate and return the mass flow of atoms that are Lutetium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Lutetium element, [-]
MW
([phase])Method to calculate and return the molecular weight of the phase.
Method to calculate and return the number of atoms in the flow which are Magnesium, [atoms/s]
Method to calculate and return the mole flow that is Magnesium, [mol/s]
Method to calculate and return the mole fraction that is Magnesium element, [-]
Method to calculate and return the mass flow of atoms that are Magnesium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Magnesium element, [-]
Method to calculate and return the number of atoms in the flow which are Manganese, [atoms/s]
Method to calculate and return the mole flow that is Manganese, [mol/s]
Method to calculate and return the mole fraction that is Manganese element, [-]
Method to calculate and return the mass flow of atoms that are Manganese element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Manganese element, [-]
Method to calculate and return the number of atoms in the flow which are Meitnerium, [atoms/s]
Method to calculate and return the mole flow that is Meitnerium, [mol/s]
Method to calculate and return the mole fraction that is Meitnerium element, [-]
Method to calculate and return the mass flow of atoms that are Meitnerium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Meitnerium element, [-]
Method to calculate and return the number of atoms in the flow which are Mendelevium, [atoms/s]
Method to calculate and return the mole flow that is Mendelevium, [mol/s]
Method to calculate and return the mole fraction that is Mendelevium element, [-]
Method to calculate and return the mass flow of atoms that are Mendelevium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Mendelevium element, [-]
Method to calculate and return the number of atoms in the flow which are Mercury, [atoms/s]
Method to calculate and return the mole flow that is Mercury, [mol/s]
Method to calculate and return the mole fraction that is Mercury element, [-]
Method to calculate and return the mass flow of atoms that are Mercury element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Mercury element, [-]
Method to calculate and return the number of atoms in the flow which are Molybdenum, [atoms/s]
Method to calculate and return the mole flow that is Molybdenum, [mol/s]
Method to calculate and return the mole fraction that is Molybdenum element, [-]
Method to calculate and return the mass flow of atoms that are Molybdenum element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Molybdenum element, [-]
Method to calculate and return the number of atoms in the flow which are Moscovium, [atoms/s]
Method to calculate and return the mole flow that is Moscovium, [mol/s]
Method to calculate and return the mole fraction that is Moscovium element, [-]
Method to calculate and return the mass flow of atoms that are Moscovium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Moscovium element, [-]
Method to calculate and return the number of atoms in the flow which are Neodymium, [atoms/s]
Method to calculate and return the mole flow that is Neodymium, [mol/s]
Method to calculate and return the mole fraction that is Neodymium element, [-]
Method to calculate and return the mass flow of atoms that are Neodymium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Neodymium element, [-]
Method to calculate and return the number of atoms in the flow which are Neon, [atoms/s]
Method to calculate and return the mole flow that is Neon, [mol/s]
Method to calculate and return the mole fraction that is Neon element, [-]
Method to calculate and return the mass flow of atoms that are Neon element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Neon element, [-]
Method to calculate and return the number of atoms in the flow which are Neptunium, [atoms/s]
Method to calculate and return the mole flow that is Neptunium, [mol/s]
Method to calculate and return the mole fraction that is Neptunium element, [-]
Method to calculate and return the mass flow of atoms that are Neptunium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Neptunium element, [-]
Method to calculate and return the number of atoms in the flow which are Nickel, [atoms/s]
Method to calculate and return the mole flow that is Nickel, [mol/s]
Method to calculate and return the mole fraction that is Nickel element, [-]
Method to calculate and return the mass flow of atoms that are Nickel element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Nickel element, [-]
Method to calculate and return the number of atoms in the flow which are Nihonium, [atoms/s]
Method to calculate and return the mole flow that is Nihonium, [mol/s]
Method to calculate and return the mole fraction that is Nihonium element, [-]
Method to calculate and return the mass flow of atoms that are Nihonium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Nihonium element, [-]
Method to calculate and return the number of atoms in the flow which are Niobium, [atoms/s]
Method to calculate and return the mole flow that is Niobium, [mol/s]
Method to calculate and return the mole fraction that is Niobium element, [-]
Method to calculate and return the mass flow of atoms that are Niobium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Niobium element, [-]
Method to calculate and return the number of atoms in the flow which are Nitrogen, [atoms/s]
Method to calculate and return the mole flow that is Nitrogen, [mol/s]
Method to calculate and return the mole fraction that is Nitrogen element, [-]
Method to calculate and return the mass flow of atoms that are Nitrogen element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Nitrogen element, [-]
Method to calculate and return the number of atoms in the flow which are Nobelium, [atoms/s]
Method to calculate and return the mole flow that is Nobelium, [mol/s]
Method to calculate and return the mole fraction that is Nobelium element, [-]
Method to calculate and return the mass flow of atoms that are Nobelium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Nobelium element, [-]
Method to calculate and return the number of atoms in the flow which are Oganesson, [atoms/s]
Method to calculate and return the mole flow that is Oganesson, [mol/s]
Method to calculate and return the mole fraction that is Oganesson element, [-]
Method to calculate and return the mass flow of atoms that are Oganesson element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Oganesson element, [-]
Method to calculate and return the number of atoms in the flow which are Osmium, [atoms/s]
Method to calculate and return the mole flow that is Osmium, [mol/s]
Method to calculate and return the mole fraction that is Osmium element, [-]
Method to calculate and return the mass flow of atoms that are Osmium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Osmium element, [-]
Method to calculate and return the number of atoms in the flow which are Oxygen, [atoms/s]
Method to calculate and return the mole flow that is Oxygen, [mol/s]
Method to calculate and return the mole fraction that is Oxygen element, [-]
Method to calculate and return the mass flow of atoms that are Oxygen element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Oxygen element, [-]
PIP
()Method to calculate and return the phase identification parameter of the phase.
Method to calculate and return the number of atoms in the flow which are Palladium, [atoms/s]
Method to calculate and return the mole flow that is Palladium, [mol/s]
Method to calculate and return the mole fraction that is Palladium element, [-]
Method to calculate and return the mass flow of atoms that are Palladium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Palladium element, [-]
Method to calculate and return the number of atoms in the flow which are Phosphorus, [atoms/s]
Method to calculate and return the mole flow that is Phosphorus, [mol/s]
Method to calculate and return the mole fraction that is Phosphorus element, [-]
Method to calculate and return the mass flow of atoms that are Phosphorus element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Phosphorus element, [-]
Method to calculate and return the number of atoms in the flow which are Platinum, [atoms/s]
Method to calculate and return the mole flow that is Platinum, [mol/s]
Method to calculate and return the mole fraction that is Platinum element, [-]
Method to calculate and return the mass flow of atoms that are Platinum element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Platinum element, [-]
Method to calculate and return the number of atoms in the flow which are Plutonium, [atoms/s]
Method to calculate and return the mole flow that is Plutonium, [mol/s]
Method to calculate and return the mole fraction that is Plutonium element, [-]
Method to calculate and return the mass flow of atoms that are Plutonium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Plutonium element, [-]
Pmc
([phase])Method to calculate and return the mechanical critical pressure of the phase.
Method to calculate and return the number of atoms in the flow which are Polonium, [atoms/s]
Method to calculate and return the mole flow that is Polonium, [mol/s]
Method to calculate and return the mole fraction that is Polonium element, [-]
Method to calculate and return the mass flow of atoms that are Polonium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Polonium element, [-]
Method to calculate and return the number of atoms in the flow which are Potassium, [atoms/s]
Method to calculate and return the mole flow that is Potassium, [mol/s]
Method to calculate and return the mole fraction that is Potassium element, [-]
Method to calculate and return the mass flow of atoms that are Potassium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Potassium element, [-]
Prandtl
()Method to calculate and return the Prandtl number of the phase
Method to calculate and return the number of atoms in the flow which are Praseodymium, [atoms/s]
Method to calculate and return the mole flow that is Praseodymium, [mol/s]
Method to calculate and return the mole fraction that is Praseodymium element, [-]
Method to calculate and return the mass flow of atoms that are Praseodymium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Praseodymium element, [-]
Method to calculate and return the number of atoms in the flow which are Promethium, [atoms/s]
Method to calculate and return the mole flow that is Promethium, [mol/s]
Method to calculate and return the mole fraction that is Promethium element, [-]
Method to calculate and return the mass flow of atoms that are Promethium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Promethium element, [-]
Method to calculate and return the number of atoms in the flow which are Protactinium, [atoms/s]
Method to calculate and return the mole flow that is Protactinium, [mol/s]
Method to calculate and return the mole fraction that is Protactinium element, [-]
Method to calculate and return the mass flow of atoms that are Protactinium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Protactinium element, [-]
Psats
()Method to calculate and return the pure-component vapor pressures of each species from the
thermo.vapor_pressure.VaporPressure
objects.Psubs
()Method to calculate and return the pure-component sublimation of each species from the
thermo.vapor_pressure.SublimationPressure
objects.Method to calculate and return the number of atoms in the flow which are Radium, [atoms/s]
Method to calculate and return the mole flow that is Radium, [mol/s]
Method to calculate and return the mole fraction that is Radium element, [-]
Method to calculate and return the mass flow of atoms that are Radium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Radium element, [-]
Method to calculate and return the number of atoms in the flow which are Radon, [atoms/s]
Method to calculate and return the mole flow that is Radon, [mol/s]
Method to calculate and return the mole fraction that is Radon element, [-]
Method to calculate and return the mass flow of atoms that are Radon element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Radon element, [-]
Method to calculate and return the number of atoms in the flow which are Rhenium, [atoms/s]
Method to calculate and return the mole flow that is Rhenium, [mol/s]
Method to calculate and return the mole fraction that is Rhenium element, [-]
Method to calculate and return the mass flow of atoms that are Rhenium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Rhenium element, [-]
Method to calculate and return the number of atoms in the flow which are Rhodium, [atoms/s]
Method to calculate and return the mole flow that is Rhodium, [mol/s]
Method to calculate and return the mole fraction that is Rhodium element, [-]
Method to calculate and return the mass flow of atoms that are Rhodium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Rhodium element, [-]
Method to calculate and return the number of atoms in the flow which are Roentgenium, [atoms/s]
Method to calculate and return the mole flow that is Roentgenium, [mol/s]
Method to calculate and return the mole fraction that is Roentgenium element, [-]
Method to calculate and return the mass flow of atoms that are Roentgenium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Roentgenium element, [-]
Method to calculate and return the number of atoms in the flow which are Rubidium, [atoms/s]
Method to calculate and return the mole flow that is Rubidium, [mol/s]
Method to calculate and return the mole fraction that is Rubidium element, [-]
Method to calculate and return the mass flow of atoms that are Rubidium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Rubidium element, [-]
Method to calculate and return the number of atoms in the flow which are Ruthenium, [atoms/s]
Method to calculate and return the mole flow that is Ruthenium, [mol/s]
Method to calculate and return the mole fraction that is Ruthenium element, [-]
Method to calculate and return the mass flow of atoms that are Ruthenium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Ruthenium element, [-]
Method to calculate and return the number of atoms in the flow which are Rutherfordium, [atoms/s]
Method to calculate and return the mole flow that is Rutherfordium, [mol/s]
Method to calculate and return the mole fraction that is Rutherfordium element, [-]
Method to calculate and return the mass flow of atoms that are Rutherfordium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Rutherfordium element, [-]
S
()Method to calculate and return the constant-temperature and constant phase-fraction entropy of the bulk phase.
SG
([phase])Method to calculate and return the standard liquid specific gravity of the phase, using constant liquid pure component densities not calculated by the phase object, at 60 °F.
SG_gas
([phase])Method to calculate and return the specific gravity of the phase with respect to a gas reference density.
S_dep
([phase])Method to calculate and return the difference between the actual S and the ideal-gas entropy of the phase.
S_dep_flow
([phase])Method to return the flow rate of the difference between the ideal-gas entropy of this phase and the actual entropy of the phase This method is only available when the phase is linked to an EquilibriumStream.
Method to calculate and return the mass departure entropy of the phase.
S_flow
([phase])Method to return the flow rate of entropy of this phase.
S_formation_ideal_gas
([phase])Method to calculate and return the ideal-gas entropy of formation of the phase (as if the phase was an ideal gas).
Method to calculate and return the mass ideal-gas formation entropy of the phase.
S_ideal_gas
([phase])Method to calculate and return the ideal-gas entropy of the phase.
Method to calculate and return the mass ideal-gas entropy of the phase.
S_mass
([phase])Method to calculate and return mass entropy of the phase.
Method to calculate and return the constant-temperature and constant phase-fraction reactive entropy of the bulk phase.
Method to calculate and return mass entropy on a reactive basis of the phase.
Method to calculate and return the number of atoms in the flow which are Samarium, [atoms/s]
Method to calculate and return the mole flow that is Samarium, [mol/s]
Method to calculate and return the mole fraction that is Samarium element, [-]
Method to calculate and return the mass flow of atoms that are Samarium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Samarium element, [-]
Method to calculate and return the number of atoms in the flow which are Scandium, [atoms/s]
Method to calculate and return the mole flow that is Scandium, [mol/s]
Method to calculate and return the mole fraction that is Scandium element, [-]
Method to calculate and return the mass flow of atoms that are Scandium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Scandium element, [-]
Method to calculate and return the number of atoms in the flow which are Seaborgium, [atoms/s]
Method to calculate and return the mole flow that is Seaborgium, [mol/s]
Method to calculate and return the mole fraction that is Seaborgium element, [-]
Method to calculate and return the mass flow of atoms that are Seaborgium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Seaborgium element, [-]
Method to calculate and return the number of atoms in the flow which are Selenium, [atoms/s]
Method to calculate and return the mole flow that is Selenium, [mol/s]
Method to calculate and return the mole fraction that is Selenium element, [-]
Method to calculate and return the mass flow of atoms that are Selenium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Selenium element, [-]
Method to calculate and return the number of atoms in the flow which are Silicon, [atoms/s]
Method to calculate and return the mole flow that is Silicon, [mol/s]
Method to calculate and return the mole fraction that is Silicon element, [-]
Method to calculate and return the mass flow of atoms that are Silicon element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Silicon element, [-]
Method to calculate and return the number of atoms in the flow which are Silver, [atoms/s]
Method to calculate and return the mole flow that is Silver, [mol/s]
Method to calculate and return the mole fraction that is Silver element, [-]
Method to calculate and return the mass flow of atoms that are Silver element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Silver element, [-]
Method to calculate and return the number of atoms in the flow which are Sodium, [atoms/s]
Method to calculate and return the mole flow that is Sodium, [mol/s]
Method to calculate and return the mole fraction that is Sodium element, [-]
Method to calculate and return the mass flow of atoms that are Sodium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Sodium element, [-]
Method to calculate and return the number of atoms in the flow which are Strontium, [atoms/s]
Method to calculate and return the mole flow that is Strontium, [mol/s]
Method to calculate and return the mole fraction that is Strontium element, [-]
Method to calculate and return the mass flow of atoms that are Strontium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Strontium element, [-]
Method to calculate and return the number of atoms in the flow which are Sulfur, [atoms/s]
Method to calculate and return the mole flow that is Sulfur, [mol/s]
Method to calculate and return the mole fraction that is Sulfur element, [-]
Method to calculate and return the mass flow of atoms that are Sulfur element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Sulfur element, [-]
Method to calculate and return the number of atoms in the flow which are Tantalum, [atoms/s]
Method to calculate and return the mole flow that is Tantalum, [mol/s]
Method to calculate and return the mole fraction that is Tantalum element, [-]
Method to calculate and return the mass flow of atoms that are Tantalum element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Tantalum element, [-]
Method to calculate and return the number of atoms in the flow which are Technetium, [atoms/s]
Method to calculate and return the mole flow that is Technetium, [mol/s]
Method to calculate and return the mole fraction that is Technetium element, [-]
Method to calculate and return the mass flow of atoms that are Technetium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Technetium element, [-]
Method to calculate and return the number of atoms in the flow which are Tellurium, [atoms/s]
Method to calculate and return the mole flow that is Tellurium, [mol/s]
Method to calculate and return the mole fraction that is Tellurium element, [-]
Method to calculate and return the mass flow of atoms that are Tellurium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Tellurium element, [-]
Method to calculate and return the number of atoms in the flow which are Tennessine, [atoms/s]
Method to calculate and return the mole flow that is Tennessine, [mol/s]
Method to calculate and return the mole fraction that is Tennessine element, [-]
Method to calculate and return the mass flow of atoms that are Tennessine element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Tennessine element, [-]
Method to calculate and return the number of atoms in the flow which are Terbium, [atoms/s]
Method to calculate and return the mole flow that is Terbium, [mol/s]
Method to calculate and return the mole fraction that is Terbium element, [-]
Method to calculate and return the mass flow of atoms that are Terbium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Terbium element, [-]
Method to calculate and return the number of atoms in the flow which are Thallium, [atoms/s]
Method to calculate and return the mole flow that is Thallium, [mol/s]
Method to calculate and return the mole fraction that is Thallium element, [-]
Method to calculate and return the mass flow of atoms that are Thallium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Thallium element, [-]
Method to calculate and return the number of atoms in the flow which are Thorium, [atoms/s]
Method to calculate and return the mole flow that is Thorium, [mol/s]
Method to calculate and return the mole fraction that is Thorium element, [-]
Method to calculate and return the mass flow of atoms that are Thorium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Thorium element, [-]
Method to calculate and return the number of atoms in the flow which are Thulium, [atoms/s]
Method to calculate and return the mole flow that is Thulium, [mol/s]
Method to calculate and return the mole fraction that is Thulium element, [-]
Method to calculate and return the mass flow of atoms that are Thulium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Thulium element, [-]
Method to calculate and return the number of atoms in the flow which are Tin, [atoms/s]
Method to calculate and return the mole flow that is Tin, [mol/s]
Method to calculate and return the mole fraction that is Tin element, [-]
Method to calculate and return the mass flow of atoms that are Tin element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Tin element, [-]
Method to calculate and return the number of atoms in the flow which are Titanium, [atoms/s]
Method to calculate and return the mole flow that is Titanium, [mol/s]
Method to calculate and return the mole fraction that is Titanium element, [-]
Method to calculate and return the mass flow of atoms that are Titanium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Titanium element, [-]
Tmc
([phase])Method to calculate and return the mechanical critical temperature of the phase.
Method to calculate and return the number of atoms in the flow which are Tungsten, [atoms/s]
Method to calculate and return the mole flow that is Tungsten, [mol/s]
Method to calculate and return the mole fraction that is Tungsten element, [-]
Method to calculate and return the mass flow of atoms that are Tungsten element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Tungsten element, [-]
U
()Method to calculate and return the internal energy of the phase.
U_dep
()Method to calculate and return the departure internal energy of the phase.
U_dep_flow
([phase])Method to return the flow rate of the difference between the ideal-gas internal energy of this phase and the actual internal energy of the phase This method is only available when the phase is linked to an EquilibriumStream.
Method to calculate and return the departure mass internal energy of the phase.
U_flow
([phase])Method to return the flow rate of internal energy of this phase.
U_formation_ideal_gas
([phase])Method to calculate and return the ideal-gas internal energy of formation of the phase (as if the phase was an ideal gas).
Method to calculate and return the ideal-gas formation mass internal energy of the phase.
U_ideal_gas
([phase])Method to calculate and return the ideal-gas internal energy of the phase.
Method to calculate and return the mass ideal-gas internal energy of the phase.
U_mass
([phase])Method to calculate and return mass internal energy of the phase.
Method to calculate and return the internal energy of the phase on a reactive basis.
Method to calculate and return mass internal energy on a reactive basis of the phase.
Method to calculate and return the number of atoms in the flow which are Uranium, [atoms/s]
Method to calculate and return the mole flow that is Uranium, [mol/s]
Method to calculate and return the mole fraction that is Uranium element, [-]
Method to calculate and return the mass flow of atoms that are Uranium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Uranium element, [-]
V
()Method to calculate and return the molar volume of the bulk phase.
V_dep
()Method to calculate and return the departure (from ideal gas behavior) molar volume of the phase.
V_gas
([phase])Method to calculate and return the ideal-gas molar volume of the phase at the chosen reference temperature and pressure, according to the temperature variable T_gas_ref and pressure variable P_gas_ref of the
thermo.bulk.BulkSettings
.V_gas_normal
([phase])Method to calculate and return the ideal-gas molar volume of the phase at the normal temperature and pressure, according to the temperature variable T_normal and pressure variable P_normal of the
thermo.bulk.BulkSettings
.V_gas_standard
([phase])Method to calculate and return the ideal-gas molar volume of the phase at the standard temperature and pressure, according to the temperature variable T_standard and pressure variable P_standard of the
thermo.bulk.BulkSettings
.V_ideal_gas
([phase])Method to calculate and return the ideal-gas molar volume of the phase.
V_iter
([phase, force])Method to calculate and return the volume of the phase in a way suitable for a TV resolution to converge on the same pressure.
V_liquid_ref
([phase])Method to calculate and return the liquid reference molar volume according to the temperature variable T_liquid_volume_ref of
thermo.bulk.BulkSettings
and the composition of the phase.Method to calculate and return the liquid reference molar volumes according to the temperature variable T_liquid_volume_ref of
thermo.bulk.BulkSettings
.V_mass
([phase])Method to calculate and return the specific volume of the phase.
Method to calculate and return the number of atoms in the flow which are Vanadium, [atoms/s]
Method to calculate and return the mole flow that is Vanadium, [mol/s]
Method to calculate and return the mole fraction that is Vanadium element, [-]
Method to calculate and return the mass flow of atoms that are Vanadium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Vanadium element, [-]
Vfgs
([phase])Method to calculate and return the ideal-gas volume fractions of the components of the phase.
Vfls
([phase])Method to calculate and return the ideal-liquid volume fractions of the components of the phase, using the standard liquid densities at the temperature variable T_liquid_volume_ref of
thermo.bulk.BulkSettings
and the composition of the phase.Vls
()Method to calculate and return the pure-component liquid temperature-dependent molar volume of each species from the
thermo.volume.VolumeLiquid
objects.Vmc
([phase])Method to calculate and return the mechanical critical volume of the phase.
Vss
()Method to calculate and return the pure-component solid temperature-dependent molar volume of each species from the
thermo.volume.VolumeSolid
objects.Wobbe_index
([phase])Method to calculate and return the molar Wobbe index of the object, [J/mol].
Wobbe_index_lower
([phase])Method to calculate and return the molar lower Wobbe index of the
Wobbe_index_lower_mass
([phase])Method to calculate and return the lower mass Wobbe index of the object, [J/kg].
Wobbe_index_lower_normal
([phase])Method to calculate and return the volumetric normal lower Wobbe index of the object, [J/m^3].
Wobbe_index_lower_standard
([phase])Method to calculate and return the volumetric standard lower Wobbe index of the object, [J/m^3].
Wobbe_index_mass
([phase])Method to calculate and return the mass Wobbe index of the object, [J/kg].
Wobbe_index_normal
([phase])Method to calculate and return the volumetric normal Wobbe index of the object, [J/m^3].
Wobbe_index_standard
([phase])Method to calculate and return the volumetric standard Wobbe index of the object, [J/m^3].
Method to calculate and return the number of atoms in the flow which are Xenon, [atoms/s]
Method to calculate and return the mole flow that is Xenon, [mol/s]
Method to calculate and return the mole fraction that is Xenon element, [-]
Method to calculate and return the mass flow of atoms that are Xenon element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Xenon element, [-]
Method to calculate and return the number of atoms in the flow which are Ytterbium, [atoms/s]
Method to calculate and return the mole flow that is Ytterbium, [mol/s]
Method to calculate and return the mole fraction that is Ytterbium element, [-]
Method to calculate and return the mass flow of atoms that are Ytterbium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Ytterbium element, [-]
Method to calculate and return the number of atoms in the flow which are Yttrium, [atoms/s]
Method to calculate and return the mole flow that is Yttrium, [mol/s]
Method to calculate and return the mole fraction that is Yttrium element, [-]
Method to calculate and return the mass flow of atoms that are Yttrium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Yttrium element, [-]
Z
()Method to calculate and return the compressibility factor of the phase.
Method to calculate and return the number of atoms in the flow which are Zinc, [atoms/s]
Method to calculate and return the mole flow that is Zinc, [mol/s]
Method to calculate and return the mole fraction that is Zinc element, [-]
Method to calculate and return the mass flow of atoms that are Zinc element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Zinc element, [-]
Method to calculate and return the number of atoms in the flow which are Zirconium, [atoms/s]
Method to calculate and return the mole flow that is Zirconium, [mol/s]
Method to calculate and return the mole fraction that is Zirconium element, [-]
Method to calculate and return the mass flow of atoms that are Zirconium element, [kg/s]
Method to calculate and return the mass fraction of the phase that is Zirconium element, [-]
Zmc
([phase])Method to calculate and return the mechanical critical compressibility of the phase.
alpha
()Method to calculate and return the thermal diffusivity of the phase.
Method to calculate and return the effective quantiy of ammonia in the phase as a molar weight, [g/mol].
Method to calculate and return the ideal partial pressure of ammonia, [Pa]
Method to calculate and return the effective quantiy of argon in the phase as a molar weight, [g/mol].
Method to calculate and return the ideal partial pressure of argon, [Pa]
atom_content
([phase])Method to calculate and return the number of moles of each atom in the phase per mole of the phase; returns a dictionary of atom counts, containing only those elements who are present.
atom_count_flows
([phase])Method to calculate and return the atom count flow rates of the phase; returns a dictionary of atom count flows, containing only those elements who are present.
atom_flows
([phase])Method to calculate and return the atomic flow rates of the phase; returns a dictionary of atom flows, containing only those elements who are present.
atom_fractions
([phase])Method to calculate and return the atomic composition of the phase; returns a dictionary of atom fraction (by count), containing only those elements who are present.
atom_mass_flows
([phase])Method to calculate and return the atomic mass flow rates of the phase; returns a dictionary of atom mass flows, containing only those elements who are present.
atom_mass_fractions
([phase])Method to calculate and return the atomic mass fractions of the phase; returns a dictionary of atom fraction (by mass), containing only those elements who arxe present.
Method to calculate and return the effective quantiy of carbon_dioxide in the phase as a molar weight, [g/mol].
Method to calculate and return the ideal partial pressure of carbon_dioxide, [Pa]
Method to return the molar concentrations of each component in the phase in units of mol/m^3.
Method to return the molar concentrations of each component in the phase in units of mol/m^3, using the ideal-gas molar volume of the phase at the chosen reference temperature and pressure.
Method to return the molar concentrations of each component in the phase in units of mol/m^3, using the ideal-gas molar volume of the phase at the normal temperature and pressure.
Method to return the molar concentrations of each component in the phase in units of mol/m^3, using the ideal-gas molar volume of the phase at the standard temperature and pressure.
Method to return the mass concentrations of each component in the phase in units of kg/m^3.
Method to return the mass concentrations of each component in the phase in units of kg/m^3, using the ideal-gas molar volume of the phase at the chosen reference temperature and pressure.
Method to return the mass concentrations of each component in the phase in units of kg/m^3, using the ideal-gas molar volume of the phase at the normal temperature and pressure.
Method to return the mass concentrations of each component in the phase in units of kg/m^3, using the ideal-gas molar volume of the phase at the standard temperature and pressure.
d2P_dT2
()Method to calculate and return the second temperature derivative of pressure of the bulk according to the selected calculation methodology.
Method to calculate and return the second constant-volume derivative of pressure with respect to temperature of the bulk phase, at constant phase fractions and phase compositions.
d2P_dTdV
()Method to calculate and return the second derivative of pressure with respect to temperature and volume of the bulk according to the selected calculation methodology.
Method to calculate and return the second derivative of pressure with respect to volume and temperature of the bulk phase, at constant phase fractions and phase compositions.
d2P_dV2
()Method to calculate and return the second volume derivative of pressure of the bulk according to the selected calculation methodology.
Method to calculate and return the constant-temperature second derivative of pressure with respect to volume of the bulk phase, at constant phase fractions and phase compositions.
dA_dP
()Method to calculate and return the constant-temperature pressure derivative of Helmholtz energy.
dA_dP_T
()Method to calculate and return the constant-temperature pressure derivative of Helmholtz energy.
dA_dP_V
()Method to calculate and return the constant-volume pressure derivative of Helmholtz energy.
dA_dT
()Method to calculate and return the constant-pressure temperature derivative of Helmholtz energy.
dA_dT_P
()Method to calculate and return the constant-pressure temperature derivative of Helmholtz energy.
dA_dT_V
()Method to calculate and return the constant-volume temperature derivative of Helmholtz energy.
dA_dV_P
()Method to calculate and return the constant-pressure volume derivative of Helmholtz energy.
dA_dV_T
()Method to calculate and return the constant-temperature volume derivative of Helmholtz energy.
Method to calculate and return the pressure derivative of mass Helmholtz energy of the phase at constant temperature.
Method to calculate and return the pressure derivative of mass Helmholtz energy of the phase at constant temperature.
Method to calculate and return the pressure derivative of mass Helmholtz energy of the phase at constant volume.
Method to calculate and return the temperature derivative of mass Helmholtz energy of the phase at constant pressure.
Method to calculate and return the temperature derivative of mass Helmholtz energy of the phase at constant pressure.
Method to calculate and return the temperature derivative of mass Helmholtz energy of the phase at constant volume.
Method to calculate and return the volume derivative of mass Helmholtz energy of the phase at constant pressure.
Method to calculate and return the volume derivative of mass Helmholtz energy of the phase at constant temperature.
dCv_dP_T
()Method to calculate the pressure derivative of Cv, constant volume heat capacity, at constant temperature.
dCv_dT_P
()Method to calculate the temperature derivative of Cv, constant volume heat capacity, at constant pressure.
Method to calculate and return the pressure derivative of mass Constant-volume heat capacity of the phase at constant temperature.
Method to calculate and return the temperature derivative of mass Constant-volume heat capacity of the phase at constant pressure.
dG_dP
()Method to calculate and return the constant-temperature pressure derivative of Gibbs free energy.
dG_dP_T
()Method to calculate and return the constant-temperature pressure derivative of Gibbs free energy.
dG_dP_V
()Method to calculate and return the constant-volume pressure derivative of Gibbs free energy.
dG_dT
()Method to calculate and return the constant-pressure temperature derivative of Gibbs free energy.
dG_dT_P
()Method to calculate and return the constant-pressure temperature derivative of Gibbs free energy.
dG_dT_V
()Method to calculate and return the constant-volume temperature derivative of Gibbs free energy.
dG_dV_P
()Method to calculate and return the constant-pressure volume derivative of Gibbs free energy.
dG_dV_T
()Method to calculate and return the constant-temperature volume derivative of Gibbs free energy.
Method to calculate and return the pressure derivative of mass Gibbs free energy of the phase at constant temperature.
Method to calculate and return the pressure derivative of mass Gibbs free energy of the phase at constant temperature.
Method to calculate and return the pressure derivative of mass Gibbs free energy of the phase at constant volume.
Method to calculate and return the temperature derivative of mass Gibbs free energy of the phase at constant pressure.
Method to calculate and return the temperature derivative of mass Gibbs free energy of the phase at constant pressure.
Method to calculate and return the temperature derivative of mass Gibbs free energy of the phase at constant volume.
Method to calculate and return the volume derivative of mass Gibbs free energy of the phase at constant pressure.
Method to calculate and return the volume derivative of mass Gibbs free energy of the phase at constant temperature.
dH_dP
()Method to calculate and return the pressure derivative of enthalpy of the phase at constant pressure.
dH_dP_T
()Method to calculate and return the pressure derivative of enthalpy of the phase at constant pressure.
dH_dT
()Method to calculate and return the constant-temperature and constant phase-fraction heat capacity of the bulk phase.
dH_dT_P
()Method to calculate and return the temperature derivative of enthalpy of the phase at constant pressure.
Method to calculate and return the pressure derivative of mass enthalpy of the phase at constant temperature.
Method to calculate and return the pressure derivative of mass enthalpy of the phase at constant temperature.
Method to calculate and return the pressure derivative of mass enthalpy of the phase at constant volume.
Method to calculate and return the temperature derivative of mass enthalpy of the phase at constant pressure.
Method to calculate and return the temperature derivative of mass enthalpy of the phase at constant pressure.
Method to calculate and return the temperature derivative of mass enthalpy of the phase at constant volume.
Method to calculate and return the volume derivative of mass enthalpy of the phase at constant pressure.
Method to calculate and return the volume derivative of mass enthalpy of the phase at constant temperature.
dP_dT
()Method to calculate and return the first temperature derivative of pressure of the bulk according to the selected calculation methodology.
dP_dT_A
()Method to calculate and return the temperature derivative of pressure of the phase at constant Helmholtz energy.
dP_dT_G
()Method to calculate and return the temperature derivative of pressure of the phase at constant Gibbs energy.
dP_dT_H
()Method to calculate and return the temperature derivative of pressure of the phase at constant enthalpy.
dP_dT_S
()Method to calculate and return the temperature derivative of pressure of the phase at constant entropy.
dP_dT_U
()Method to calculate and return the temperature derivative of pressure of the phase at constant internal energy.
Method to calculate and return the constant-volume derivative of pressure with respect to temperature of the bulk phase, at constant phase fractions and phase compositions.
dP_dV
()Method to calculate and return the first volume derivative of pressure of the bulk according to the selected calculation methodology.
dP_dV_A
()Method to calculate and return the volume derivative of pressure of the phase at constant Helmholtz energy.
dP_dV_G
()Method to calculate and return the volume derivative of pressure of the phase at constant Gibbs energy.
dP_dV_H
()Method to calculate and return the volume derivative of pressure of the phase at constant enthalpy.
dP_dV_S
()Method to calculate and return the volume derivative of pressure of the phase at constant entropy.
dP_dV_U
()Method to calculate and return the volume derivative of pressure of the phase at constant internal energy.
Method to calculate and return the constant-temperature derivative of pressure with respect to volume of the bulk phase, at constant phase fractions and phase compositions.
Method to calculate and return the density derivative of pressure of the phase at constant Helmholtz energy.
Method to calculate and return the density derivative of pressure of the phase at constant Gibbs energy.
Method to calculate and return the density derivative of pressure of the phase at constant enthalpy.
Method to calculate and return the density derivative of pressure of the phase at constant entropy.
Method to calculate and return the density derivative of pressure of the phase at constant internal energy.
dS_dP
()Method to calculate and return the pressure derivative of entropy of the phase at constant pressure.
dS_dP_T
()Method to calculate and return the pressure derivative of entropy of the phase at constant pressure.
dS_dV_P
()Method to calculate and return the volume derivative of entropy of the phase at constant pressure.
dS_dV_T
()Method to calculate and return the volume derivative of entropy of the phase at constant temperature.
Method to calculate and return the pressure derivative of mass entropy of the phase at constant temperature.
Method to calculate and return the pressure derivative of mass entropy of the phase at constant temperature.
Method to calculate and return the pressure derivative of mass entropy of the phase at constant volume.
Method to calculate and return the temperature derivative of mass entropy of the phase at constant pressure.
Method to calculate and return the temperature derivative of mass entropy of the phase at constant pressure.
Method to calculate and return the temperature derivative of mass entropy of the phase at constant volume.
Method to calculate and return the volume derivative of mass entropy of the phase at constant pressure.
Method to calculate and return the volume derivative of mass entropy of the phase at constant temperature.
dT_dP_A
()Method to calculate and return the pressure derivative of temperature of the phase at constant Helmholtz energy.
dT_dP_G
()Method to calculate and return the pressure derivative of temperature of the phase at constant Gibbs energy.
dT_dP_H
()Method to calculate and return the pressure derivative of temperature of the phase at constant enthalpy.
dT_dP_S
()Method to calculate and return the pressure derivative of temperature of the phase at constant entropy.
dT_dP_U
()Method to calculate and return the pressure derivative of temperature of the phase at constant internal energy.
dT_dV_A
()Method to calculate and return the volume derivative of temperature of the phase at constant Helmholtz energy.
dT_dV_G
()Method to calculate and return the volume derivative of temperature of the phase at constant Gibbs energy.
dT_dV_H
()Method to calculate and return the volume derivative of temperature of the phase at constant enthalpy.
dT_dV_S
()Method to calculate and return the volume derivative of temperature of the phase at constant entropy.
dT_dV_U
()Method to calculate and return the volume derivative of temperature of the phase at constant internal energy.
Method to calculate and return the density derivative of temperature of the phase at constant Helmholtz energy.
Method to calculate and return the density derivative of temperature of the phase at constant Gibbs energy.
Method to calculate and return the density derivative of temperature of the phase at constant enthalpy.
Method to calculate and return the density derivative of temperature of the phase at constant entropy.
Method to calculate and return the density derivative of temperature of the phase at constant internal energy.
dU_dP
()Method to calculate and return the constant-temperature pressure derivative of internal energy.
dU_dP_T
()Method to calculate and return the constant-temperature pressure derivative of internal energy.
dU_dP_V
()Method to calculate and return the constant-volume pressure derivative of internal energy.
dU_dT
()Method to calculate and return the constant-pressure temperature derivative of internal energy.
dU_dT_P
()Method to calculate and return the constant-pressure temperature derivative of internal energy.
dU_dT_V
()Method to calculate and return the constant-volume temperature derivative of internal energy.
dU_dV_P
()Method to calculate and return the constant-pressure volume derivative of internal energy.
dU_dV_T
()Method to calculate and return the constant-temperature volume derivative of internal energy.
Method to calculate and return the pressure derivative of mass internal energy of the phase at constant temperature.
Method to calculate and return the pressure derivative of mass internal energy of the phase at constant temperature.
Method to calculate and return the pressure derivative of mass internal energy of the phase at constant volume.
Method to calculate and return the temperature derivative of mass internal energy of the phase at constant pressure.
Method to calculate and return the temperature derivative of mass internal energy of the phase at constant pressure.
Method to calculate and return the temperature derivative of mass internal energy of the phase at constant volume.
Method to calculate and return the volume derivative of mass internal energy of the phase at constant pressure.
Method to calculate and return the volume derivative of mass internal energy of the phase at constant temperature.
dV_dP_A
()Method to calculate and return the pressure derivative of volume of the phase at constant Helmholtz energy.
dV_dP_G
()Method to calculate and return the pressure derivative of volume of the phase at constant Gibbs energy.
dV_dP_H
()Method to calculate and return the pressure derivative of volume of the phase at constant enthalpy.
dV_dP_S
()Method to calculate and return the pressure derivative of volume of the phase at constant entropy.
dV_dP_U
()Method to calculate and return the pressure derivative of volume of the phase at constant internal energy.
dV_dT_A
()Method to calculate and return the temperature derivative of volume of the phase at constant Helmholtz energy.
dV_dT_G
()Method to calculate and return the temperature derivative of volume of the phase at constant Gibbs energy.
dV_dT_H
()Method to calculate and return the temperature derivative of volume of the phase at constant enthalpy.
dV_dT_S
()Method to calculate and return the temperature derivative of volume of the phase at constant entropy.
dV_dT_U
()Method to calculate and return the temperature derivative of volume of the phase at constant internal energy.
Method to calculate and return the density derivative of volume of the phase at constant Helmholtz energy.
Method to calculate and return the density derivative of volume of the phase at constant Gibbs energy.
Method to calculate and return the density derivative of volume of the phase at constant enthalpy.
Method to calculate and return the density derivative of volume of the phase at constant entropy.
Method to calculate and return the density derivative of volume of the phase at constant internal energy.
Method to calculate and return the pressure derivative of density of the phase at constant Helmholtz energy.
Method to calculate and return the pressure derivative of density of the phase at constant Gibbs energy.
Method to calculate and return the pressure derivative of density of the phase at constant enthalpy.
Method to calculate and return the pressure derivative of density of the phase at constant entropy.
Method to calculate and return the pressure derivative of density of the phase at constant internal energy.
Method to calculate and return the temperature derivative of density of the phase at constant Helmholtz energy.
Method to calculate and return the temperature derivative of density of the phase at constant Gibbs energy.
Method to calculate and return the temperature derivative of density of the phase at constant enthalpy.
Method to calculate and return the temperature derivative of density of the phase at constant entropy.
Method to calculate and return the temperature derivative of density of the phase at constant internal energy.
Method to calculate and return the volume derivative of density of the phase at constant Helmholtz energy.
Method to calculate and return the volume derivative of density of the phase at constant Gibbs energy.
Method to calculate and return the volume derivative of density of the phase at constant enthalpy.
Method to calculate and return the volume derivative of density of the phase at constant entropy.
Method to calculate and return the volume derivative of density of the phase at constant internal energy.
Method to calculate and return the effective quantiy of helium in the phase as a molar weight, [g/mol].
Method to calculate and return the ideal partial pressure of helium, [Pa]
humidity_ratio
([phase])Method to calculate and return the humidity ratio of the phase; normally defined as the kg water/kg dry air, the definition here is kg water/(kg rest of the phase) [-]
Method to calculate and return the effective quantiy of hydrogen in the phase as a molar weight, [g/mol].
Method to calculate and return the ideal partial pressure of hydrogen, [Pa]
Method to calculate and return the effective quantiy of hydrogen_sulfide in the phase as a molar weight, [g/mol].
Method to calculate and return the ideal partial pressure of hydrogen_sulfide, [Pa]
Method to calculate and return the real gas isentropic exponent of the phase, which satisfies the relationship .
Method to calculate and return the real gas isentropic exponent of the phase, which satisfies the relationship .
Method to calculate and return the real gas isentropic exponent of the phase, which satisfies the relationship .
Method to calculate and return the real gas isentropic exponent of the phase, which satisfies the relationship .
Method to calculate and return the isobatic expansion coefficient of the bulk according to the selected calculation methodology.
Method to calculate and return the isothermal bulk modulus of the phase.
k
()Calculate and return the thermal conductivity of the bulk according to the selected thermal conductivity settings in
BulkSettings
, the settings inThermalConductivityGasMixture
andThermalConductivityLiquidMixture
, and the configured pure-component settings inThermalConductivityGas
andThermalConductivityLiquid
.kappa
()Method to calculate and return the isothermal compressibility of the bulk according to the selected calculation methodology.
kgs
()Method to calculate and return the pure-component gas temperature-dependent thermal conductivity of each species from the
thermo.thermal_conductivity.ThermalConductivityGas
objects.Method to calculate and return the kinematic viscosity of the phase, [m^2/s]
kls
()Method to calculate and return the pure-component liquid temperature-dependent thermal conductivity of each species from the
thermo.thermal_conductivity.ThermalConductivityLiquid
objects.kss
()Method to calculate and return the pure-component solid temperature-dependent thermal conductivity of each species from the
thermo.thermal_conductivity.ThermalConductivitySolid
objects.log_zs
()Method to calculate and return the log of mole fractions specified.
m
()Method to return the mass flow rate of this phase.
Method to calculate and return the effective quantiy of methane in the phase as a molar weight, [g/mol].
Method to calculate and return the ideal partial pressure of methane, [Pa]
ms
()Method to return the mass flow rates of each component in this phase.
mu
()Calculate and return the viscosity of the bulk according to the selected viscosity settings in
BulkSettings
, the settings inViscosityGasMixture
andViscosityLiquidMixture
, and the configured pure-component settings inViscosityGas
andViscosityLiquid
.mugs
()Method to calculate and return the pure-component gas temperature-dependent viscosity of each species from the
thermo.viscosity.ViscosityGas
objects.muls
()Method to calculate and return the pure-component liquid temperature-dependent viscosity of each species from the
thermo.viscosity.ViscosityLiquid
objects.n
()Method to return the molar flow rate of this phase.
Method to calculate and return the effective quantiy of nitrogen in the phase as a molar weight, [g/mol].
Method to calculate and return the ideal partial pressure of nitrogen, [Pa]
ns
()Method to return the molar flow rates of each component in this phase.
nu
()Method to calculate and return the kinematic viscosity of the phase, [m^2/s]
Method to calculate and return the effective quantiy of oxygen in the phase as a molar weight, [g/mol].
Method to calculate and return the ideal partial pressure of oxygen, [Pa]
Method to return the partial pressures of each component in the phase.
pseudo_Pc
([phase])Method to calculate and return the pseudocritical pressure calculated using Kay's rule (linear mole fractions):
pseudo_Tc
([phase])Method to calculate and return the pseudocritical temperature calculated using Kay's rule (linear mole fractions):
pseudo_Vc
([phase])Method to calculate and return the pseudocritical volume calculated using Kay's rule (linear mole fractions):
pseudo_Zc
([phase])Method to calculate and return the pseudocritical compressibility calculated using Kay's rule (linear mole fractions):
pseudo_omega
([phase])Method to calculate and return the pseudocritical acentric factor calculated using Kay's rule (linear mole fractions):
rho
()Method to calculate and return the molar density of the phase.
rho_gas
([phase])Method to calculate and return the ideal-gas molar density of the phase at the chosen reference temperature and pressure, according to the temperature variable T_gas_ref and pressure variable P_gas_ref of the
thermo.bulk.BulkSettings
.rho_gas_normal
([phase])Method to calculate and return the ideal-gas molar density of the phase at the normal temperature and pressure, according to the temperature variable T_normal and pressure variable P_normal of the
thermo.bulk.BulkSettings
.rho_gas_standard
([phase])Method to calculate and return the ideal-gas molar density of the phase at the standard temperature and pressure, according to the temperature variable T_standard and pressure variable P_standard of the
thermo.bulk.BulkSettings
.rho_mass
([phase])Method to calculate and return mass density of the phase.
rho_mass_gas
([phase])Method to calculate and return the ideal-gas mass density of the phase at the chosen reference temperature and pressure, according to the temperature variable T_gas_ref and pressure variable P_gas_ref of the
thermo.bulk.BulkSettings
.rho_mass_gas_normal
([phase])Method to calculate and return the ideal-gas mass density of the phase at the normal temperature and pressure, according to the temperature variable T_normal and pressure variable P_normal of the
thermo.bulk.BulkSettings
.rho_mass_gas_standard
([phase])Method to calculate and return the ideal-gas mass density of the phase at the standard temperature and pressure, according to the temperature variable T_standard and pressure variable P_standard of the
thermo.bulk.BulkSettings
.rho_mass_liquid_ref
([phase])Method to calculate and return the liquid reference mass density according to the temperature variable T_liquid_volume_ref of
thermo.bulk.BulkSettings
and the composition of the phase.sigma
()Calculate and return the surface tension of the bulk according to the selected surface tension settings in
BulkSettings
, the settings inSurfaceTensionMixture
and the configured pure-component settings inSurfaceTension
.sigmas
()Method to calculate and return the pure-component surface tensions of each species from the
thermo.interface.SurfaceTension
objects.Method to calculate and return the molar speed of sound of the bulk according to the selected calculation methodology.
Method to calculate and return the molar speed of sound of an ideal gas phase at the current conditions.
Method to calculate and return the mass speed of sound of an ideal gas phase at the current conditions.
Method to calculate and return the speed of sound of the phase.
Method to calculate and return the thermal diffusivity of the phase.
value
(name[, phase])Method to retrieve a property from a string.
Method to calculate and return the effective quantiy of water in the phase as a molar weight, [g/mol].
Method to calculate and return the ideal partial pressure of water, [Pa]
ws
([phase])Method to calculate and return the mass fractions of the phase, [-]
ws_no_water
([phase])Method to calculate and return the mass fractions of all species in the phase, normalized to a water-free basis (the mass fraction of water returned is zero).
zs_no_water
([phase])Method to calculate and return the mole fractions of all species in the phase, normalized to a water-free basis (the mole fraction of water returned is zero).
B_from_Z
G_ideal_gas_standard_state
Gs_ideal_gas_standard_state
H_ideal_gas_standard_state
Hs_ideal_gas_standard_state
S_ideal_gas_standard_state
Ss_ideal_gas_standard_state
activities
as_json
d2G_dP2
d2G_dPdT
d2G_dT2
d2G_dTdP
d2G_mass_dP2
d2G_mass_dPdT
d2G_mass_dT2
d2G_mass_dTdP
dfugacities_dP
dfugacities_dT
dlnphis_dP
dlnphis_dT
dlnphis_dns
dphis_dP
dphis_dT
dphis_dzs
from_json
fugacities
lnphis
phis
- A()¶
Method to calculate and return the Helmholtz energy of the phase.
- Returns
- A
float
Helmholtz energy, [J/mol]
- A
- API(phase=None)[source]¶
Method to calculate and return the API of the phase.
- Returns
- API
float
API of the fluid [-]
- API
- A_dep()¶
Method to calculate and return the departure Helmholtz energy of the phase.
- Returns
- A_dep
float
Departure Helmholtz energy, [J/mol]
- A_dep
- A_dep_flow(phase=None)[source]¶
Method to return the flow rate of the difference between the ideal-gas Helmholtz energy of this phase and the Helmholtz energy of the phase This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- A_dep_flow
float
Flow rate of departure Helmholtz energy, [J/s]
- A_dep_flow
- A_dep_mass()¶
Method to calculate and return the departure mass Helmholtz energy of the phase.
- Returns
- A_dep_mass
float
Departure mass Helmholtz energy, [J/kg]
- A_dep_mass
- A_flow(phase=None)[source]¶
Method to return the flow rate of Helmholtz energy of this phase. This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- A_flow
float
Flow rate of Helmholtz energy, [J/s]
- A_flow
- A_formation_ideal_gas(phase=None)[source]¶
Method to calculate and return the ideal-gas Helmholtz energy of formation of the phase (as if the phase was an ideal gas).
- Returns
- A_formation_ideal_gas
float
Helmholtz energy of formation of the phase on a reactive basis as an ideal gas, [J/(mol)]
- A_formation_ideal_gas
- A_formation_ideal_gas_mass()¶
Method to calculate and return the ideal-gas formation mass Helmholtz energy of the phase.
- Returns
- A_formation_ideal_gas_mass
float
Formation mass Helmholtz energy, [J/kg]
- A_formation_ideal_gas_mass
- A_ideal_gas(phase=None)[source]¶
Method to calculate and return the ideal-gas Helmholtz energy of the phase.
- Returns
- A_ideal_gas
float
Ideal gas Helmholtz free energy, [J/(mol)]
- A_ideal_gas
- A_ideal_gas_mass()¶
Method to calculate and return the mass ideal-gas Helmholtz energy of the phase.
- Returns
- A_ideal_gas_mass
float
Ideal gas mass Helmholtz free energy, [J/(kg)]
- A_ideal_gas_mass
- A_mass(phase=None)[source]¶
Method to calculate and return mass Helmholtz energy of the phase.
- Returns
- A_mass
float
Mass Helmholtz energy, [J/(kg)]
- A_mass
- A_reactive()¶
Method to calculate and return the Helmholtz free energy of the phase on a reactive basis.
- Returns
- A_reactive
float
Helmholtz free energy of the phase on a reactive basis, [J/(mol)]
- A_reactive
- A_reactive_mass()¶
Method to calculate and return mass Helmholtz energy on a reactive basis of the phase.
- Returns
- A_reactive_mass
float
Mass Helmholtz energy on a reactive basis, [J/kg]
- A_reactive_mass
- Actinium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Actinium, [atoms/s]
- Actinium_atom_flow()¶
Method to calculate and return the mole flow that is Actinium, [mol/s]
- Actinium_atom_fraction()¶
Method to calculate and return the mole fraction that is Actinium element, [-]
- Actinium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Actinium element, [kg/s]
- Actinium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Actinium element, [-]
- Aluminium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Aluminium, [atoms/s]
- Aluminium_atom_flow()¶
Method to calculate and return the mole flow that is Aluminium, [mol/s]
- Aluminium_atom_fraction()¶
Method to calculate and return the mole fraction that is Aluminium element, [-]
- Aluminium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Aluminium element, [kg/s]
- Aluminium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Aluminium element, [-]
- Americium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Americium, [atoms/s]
- Americium_atom_flow()¶
Method to calculate and return the mole flow that is Americium, [mol/s]
- Americium_atom_fraction()¶
Method to calculate and return the mole fraction that is Americium element, [-]
- Americium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Americium element, [kg/s]
- Americium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Americium element, [-]
- Antimony_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Antimony, [atoms/s]
- Antimony_atom_flow()¶
Method to calculate and return the mole flow that is Antimony, [mol/s]
- Antimony_atom_fraction()¶
Method to calculate and return the mole fraction that is Antimony element, [-]
- Antimony_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Antimony element, [kg/s]
- Antimony_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Antimony element, [-]
- Argon_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Argon, [atoms/s]
- Argon_atom_flow()¶
Method to calculate and return the mole flow that is Argon, [mol/s]
- Argon_atom_fraction()¶
Method to calculate and return the mole fraction that is Argon element, [-]
- Argon_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Argon element, [kg/s]
- Argon_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Argon element, [-]
- Arsenic_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Arsenic, [atoms/s]
- Arsenic_atom_flow()¶
Method to calculate and return the mole flow that is Arsenic, [mol/s]
- Arsenic_atom_fraction()¶
Method to calculate and return the mole fraction that is Arsenic element, [-]
- Arsenic_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Arsenic element, [kg/s]
- Arsenic_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Arsenic element, [-]
- Astatine_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Astatine, [atoms/s]
- Astatine_atom_flow()¶
Method to calculate and return the mole flow that is Astatine, [mol/s]
- Astatine_atom_fraction()¶
Method to calculate and return the mole fraction that is Astatine element, [-]
- Astatine_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Astatine element, [kg/s]
- Astatine_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Astatine element, [-]
- B_from_Z()¶
- Barium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Barium, [atoms/s]
- Barium_atom_flow()¶
Method to calculate and return the mole flow that is Barium, [mol/s]
- Barium_atom_fraction()¶
Method to calculate and return the mole fraction that is Barium element, [-]
- Barium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Barium element, [kg/s]
- Barium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Barium element, [-]
- Berkelium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Berkelium, [atoms/s]
- Berkelium_atom_flow()¶
Method to calculate and return the mole flow that is Berkelium, [mol/s]
- Berkelium_atom_fraction()¶
Method to calculate and return the mole fraction that is Berkelium element, [-]
- Berkelium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Berkelium element, [kg/s]
- Berkelium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Berkelium element, [-]
- Beryllium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Beryllium, [atoms/s]
- Beryllium_atom_flow()¶
Method to calculate and return the mole flow that is Beryllium, [mol/s]
- Beryllium_atom_fraction()¶
Method to calculate and return the mole fraction that is Beryllium element, [-]
- Beryllium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Beryllium element, [kg/s]
- Beryllium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Beryllium element, [-]
- Bismuth_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Bismuth, [atoms/s]
- Bismuth_atom_flow()¶
Method to calculate and return the mole flow that is Bismuth, [mol/s]
- Bismuth_atom_fraction()¶
Method to calculate and return the mole fraction that is Bismuth element, [-]
- Bismuth_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Bismuth element, [kg/s]
- Bismuth_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Bismuth element, [-]
- Bohrium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Bohrium, [atoms/s]
- Bohrium_atom_flow()¶
Method to calculate and return the mole flow that is Bohrium, [mol/s]
- Bohrium_atom_fraction()¶
Method to calculate and return the mole fraction that is Bohrium element, [-]
- Bohrium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Bohrium element, [kg/s]
- Bohrium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Bohrium element, [-]
- Boron_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Boron, [atoms/s]
- Boron_atom_flow()¶
Method to calculate and return the mole flow that is Boron, [mol/s]
- Boron_atom_fraction()¶
Method to calculate and return the mole fraction that is Boron element, [-]
- Boron_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Boron element, [kg/s]
- Boron_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Boron element, [-]
- Bromine_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Bromine, [atoms/s]
- Bromine_atom_flow()¶
Method to calculate and return the mole flow that is Bromine, [mol/s]
- Bromine_atom_fraction()¶
Method to calculate and return the mole fraction that is Bromine element, [-]
- Bromine_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Bromine element, [kg/s]
- Bromine_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Bromine element, [-]
- property CASis¶
CAS registration numbers as integeres for each component, [-].
- property CASs¶
CAS registration numbers for each component, [-].
- Cadmium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Cadmium, [atoms/s]
- Cadmium_atom_flow()¶
Method to calculate and return the mole flow that is Cadmium, [mol/s]
- Cadmium_atom_fraction()¶
Method to calculate and return the mole fraction that is Cadmium element, [-]
- Cadmium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Cadmium element, [kg/s]
- Cadmium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Cadmium element, [-]
- Caesium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Caesium, [atoms/s]
- Caesium_atom_flow()¶
Method to calculate and return the mole flow that is Caesium, [mol/s]
- Caesium_atom_fraction()¶
Method to calculate and return the mole fraction that is Caesium element, [-]
- Caesium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Caesium element, [kg/s]
- Caesium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Caesium element, [-]
- Calcium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Calcium, [atoms/s]
- Calcium_atom_flow()¶
Method to calculate and return the mole flow that is Calcium, [mol/s]
- Calcium_atom_fraction()¶
Method to calculate and return the mole fraction that is Calcium element, [-]
- Calcium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Calcium element, [kg/s]
- Calcium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Calcium element, [-]
- Californium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Californium, [atoms/s]
- Californium_atom_flow()¶
Method to calculate and return the mole flow that is Californium, [mol/s]
- Californium_atom_fraction()¶
Method to calculate and return the mole fraction that is Californium element, [-]
- Californium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Californium element, [kg/s]
- Californium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Californium element, [-]
- Carbon_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Carbon, [atoms/s]
- Carbon_atom_flow()¶
Method to calculate and return the mole flow that is Carbon, [mol/s]
- Carbon_atom_fraction()¶
Method to calculate and return the mole fraction that is Carbon element, [-]
- Carbon_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Carbon element, [kg/s]
- Carbon_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Carbon element, [-]
- property Carcinogens¶
Status of each component in cancer causing registries, [-].
- property Ceilings¶
Ceiling exposure limits to chemicals (and their units; ppm or mg/m^3), [various].
- Cerium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Cerium, [atoms/s]
- Cerium_atom_flow()¶
Method to calculate and return the mole flow that is Cerium, [mol/s]
- Cerium_atom_fraction()¶
Method to calculate and return the mole fraction that is Cerium element, [-]
- Cerium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Cerium element, [kg/s]
- Cerium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Cerium element, [-]
- Chlorine_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Chlorine, [atoms/s]
- Chlorine_atom_flow()¶
Method to calculate and return the mole flow that is Chlorine, [mol/s]
- Chlorine_atom_fraction()¶
Method to calculate and return the mole fraction that is Chlorine element, [-]
- Chlorine_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Chlorine element, [kg/s]
- Chlorine_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Chlorine element, [-]
- Chromium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Chromium, [atoms/s]
- Chromium_atom_flow()¶
Method to calculate and return the mole flow that is Chromium, [mol/s]
- Chromium_atom_fraction()¶
Method to calculate and return the mole fraction that is Chromium element, [-]
- Chromium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Chromium element, [kg/s]
- Chromium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Chromium element, [-]
- Cobalt_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Cobalt, [atoms/s]
- Cobalt_atom_flow()¶
Method to calculate and return the mole flow that is Cobalt, [mol/s]
- Cobalt_atom_fraction()¶
Method to calculate and return the mole fraction that is Cobalt element, [-]
- Cobalt_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Cobalt element, [kg/s]
- Cobalt_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Cobalt element, [-]
- Copernicium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Copernicium, [atoms/s]
- Copernicium_atom_flow()¶
Method to calculate and return the mole flow that is Copernicium, [mol/s]
- Copernicium_atom_fraction()¶
Method to calculate and return the mole fraction that is Copernicium element, [-]
- Copernicium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Copernicium element, [kg/s]
- Copernicium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Copernicium element, [-]
- Copper_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Copper, [atoms/s]
- Copper_atom_flow()¶
Method to calculate and return the mole flow that is Copper, [mol/s]
- Copper_atom_fraction()¶
Method to calculate and return the mole fraction that is Copper element, [-]
- Copper_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Copper element, [kg/s]
- Copper_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Copper element, [-]
- Cp()¶
Method to calculate and return the constant-temperature and constant phase-fraction heat capacity of the bulk phase. This is a phase-fraction weighted calculation.
- Returns
- Cp
float
Molar heat capacity, [J/(mol*K)]
- Cp
- Cp_Cv_ratio()¶
Method to calculate and return the Cp/Cv ratio of the phase.
- Returns
- Cp_Cv_ratio
float
Cp/Cv ratio, [-]
- Cp_Cv_ratio
- Cp_Cv_ratio_ideal_gas(phase=None)[source]¶
Method to calculate and return the ratio of the ideal-gas heat capacity to its constant-volume heat capacity.
- Returns
- Cp_Cv_ratio_ideal_gas
float
Cp/Cv for the phase as an ideal gas, [-]
- Cp_Cv_ratio_ideal_gas
- Cp_dep(phase=None)[source]¶
Method to calculate and return the difference between the actual Cp and the ideal-gas heat capacity of the phase.
- Returns
- Cp_dep
float
Departure ideal gas heat capacity, [J/(mol*K)]
- Cp_dep
- Cp_dep_mass()¶
Method to calculate and return mass constant pressure departure heat capacity of the phase.
- Returns
- Cp_dep_mass
float
Mass departure heat capacity, [J/(kg*K)]
- Cp_dep_mass
- Cp_ideal_gas(phase=None)[source]¶
Method to calculate and return the ideal-gas heat capacity of the phase.
- Returns
- Cp
float
Ideal gas heat capacity, [J/(mol*K)]
- Cp
- Cp_ideal_gas_mass()¶
Method to calculate and return mass constant pressure departure heat capacity of the phase.
- Returns
- Cp_ideal_gas_mass
float
Mass departure heat capacity, [J/(kg*K)]
- Cp_ideal_gas_mass
- Cp_mass(phase=None)[source]¶
Method to calculate and return mass constant pressure heat capacity of the phase.
- Returns
- Cp_mass
float
Mass heat capacity, [J/(kg*K)]
- Cp_mass
- Cpgs()[source]¶
Method to calculate and return the pure-component ideal gas heat capacities of each species from the
thermo.heat_capacity.HeatCapacityGas
objects.
- Cpls()[source]¶
Method to calculate and return the pure-component liquid temperature-dependent heat capacities of each species from the
thermo.heat_capacity.HeatCapacityLiquid
objects.Note that some correlation methods for liquid heat capacity are at low pressure, and others are along the saturation line. There is a large difference in values.
- Cpss()[source]¶
Method to calculate and return the pure-component solid heat capacities of each species from the
thermo.heat_capacity.HeatCapacitySolid
objects.
- Curium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Curium, [atoms/s]
- Curium_atom_flow()¶
Method to calculate and return the mole flow that is Curium, [mol/s]
- Curium_atom_fraction()¶
Method to calculate and return the mole fraction that is Curium element, [-]
- Curium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Curium element, [kg/s]
- Curium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Curium element, [-]
- Cv()¶
Method to calculate and return the constant-volume heat capacity Cv of the phase.
- Returns
- Cv
float
Constant volume molar heat capacity, [J/(mol*K)]
- Cv
- Cv_dep(phase=None)[source]¶
Method to calculate and return the difference between the actual Cv and the ideal-gas constant volume heat capacity of the phase.
- Returns
- Cv_dep
float
Departure ideal gas constant volume heat capacity, [J/(mol*K)]
- Cv_dep
- Cv_dep_mass()¶
Method to calculate and return mass constant pressure departure heat capacity of the phase.
- Returns
- Cv_dep_mass
float
Mass departure heat capacity, [J/(kg*K)]
- Cv_dep_mass
- Cv_ideal_gas(phase=None)[source]¶
Method to calculate and return the ideal-gas constant volume heat capacity of the phase.
- Returns
- Cv
float
Ideal gas constant volume heat capacity, [J/(mol*K)]
- Cv
- Cv_mass(phase=None)[source]¶
Method to calculate and return mass constant volume heat capacity of the phase.
- Returns
- Cv_mass
float
Mass constant volume heat capacity, [J/(kg*K)]
- Cv_mass
- Darmstadtium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Darmstadtium, [atoms/s]
- Darmstadtium_atom_flow()¶
Method to calculate and return the mole flow that is Darmstadtium, [mol/s]
- Darmstadtium_atom_fraction()¶
Method to calculate and return the mole fraction that is Darmstadtium element, [-]
- Darmstadtium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Darmstadtium element, [kg/s]
- Darmstadtium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Darmstadtium element, [-]
- Dubnium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Dubnium, [atoms/s]
- Dubnium_atom_flow()¶
Method to calculate and return the mole flow that is Dubnium, [mol/s]
- Dubnium_atom_fraction()¶
Method to calculate and return the mole fraction that is Dubnium element, [-]
- Dubnium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Dubnium element, [kg/s]
- Dubnium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Dubnium element, [-]
- Dysprosium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Dysprosium, [atoms/s]
- Dysprosium_atom_flow()¶
Method to calculate and return the mole flow that is Dysprosium, [mol/s]
- Dysprosium_atom_fraction()¶
Method to calculate and return the mole fraction that is Dysprosium element, [-]
- Dysprosium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Dysprosium element, [kg/s]
- Dysprosium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Dysprosium element, [-]
- Einsteinium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Einsteinium, [atoms/s]
- Einsteinium_atom_flow()¶
Method to calculate and return the mole flow that is Einsteinium, [mol/s]
- Einsteinium_atom_fraction()¶
Method to calculate and return the mole fraction that is Einsteinium element, [-]
- Einsteinium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Einsteinium element, [kg/s]
- Einsteinium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Einsteinium element, [-]
- property EnthalpySublimations¶
Wrapper to obtain the list of EnthalpySublimations objects of the associated
PropertyCorrelationsPackage
.
- property EnthalpyVaporizations¶
Wrapper to obtain the list of EnthalpyVaporizations objects of the associated
PropertyCorrelationsPackage
.
- Erbium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Erbium, [atoms/s]
- Erbium_atom_flow()¶
Method to calculate and return the mole flow that is Erbium, [mol/s]
- Erbium_atom_fraction()¶
Method to calculate and return the mole fraction that is Erbium element, [-]
- Erbium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Erbium element, [kg/s]
- Erbium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Erbium element, [-]
- Europium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Europium, [atoms/s]
- Europium_atom_flow()¶
Method to calculate and return the mole flow that is Europium, [mol/s]
- Europium_atom_fraction()¶
Method to calculate and return the mole fraction that is Europium element, [-]
- Europium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Europium element, [kg/s]
- Europium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Europium element, [-]
- Fermium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Fermium, [atoms/s]
- Fermium_atom_flow()¶
Method to calculate and return the mole flow that is Fermium, [mol/s]
- Fermium_atom_fraction()¶
Method to calculate and return the mole fraction that is Fermium element, [-]
- Fermium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Fermium element, [kg/s]
- Fermium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Fermium element, [-]
- Flerovium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Flerovium, [atoms/s]
- Flerovium_atom_flow()¶
Method to calculate and return the mole flow that is Flerovium, [mol/s]
- Flerovium_atom_fraction()¶
Method to calculate and return the mole fraction that is Flerovium element, [-]
- Flerovium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Flerovium element, [kg/s]
- Flerovium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Flerovium element, [-]
- Fluorine_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Fluorine, [atoms/s]
- Fluorine_atom_flow()¶
Method to calculate and return the mole flow that is Fluorine, [mol/s]
- Fluorine_atom_fraction()¶
Method to calculate and return the mole fraction that is Fluorine element, [-]
- Fluorine_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Fluorine element, [kg/s]
- Fluorine_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Fluorine element, [-]
- Francium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Francium, [atoms/s]
- Francium_atom_flow()¶
Method to calculate and return the mole flow that is Francium, [mol/s]
- Francium_atom_fraction()¶
Method to calculate and return the mole fraction that is Francium element, [-]
- Francium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Francium element, [kg/s]
- Francium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Francium element, [-]
- G()¶
Method to calculate and return the Gibbs free energy of the phase.
- Returns
- G
float
Gibbs free energy, [J/mol]
- G
- property GWPs¶
Global Warming Potentials for each component (impact/mass chemical)/(impact/mass CO2), [-].
- G_dep()¶
Method to calculate and return the departure Gibbs free energy of the phase.
- Returns
- G_dep
float
Departure Gibbs free energy, [J/mol]
- G_dep
- G_dep_flow(phase=None)[source]¶
Method to return the flow rate of the difference between the ideal-gas Gibbs free energy of this phase and the actual Gibbs free energy of the phase This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- G_dep_flow
float
Flow rate of departure Gibbs energy, [J/s]
- G_dep_flow
- G_dep_mass()¶
Method to calculate and return the mass departure Gibbs free energy of the phase.
- Returns
- G_dep_mass
float
Departure mass Gibbs free energy, [J/kg]
- G_dep_mass
- G_flow(phase=None)[source]¶
Method to return the flow rate of Gibbs free energy of this phase. This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- G_flow
float
Flow rate of Gibbs energy, [J/s]
- G_flow
- G_formation_ideal_gas(phase=None)[source]¶
Method to calculate and return the ideal-gas Gibbs free energy of formation of the phase (as if the phase was an ideal gas).
- Returns
- G_formation_ideal_gas
float
Gibbs free energy of formation of the phase on a reactive basis as an ideal gas, [J/(mol)]
- G_formation_ideal_gas
- G_formation_ideal_gas_mass()¶
Method to calculate and return the mass ideal-gas formation Gibbs free energy of the phase.
- Returns
- G_formation_ideal_gas_mass
float
Formation mass Gibbs free energy, [J/kg]
- G_formation_ideal_gas_mass
- G_ideal_gas(phase=None)[source]¶
Method to calculate and return the ideal-gas Gibbs free energy of the phase.
- Returns
- G_ideal_gas
float
Ideal gas free energy, [J/(mol)]
- G_ideal_gas
- G_ideal_gas_mass()¶
Method to calculate and return the mass ideal-gas Gibbs free energy of the phase.
- Returns
- G_ideal_gas_mass
float
Ideal gas mass free energy, [J/(kg)]
- G_ideal_gas_mass
- G_ideal_gas_standard_state()¶
- G_mass(phase=None)[source]¶
Method to calculate and return mass Gibbs energy of the phase.
- Returns
- G_mass
float
Mass Gibbs energy, [J/(kg)]
- G_mass
- G_min_criteria()¶
Method to calculate and return the Gibbs energy criteria required for comparing phase stability. This calculation can be faster than calculating the full Gibbs energy. For this comparison to work, all phases must use the ideal gas basis.
- Returns
- G_crit
float
Gibbs free energy like criteria [J/mol]
- G_crit
- G_reactive()¶
Method to calculate and return the Gibbs free energy of the phase on a reactive basis.
- Returns
- G_reactive
float
Gibbs free energy of the phase on a reactive basis, [J/(mol)]
- G_reactive
- G_reactive_mass()¶
Method to calculate and return mass Gibbs free energy on a reactive basis of the phase.
- Returns
- G_reactive_mass
float
Gibbs free energy on a reactive basis, [J/kg]
- G_reactive_mass
- Gadolinium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Gadolinium, [atoms/s]
- Gadolinium_atom_flow()¶
Method to calculate and return the mole flow that is Gadolinium, [mol/s]
- Gadolinium_atom_fraction()¶
Method to calculate and return the mole fraction that is Gadolinium element, [-]
- Gadolinium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Gadolinium element, [kg/s]
- Gadolinium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Gadolinium element, [-]
- Gallium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Gallium, [atoms/s]
- Gallium_atom_flow()¶
Method to calculate and return the mole flow that is Gallium, [mol/s]
- Gallium_atom_fraction()¶
Method to calculate and return the mole fraction that is Gallium element, [-]
- Gallium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Gallium element, [kg/s]
- Gallium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Gallium element, [-]
- Germanium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Germanium, [atoms/s]
- Germanium_atom_flow()¶
Method to calculate and return the mole flow that is Germanium, [mol/s]
- Germanium_atom_fraction()¶
Method to calculate and return the mole fraction that is Germanium element, [-]
- Germanium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Germanium element, [kg/s]
- Germanium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Germanium element, [-]
- property Gfgs¶
Ideal gas standard molar Gibbs free energy of formation for each component, [J/mol].
- property Gfgs_mass¶
Ideal gas standard Gibbs free energy of formation for each component, [J/kg].
- Gold_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Gold, [atoms/s]
- Gold_atom_flow()¶
Method to calculate and return the mole flow that is Gold, [mol/s]
- Gold_atom_fraction()¶
Method to calculate and return the mole fraction that is Gold element, [-]
- Gold_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Gold element, [kg/s]
- Gold_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Gold element, [-]
- Gs_ideal_gas_standard_state()¶
- H()¶
Method to calculate and return the constant-temperature and constant phase-fraction enthalpy of the bulk phase. This is a phase-fraction weighted calculation.
- Returns
- H
float
Molar enthalpy, [J/(mol)]
- H
- H_C_ratio(phase=None)[source]¶
Method to calculate and return the atomic ratio of hydrogen atoms to carbon atoms, based on the current composition of the phase.
- Returns
- H_C_ratio
float
H/C ratio on a molar basis, [-]
- H_C_ratio
Notes
None is returned if no species are present that have carbon atoms.
- H_C_ratio_mass(phase=None)[source]¶
Method to calculate and return the mass ratio of hydrogen atoms to carbon atoms, based on the current composition of the phase.
- Returns
- H_C_ratio_mass
float
H/C ratio on a mass basis, [-]
- H_C_ratio_mass
Notes
None is returned if no species are present that have carbon atoms.
- property H_calc¶
- H_dep(phase=None)[source]¶
Method to calculate and return the difference between the actual H and the ideal-gas enthalpy of the phase.
- Returns
- H_dep
float
Departure enthalpy, [J/(mol)]
- H_dep
- H_dep_flow(phase=None)[source]¶
Method to return the flow rate of the difference between the ideal-gas energy of this phase and the actual energy of the phase This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- H_dep_flow
float
Flow rate of departure energy, [J/s]
- H_dep_flow
- H_dep_mass()¶
Method to calculate and return the mass departure enthalpy of the phase.
- Returns
- H_dep_mass
float
Departure mass enthalpy free energy, [J/kg]
- H_dep_mass
- H_flow(phase=None)[source]¶
Method to return the flow rate of enthalpy of this phase. This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- H_flow
float
Flow rate of energy, [J/s]
- H_flow
- H_formation_ideal_gas(phase=None)[source]¶
Method to calculate and return the ideal-gas enthalpy of formation of the phase (as if the phase was an ideal gas).
- Returns
- H_formation_ideal_gas
float
Enthalpy of formation of the phase on a reactive basis as an ideal gas, [J/mol]
- H_formation_ideal_gas
- H_formation_ideal_gas_mass()¶
Method to calculate and return the mass ideal-gas formation enthalpy of the phase.
- Returns
- H_formation_ideal_gas_mass
float
Formation mass enthalpy, [J/kg]
- H_formation_ideal_gas_mass
- H_ideal_gas(phase=None)[source]¶
Method to calculate and return the ideal-gas enthalpy of the phase.
- Returns
- H
float
Ideal gas enthalpy, [J/(mol)]
- H
- H_ideal_gas_mass()¶
Method to calculate and return the mass ideal-gas enthalpy of the phase.
- Returns
- H_ideal_gas_mass
float
Ideal gas mass enthalpy, [J/(kg)]
- H_ideal_gas_mass
- H_ideal_gas_standard_state()¶
- H_mass(phase=None)[source]¶
Method to calculate and return mass enthalpy of the phase.
- Returns
- H_mass
float
Mass enthalpy, [J/kg]
- H_mass
- H_reactive()¶
Method to calculate and return the constant-temperature and constant phase-fraction reactive enthalpy of the bulk phase. This is a phase-fraction weighted calculation.
- Returns
- H_reactive
float
Reactive molar enthalpy, [J/(mol)]
- H_reactive
- H_reactive_mass()¶
Method to calculate and return mass enthalpy on a reactive basis of the phase.
- Returns
- H_reactive_mass
float
Mass enthalpy on a reactive basis, [J/kg]
- H_reactive_mass
- Hafnium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Hafnium, [atoms/s]
- Hafnium_atom_flow()¶
Method to calculate and return the mole flow that is Hafnium, [mol/s]
- Hafnium_atom_fraction()¶
Method to calculate and return the mole fraction that is Hafnium element, [-]
- Hafnium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Hafnium element, [kg/s]
- Hafnium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Hafnium element, [-]
- Hassium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Hassium, [atoms/s]
- Hassium_atom_flow()¶
Method to calculate and return the mole flow that is Hassium, [mol/s]
- Hassium_atom_fraction()¶
Method to calculate and return the mole fraction that is Hassium element, [-]
- Hassium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Hassium element, [kg/s]
- Hassium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Hassium element, [-]
- Hc(phase=None)[source]¶
Method to calculate and return the molar ideal-gas higher heat of combustion of the object, [J/mol]
- Returns
- Hc
float
Molar higher heat of combustion, [J/(mol)]
- Hc
- Hc_lower(phase=None)[source]¶
Method to calculate and return the molar ideal-gas lower heat of combustion of the object, [J/mol]
- Returns
- Hc_lower
float
Molar lower heat of combustion, [J/(mol)]
- Hc_lower
- Hc_lower_mass(phase=None)[source]¶
Method to calculate and return the mass ideal-gas lower heat of combustion of the object, [J/mol]
- Returns
- Hc_lower_mass
float
Mass lower heat of combustion, [J/(kg)]
- Hc_lower_mass
- Hc_lower_normal(phase=None)[source]¶
Method to calculate and return the volumetric ideal-gas lower heat of combustion of the object using the normal gas volume, [J/m^3]
- Returns
- Hc_lower_normal
float
Volumetric (normal) lower heat of combustion, [J/(m^3)]
- Hc_lower_normal
- Hc_lower_standard(phase=None)[source]¶
Method to calculate and return the volumetric ideal-gas lower heat of combustion of the object using the standard gas volume, [J/m^3]
- Returns
- Hc_lower_standard
float
Volumetric (standard) lower heat of combustion, [J/(m^3)]
- Hc_lower_standard
- Hc_mass(phase=None)[source]¶
Method to calculate and return the mass ideal-gas higher heat of combustion of the object, [J/mol]
- Returns
- Hc_mass
float
Mass higher heat of combustion, [J/(kg)]
- Hc_mass
- Hc_normal(phase=None)[source]¶
Method to calculate and return the volumetric ideal-gas higher heat of combustion of the object using the normal gas volume, [J/m^3]
- Returns
- Hc_normal
float
Volumetric (normal) higher heat of combustion, [J/(m^3)]
- Hc_normal
- Hc_standard(phase=None)[source]¶
Method to calculate and return the volumetric ideal-gas higher heat of combustion of the object using the standard gas volume, [J/m^3]
- Returns
- Hc_normal
float
Volumetric (standard) higher heat of combustion, [J/(m^3)]
- Hc_normal
- property Hcs¶
Higher standard molar heats of combustion for each component, [J/mol].
- property Hcs_lower¶
Lower standard molar heats of combustion for each component, [J/mol].
- property Hcs_lower_mass¶
Lower standard heats of combustion for each component, [J/kg].
- property Hcs_mass¶
Higher standard heats of combustion for each component, [J/kg].
- property HeatCapacityGasMixture¶
Wrapper to obtain the list of HeatCapacityGasMixture objects of the associated
PropertyCorrelationsPackage
.
- property HeatCapacityGases¶
Wrapper to obtain the list of HeatCapacityGases objects of the associated
PropertyCorrelationsPackage
.
- property HeatCapacityLiquidMixture¶
Wrapper to obtain the list of HeatCapacityLiquidMixture objects of the associated
PropertyCorrelationsPackage
.
- property HeatCapacityLiquids¶
Wrapper to obtain the list of HeatCapacityLiquids objects of the associated
PropertyCorrelationsPackage
.
- property HeatCapacitySolidMixture¶
Wrapper to obtain the list of HeatCapacitySolidMixture objects of the associated
PropertyCorrelationsPackage
.
- property HeatCapacitySolids¶
Wrapper to obtain the list of HeatCapacitySolids objects of the associated
PropertyCorrelationsPackage
.
- Helium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Helium, [atoms/s]
- Helium_atom_flow()¶
Method to calculate and return the mole flow that is Helium, [mol/s]
- Helium_atom_fraction()¶
Method to calculate and return the mole fraction that is Helium element, [-]
- Helium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Helium element, [kg/s]
- Helium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Helium element, [-]
- property Hf_STPs¶
Standard state molar enthalpies of formation for each component, [J/mol].
- property Hf_STPs_mass¶
Standard state mass enthalpies of formation for each component, [J/kg].
- property Hfgs¶
Ideal gas standard molar enthalpies of formation for each component, [J/mol].
- property Hfgs_mass¶
Ideal gas standard enthalpies of formation for each component, [J/kg].
- property Hfus_Tms¶
Molar heats of fusion for each component at their respective melting points, [J/mol].
- property Hfus_Tms_mass¶
Heats of fusion for each component at their respective melting points, [J/kg].
- Holmium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Holmium, [atoms/s]
- Holmium_atom_flow()¶
Method to calculate and return the mole flow that is Holmium, [mol/s]
- Holmium_atom_fraction()¶
Method to calculate and return the mole fraction that is Holmium element, [-]
- Holmium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Holmium element, [kg/s]
- Holmium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Holmium element, [-]
- Hs_ideal_gas_standard_state()¶
- property Hsub_Tts¶
Heats of sublimation for each component at their respective triple points, [J/mol].
- property Hsub_Tts_mass¶
Heats of sublimation for each component at their respective triple points, [J/kg].
- Hsubs()[source]¶
Method to calculate and return the pure-component enthalpy of sublimation of each species from the
thermo.phase_change.EnthalpySublimation
objects.Notes
Warning
This is not necessarily consistent with the saturation enthalpy change calculated by a flash algorithm.
- property Hvap_298s¶
Molar heats of vaporization for each component at 298.15 K, [J/mol].
- property Hvap_298s_mass¶
Heats of vaporization for each component at 298.15 K, [J/kg].
- property Hvap_Tbs¶
Molar heats of vaporization for each component at their respective normal boiling points, [J/mol].
- property Hvap_Tbs_mass¶
Heats of vaporization for each component at their respective normal boiling points, [J/kg].
- Hvaps()[source]¶
Method to calculate and return the pure-component enthalpy of vaporization of each species from the
thermo.phase_change.EnthalpyVaporization
objects.Notes
Warning
This is not necessarily consistent with the saturation enthalpy change calculated by a flash algorithm.
- Hydrogen_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Hydrogen, [atoms/s]
- Hydrogen_atom_flow()¶
Method to calculate and return the mole flow that is Hydrogen, [mol/s]
- Hydrogen_atom_fraction()¶
Method to calculate and return the mole fraction that is Hydrogen element, [-]
- Hydrogen_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Hydrogen element, [kg/s]
- Hydrogen_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Hydrogen element, [-]
- property IDs¶
Alias of CASs.
- property InChI_Keys¶
InChI Keys for each component, [-].
- property InChIs¶
InChI strings for each component, [-].
- Indium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Indium, [atoms/s]
- Indium_atom_flow()¶
Method to calculate and return the mole flow that is Indium, [mol/s]
- Indium_atom_fraction()¶
Method to calculate and return the mole fraction that is Indium element, [-]
- Indium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Indium element, [kg/s]
- Indium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Indium element, [-]
- Iodine_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Iodine, [atoms/s]
- Iodine_atom_flow()¶
Method to calculate and return the mole flow that is Iodine, [mol/s]
- Iodine_atom_fraction()¶
Method to calculate and return the mole fraction that is Iodine element, [-]
- Iodine_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Iodine element, [kg/s]
- Iodine_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Iodine element, [-]
- Iridium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Iridium, [atoms/s]
- Iridium_atom_flow()¶
Method to calculate and return the mole flow that is Iridium, [mol/s]
- Iridium_atom_fraction()¶
Method to calculate and return the mole fraction that is Iridium element, [-]
- Iridium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Iridium element, [kg/s]
- Iridium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Iridium element, [-]
- Iron_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Iron, [atoms/s]
- Iron_atom_flow()¶
Method to calculate and return the mole flow that is Iron, [mol/s]
- Iron_atom_fraction()¶
Method to calculate and return the mole fraction that is Iron element, [-]
- Iron_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Iron element, [kg/s]
- Iron_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Iron element, [-]
- Joule_Thomson()¶
Method to calculate and return the Joule-Thomson coefficient of the bulk according to the selected calculation methodology.
- Returns
- mu_JT
float
Joule-Thomson coefficient [K/Pa]
- mu_JT
- Krypton_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Krypton, [atoms/s]
- Krypton_atom_flow()¶
Method to calculate and return the mole flow that is Krypton, [mol/s]
- Krypton_atom_fraction()¶
Method to calculate and return the mole fraction that is Krypton element, [-]
- Krypton_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Krypton element, [kg/s]
- Krypton_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Krypton element, [-]
- Ks(phase, ref_phase=None)[source]¶
Method to calculate and return the K-values of each phase. These are NOT just liquid-vapor K values; these are thermodynamic K values. The reference phase can be specified with ref_phase, and then the K-values will be with respect to that phase.
If no reference phase is provided, the following criteria is used to select one:
If the flash algorithm provided a reference phase, use that
Otherwise use the liquid0 phase if one is present
Otherwise use the solid0 phase if one is present
Otherwise use the gas phase if one is present
- property LF¶
Method to return the liquid fraction of the equilibrium state. If no liquid is present, 0 is always returned.
- Returns
- LF
float
Liquid molar fraction, [-]
- LF
- property LFLs¶
Lower flammability limits for each component, [-].
- Lanthanum_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Lanthanum, [atoms/s]
- Lanthanum_atom_flow()¶
Method to calculate and return the mole flow that is Lanthanum, [mol/s]
- Lanthanum_atom_fraction()¶
Method to calculate and return the mole fraction that is Lanthanum element, [-]
- Lanthanum_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Lanthanum element, [kg/s]
- Lanthanum_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Lanthanum element, [-]
- Lawrencium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Lawrencium, [atoms/s]
- Lawrencium_atom_flow()¶
Method to calculate and return the mole flow that is Lawrencium, [mol/s]
- Lawrencium_atom_fraction()¶
Method to calculate and return the mole fraction that is Lawrencium element, [-]
- Lawrencium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Lawrencium element, [kg/s]
- Lawrencium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Lawrencium element, [-]
- Lead_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Lead, [atoms/s]
- Lead_atom_flow()¶
Method to calculate and return the mole flow that is Lead, [mol/s]
- Lead_atom_fraction()¶
Method to calculate and return the mole fraction that is Lead element, [-]
- Lead_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Lead element, [kg/s]
- Lead_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Lead element, [-]
- Lithium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Lithium, [atoms/s]
- Lithium_atom_flow()¶
Method to calculate and return the mole flow that is Lithium, [mol/s]
- Lithium_atom_fraction()¶
Method to calculate and return the mole fraction that is Lithium element, [-]
- Lithium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Lithium element, [kg/s]
- Lithium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Lithium element, [-]
- Livermorium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Livermorium, [atoms/s]
- Livermorium_atom_flow()¶
Method to calculate and return the mole flow that is Livermorium, [mol/s]
- Livermorium_atom_fraction()¶
Method to calculate and return the mole fraction that is Livermorium element, [-]
- Livermorium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Livermorium element, [kg/s]
- Livermorium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Livermorium element, [-]
- Lutetium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Lutetium, [atoms/s]
- Lutetium_atom_flow()¶
Method to calculate and return the mole flow that is Lutetium, [mol/s]
- Lutetium_atom_fraction()¶
Method to calculate and return the mole fraction that is Lutetium element, [-]
- Lutetium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Lutetium element, [kg/s]
- Lutetium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Lutetium element, [-]
- MW(phase=None)[source]¶
Method to calculate and return the molecular weight of the phase.
- Returns
- MW
float
Molecular weight of the phase, [g/mol]
- MW
- property MWs¶
Molecular weights for each component, [g/mol].
- Magnesium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Magnesium, [atoms/s]
- Magnesium_atom_flow()¶
Method to calculate and return the mole flow that is Magnesium, [mol/s]
- Magnesium_atom_fraction()¶
Method to calculate and return the mole fraction that is Magnesium element, [-]
- Magnesium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Magnesium element, [kg/s]
- Magnesium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Magnesium element, [-]
- Manganese_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Manganese, [atoms/s]
- Manganese_atom_flow()¶
Method to calculate and return the mole flow that is Manganese, [mol/s]
- Manganese_atom_fraction()¶
Method to calculate and return the mole fraction that is Manganese element, [-]
- Manganese_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Manganese element, [kg/s]
- Manganese_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Manganese element, [-]
- Meitnerium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Meitnerium, [atoms/s]
- Meitnerium_atom_flow()¶
Method to calculate and return the mole flow that is Meitnerium, [mol/s]
- Meitnerium_atom_fraction()¶
Method to calculate and return the mole fraction that is Meitnerium element, [-]
- Meitnerium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Meitnerium element, [kg/s]
- Meitnerium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Meitnerium element, [-]
- Mendelevium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Mendelevium, [atoms/s]
- Mendelevium_atom_flow()¶
Method to calculate and return the mole flow that is Mendelevium, [mol/s]
- Mendelevium_atom_fraction()¶
Method to calculate and return the mole fraction that is Mendelevium element, [-]
- Mendelevium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Mendelevium element, [kg/s]
- Mendelevium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Mendelevium element, [-]
- Mercury_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Mercury, [atoms/s]
- Mercury_atom_flow()¶
Method to calculate and return the mole flow that is Mercury, [mol/s]
- Mercury_atom_fraction()¶
Method to calculate and return the mole fraction that is Mercury element, [-]
- Mercury_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Mercury element, [kg/s]
- Mercury_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Mercury element, [-]
- Molybdenum_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Molybdenum, [atoms/s]
- Molybdenum_atom_flow()¶
Method to calculate and return the mole flow that is Molybdenum, [mol/s]
- Molybdenum_atom_fraction()¶
Method to calculate and return the mole fraction that is Molybdenum element, [-]
- Molybdenum_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Molybdenum element, [kg/s]
- Molybdenum_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Molybdenum element, [-]
- Moscovium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Moscovium, [atoms/s]
- Moscovium_atom_flow()¶
Method to calculate and return the mole flow that is Moscovium, [mol/s]
- Moscovium_atom_fraction()¶
Method to calculate and return the mole fraction that is Moscovium element, [-]
- Moscovium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Moscovium element, [kg/s]
- Moscovium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Moscovium element, [-]
- N¶
- Neodymium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Neodymium, [atoms/s]
- Neodymium_atom_flow()¶
Method to calculate and return the mole flow that is Neodymium, [mol/s]
- Neodymium_atom_fraction()¶
Method to calculate and return the mole fraction that is Neodymium element, [-]
- Neodymium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Neodymium element, [kg/s]
- Neodymium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Neodymium element, [-]
- Neon_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Neon, [atoms/s]
- Neon_atom_flow()¶
Method to calculate and return the mole flow that is Neon, [mol/s]
- Neon_atom_fraction()¶
Method to calculate and return the mole fraction that is Neon element, [-]
- Neon_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Neon element, [kg/s]
- Neon_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Neon element, [-]
- Neptunium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Neptunium, [atoms/s]
- Neptunium_atom_flow()¶
Method to calculate and return the mole flow that is Neptunium, [mol/s]
- Neptunium_atom_fraction()¶
Method to calculate and return the mole fraction that is Neptunium element, [-]
- Neptunium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Neptunium element, [kg/s]
- Neptunium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Neptunium element, [-]
- Nickel_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Nickel, [atoms/s]
- Nickel_atom_flow()¶
Method to calculate and return the mole flow that is Nickel, [mol/s]
- Nickel_atom_fraction()¶
Method to calculate and return the mole fraction that is Nickel element, [-]
- Nickel_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Nickel element, [kg/s]
- Nickel_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Nickel element, [-]
- Nihonium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Nihonium, [atoms/s]
- Nihonium_atom_flow()¶
Method to calculate and return the mole flow that is Nihonium, [mol/s]
- Nihonium_atom_fraction()¶
Method to calculate and return the mole fraction that is Nihonium element, [-]
- Nihonium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Nihonium element, [kg/s]
- Nihonium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Nihonium element, [-]
- Niobium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Niobium, [atoms/s]
- Niobium_atom_flow()¶
Method to calculate and return the mole flow that is Niobium, [mol/s]
- Niobium_atom_fraction()¶
Method to calculate and return the mole fraction that is Niobium element, [-]
- Niobium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Niobium element, [kg/s]
- Niobium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Niobium element, [-]
- Nitrogen_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Nitrogen, [atoms/s]
- Nitrogen_atom_flow()¶
Method to calculate and return the mole flow that is Nitrogen, [mol/s]
- Nitrogen_atom_fraction()¶
Method to calculate and return the mole fraction that is Nitrogen element, [-]
- Nitrogen_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Nitrogen element, [kg/s]
- Nitrogen_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Nitrogen element, [-]
- Nobelium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Nobelium, [atoms/s]
- Nobelium_atom_flow()¶
Method to calculate and return the mole flow that is Nobelium, [mol/s]
- Nobelium_atom_fraction()¶
Method to calculate and return the mole fraction that is Nobelium element, [-]
- Nobelium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Nobelium element, [kg/s]
- Nobelium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Nobelium element, [-]
- property ODPs¶
Ozone Depletion Potentials for each component (impact/mass chemical)/(impact/mass CFC-11), [-].
- Oganesson_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Oganesson, [atoms/s]
- Oganesson_atom_flow()¶
Method to calculate and return the mole flow that is Oganesson, [mol/s]
- Oganesson_atom_fraction()¶
Method to calculate and return the mole fraction that is Oganesson element, [-]
- Oganesson_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Oganesson element, [kg/s]
- Oganesson_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Oganesson element, [-]
- Osmium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Osmium, [atoms/s]
- Osmium_atom_flow()¶
Method to calculate and return the mole flow that is Osmium, [mol/s]
- Osmium_atom_fraction()¶
Method to calculate and return the mole fraction that is Osmium element, [-]
- Osmium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Osmium element, [kg/s]
- Osmium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Osmium element, [-]
- Oxygen_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Oxygen, [atoms/s]
- Oxygen_atom_flow()¶
Method to calculate and return the mole flow that is Oxygen, [mol/s]
- Oxygen_atom_fraction()¶
Method to calculate and return the mole fraction that is Oxygen element, [-]
- Oxygen_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Oxygen element, [kg/s]
- Oxygen_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Oxygen element, [-]
- P¶
- PIP()¶
Method to calculate and return the phase identification parameter of the phase.
- Returns
- PIP
float
Phase identification parameter, [-]
- PIP
- property PSRK_groups¶
PSRK subgroup: count groups for each component, [-].
- P_REF_IG = 101325.0¶
- P_REF_IG_INV = 9.869232667160129e-06¶
- property P_calc¶
- Palladium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Palladium, [atoms/s]
- Palladium_atom_flow()¶
Method to calculate and return the mole flow that is Palladium, [mol/s]
- Palladium_atom_fraction()¶
Method to calculate and return the mole fraction that is Palladium element, [-]
- Palladium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Palladium element, [kg/s]
- Palladium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Palladium element, [-]
- property Parachors¶
Parachors for each component, [N^0.25*m^2.75/mol].
- property Pcs¶
Critical pressures for each component, [Pa].
- property PermittivityLiquids¶
Wrapper to obtain the list of PermittivityLiquids objects of the associated
PropertyCorrelationsPackage
.
- Phosphorus_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Phosphorus, [atoms/s]
- Phosphorus_atom_flow()¶
Method to calculate and return the mole flow that is Phosphorus, [mol/s]
- Phosphorus_atom_fraction()¶
Method to calculate and return the mole fraction that is Phosphorus element, [-]
- Phosphorus_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Phosphorus element, [kg/s]
- Phosphorus_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Phosphorus element, [-]
- Platinum_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Platinum, [atoms/s]
- Platinum_atom_flow()¶
Method to calculate and return the mole flow that is Platinum, [mol/s]
- Platinum_atom_fraction()¶
Method to calculate and return the mole fraction that is Platinum element, [-]
- Platinum_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Platinum element, [kg/s]
- Platinum_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Platinum element, [-]
- Plutonium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Plutonium, [atoms/s]
- Plutonium_atom_flow()¶
Method to calculate and return the mole flow that is Plutonium, [mol/s]
- Plutonium_atom_fraction()¶
Method to calculate and return the mole fraction that is Plutonium element, [-]
- Plutonium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Plutonium element, [kg/s]
- Plutonium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Plutonium element, [-]
- Pmc(phase=None)[source]¶
Method to calculate and return the mechanical critical pressure of the phase.
- Returns
- Pmc
float
Mechanical critical pressure, [Pa]
- Pmc
- Polonium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Polonium, [atoms/s]
- Polonium_atom_flow()¶
Method to calculate and return the mole flow that is Polonium, [mol/s]
- Polonium_atom_fraction()¶
Method to calculate and return the mole fraction that is Polonium element, [-]
- Polonium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Polonium element, [kg/s]
- Polonium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Polonium element, [-]
- Potassium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Potassium, [atoms/s]
- Potassium_atom_flow()¶
Method to calculate and return the mole flow that is Potassium, [mol/s]
- Potassium_atom_fraction()¶
Method to calculate and return the mole fraction that is Potassium element, [-]
- Potassium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Potassium element, [kg/s]
- Potassium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Potassium element, [-]
- Prandtl()¶
Method to calculate and return the Prandtl number of the phase
- Returns
- Pr
float
Prandtl number []
- Pr
- Praseodymium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Praseodymium, [atoms/s]
- Praseodymium_atom_flow()¶
Method to calculate and return the mole flow that is Praseodymium, [mol/s]
- Praseodymium_atom_fraction()¶
Method to calculate and return the mole fraction that is Praseodymium element, [-]
- Praseodymium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Praseodymium element, [kg/s]
- Praseodymium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Praseodymium element, [-]
- Promethium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Promethium, [atoms/s]
- Promethium_atom_flow()¶
Method to calculate and return the mole flow that is Promethium, [mol/s]
- Promethium_atom_fraction()¶
Method to calculate and return the mole fraction that is Promethium element, [-]
- Promethium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Promethium element, [kg/s]
- Promethium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Promethium element, [-]
- Protactinium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Protactinium, [atoms/s]
- Protactinium_atom_flow()¶
Method to calculate and return the mole flow that is Protactinium, [mol/s]
- Protactinium_atom_fraction()¶
Method to calculate and return the mole fraction that is Protactinium element, [-]
- Protactinium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Protactinium element, [kg/s]
- Protactinium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Protactinium element, [-]
- property Psat_298s¶
Vapor pressures for each component at 298.15 K, [Pa].
- Psats()[source]¶
Method to calculate and return the pure-component vapor pressures of each species from the
thermo.vapor_pressure.VaporPressure
objects.Notes
Warning
This is not necessarily consistent with the saturation pressure calculated by a flash algorithm.
- Psubs()[source]¶
Method to calculate and return the pure-component sublimation of each species from the
thermo.vapor_pressure.SublimationPressure
objects.Notes
Warning
This is not necessarily consistent with the saturation pressure calculated by a flash algorithm.
- property Pts¶
Triple point pressures for each component, [Pa].
- property PubChems¶
Pubchem IDs for each component, [-].
- property Q¶
Method to return the actual volumetric flow rate of this phase. This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- Q
float
Volume flow of the phase, [m^3/s]
- Q
- property Q_calc¶
Method to return the actual volumetric flow rate of this phase. This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- Q
float
Volume flow of the phase, [m^3/s]
- Q
- property Qg¶
Method to return the volume flow rate of this phase as an ideal gas, using the configured temperature T_gas_ref and pressure P_gas_ref. This method is only available when the phase is linked to an EquilibriumStream. This method totally ignores phase equilibrium.
- Returns
- Qg
float
Ideal gas flow rate of the phase, [m^3/s]
- Qg
- property Qg_calc¶
Method to return the volume flow rate of this phase as an ideal gas, using the configured temperature T_gas_ref and pressure P_gas_ref. This method is only available when the phase is linked to an EquilibriumStream. This method totally ignores phase equilibrium.
- Returns
- Qg
float
Ideal gas flow rate of the phase, [m^3/s]
- Qg
- property Qgs¶
Method to return the volume flow rate of each component in this phase as an ideal gas, using the configured temperature T_gas_ref and pressure P_gas_ref. This method is only available when the phase is linked to an EquilibriumStream. This method totally ignores phase equilibrium.
- Returns
- Qgs
float
Ideal gas flow rates of the components in the phase, [m^3/s]
- Qgs
- property Qgs_calc¶
Method to return the volume flow rate of each component in this phase as an ideal gas, using the configured temperature T_gas_ref and pressure P_gas_ref. This method is only available when the phase is linked to an EquilibriumStream. This method totally ignores phase equilibrium.
- Returns
- Qgs
float
Ideal gas flow rates of the components in the phase, [m^3/s]
- Qgs
- property Ql¶
Method to return the volume flow rate of this phase as an ideal liquid, using the configured standard molar volumes Vml_STPs. This method is only available when the phase is linked to an EquilibriumStream. This method totally ignores phase equilibrium.
- Returns
- Ql
float
Ideal liquid flow rate of the phase, [m^3/s]
- Ql
- property Ql_calc¶
Method to return the volume flow rate of this phase as an ideal liquid, using the configured standard molar volumes Vml_STPs. This method is only available when the phase is linked to an EquilibriumStream. This method totally ignores phase equilibrium.
- Returns
- Ql
float
Ideal liquid flow rate of the phase, [m^3/s]
- Ql
- property Qls¶
Method to return the volume flow rate of each component in this phase as an ideal liquid, using the configured V_liquids_ref. This method is only available when the phase is linked to an EquilibriumStream. This method totally ignores phase equilibrium.
- Returns
- Qls
float
Ideal liquid flow rates of the components in the phase, [m^3/s]
- Qls
- property Qls_calc¶
Method to return the volume flow rate of each component in this phase as an ideal liquid, using the configured V_liquids_ref. This method is only available when the phase is linked to an EquilibriumStream. This method totally ignores phase equilibrium.
- Returns
- Qls
float
Ideal liquid flow rates of the components in the phase, [m^3/s]
- Qls
- property RI_Ts¶
Temperatures at which the refractive indexes were reported for each component, [K].
- property RIs¶
Refractive indexes for each component, [-].
- Radium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Radium, [atoms/s]
- Radium_atom_flow()¶
Method to calculate and return the mole flow that is Radium, [mol/s]
- Radium_atom_fraction()¶
Method to calculate and return the mole fraction that is Radium element, [-]
- Radium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Radium element, [kg/s]
- Radium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Radium element, [-]
- Radon_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Radon, [atoms/s]
- Radon_atom_flow()¶
Method to calculate and return the mole flow that is Radon, [mol/s]
- Radon_atom_fraction()¶
Method to calculate and return the mole fraction that is Radon element, [-]
- Radon_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Radon element, [kg/s]
- Radon_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Radon element, [-]
- Rhenium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Rhenium, [atoms/s]
- Rhenium_atom_flow()¶
Method to calculate and return the mole flow that is Rhenium, [mol/s]
- Rhenium_atom_fraction()¶
Method to calculate and return the mole fraction that is Rhenium element, [-]
- Rhenium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Rhenium element, [kg/s]
- Rhenium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Rhenium element, [-]
- Rhodium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Rhodium, [atoms/s]
- Rhodium_atom_flow()¶
Method to calculate and return the mole flow that is Rhodium, [mol/s]
- Rhodium_atom_fraction()¶
Method to calculate and return the mole fraction that is Rhodium element, [-]
- Rhodium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Rhodium element, [kg/s]
- Rhodium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Rhodium element, [-]
- Roentgenium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Roentgenium, [atoms/s]
- Roentgenium_atom_flow()¶
Method to calculate and return the mole flow that is Roentgenium, [mol/s]
- Roentgenium_atom_fraction()¶
Method to calculate and return the mole fraction that is Roentgenium element, [-]
- Roentgenium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Roentgenium element, [kg/s]
- Roentgenium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Roentgenium element, [-]
- Rubidium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Rubidium, [atoms/s]
- Rubidium_atom_flow()¶
Method to calculate and return the mole flow that is Rubidium, [mol/s]
- Rubidium_atom_fraction()¶
Method to calculate and return the mole fraction that is Rubidium element, [-]
- Rubidium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Rubidium element, [kg/s]
- Rubidium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Rubidium element, [-]
- Ruthenium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Ruthenium, [atoms/s]
- Ruthenium_atom_flow()¶
Method to calculate and return the mole flow that is Ruthenium, [mol/s]
- Ruthenium_atom_fraction()¶
Method to calculate and return the mole fraction that is Ruthenium element, [-]
- Ruthenium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Ruthenium element, [kg/s]
- Ruthenium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Ruthenium element, [-]
- Rutherfordium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Rutherfordium, [atoms/s]
- Rutherfordium_atom_flow()¶
Method to calculate and return the mole flow that is Rutherfordium, [mol/s]
- Rutherfordium_atom_fraction()¶
Method to calculate and return the mole fraction that is Rutherfordium element, [-]
- Rutherfordium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Rutherfordium element, [kg/s]
- Rutherfordium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Rutherfordium element, [-]
- S()¶
Method to calculate and return the constant-temperature and constant phase-fraction entropy of the bulk phase. This is a phase-fraction weighted calculation.
- Returns
- S
float
Molar entropy, [J/(mol*K)]
- S
- property S0gs¶
Ideal gas absolute molar entropies at 298.15 K at 1 atm for each component, [J/(mol*K)].
- property S0gs_mass¶
Ideal gas absolute entropies at 298.15 K at 1 atm for each component, [J/(kg*K)].
- SG(phase=None)[source]¶
Method to calculate and return the standard liquid specific gravity of the phase, using constant liquid pure component densities not calculated by the phase object, at 60 °F.
- Returns
- SG
float
Specific gravity of the liquid, [-]
- SG
Notes
The reference density of water is from the IAPWS-95 standard - 999.0170824078306 kg/m^3.
- SG_gas(phase=None)[source]¶
Method to calculate and return the specific gravity of the phase with respect to a gas reference density.
- Returns
- SG_gas
float
Specific gravity of the gas, [-]
- SG_gas
Notes
The reference molecular weight of air used is 28.9586 g/mol.
- property STELs¶
Short term exposure limits to chemicals (and their units; ppm or mg/m^3), [various].
- S_dep(phase=None)[source]¶
Method to calculate and return the difference between the actual S and the ideal-gas entropy of the phase.
- Returns
- S_dep
float
Departure entropy, [J/(mol*K)]
- S_dep
- S_dep_flow(phase=None)[source]¶
Method to return the flow rate of the difference between the ideal-gas entropy of this phase and the actual entropy of the phase This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- S_dep_flow
float
Flow rate of departure entropy, [J/(K*s)]
- S_dep_flow
- S_dep_mass()¶
Method to calculate and return the mass departure entropy of the phase.
- Returns
- S_dep_mass
float
Departure mass entropy free energy, [J/(kg*K)]
- S_dep_mass
- S_flow(phase=None)[source]¶
Method to return the flow rate of entropy of this phase. This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- S_flow
float
Flow rate of entropy, [J/(K*s)]
- S_flow
- S_formation_ideal_gas(phase=None)[source]¶
Method to calculate and return the ideal-gas entropy of formation of the phase (as if the phase was an ideal gas).
- Returns
- S_formation_ideal_gas
float
Entropy of formation of the phase on a reactive basis as an ideal gas, [J/(mol*K)]
- S_formation_ideal_gas
- S_formation_ideal_gas_mass()¶
Method to calculate and return the mass ideal-gas formation entropy of the phase.
- Returns
- S_formation_ideal_gas_mass
float
Formation mass entropy, [J/(kg*K)]
- S_formation_ideal_gas_mass
- S_ideal_gas(phase=None)[source]¶
Method to calculate and return the ideal-gas entropy of the phase.
- Returns
- S
float
Ideal gas molar entropy, [J/(mol*K)]
- S
- S_ideal_gas_mass()¶
Method to calculate and return the mass ideal-gas entropy of the phase.
- Returns
- S_ideal_gas_mass
float
Ideal gas mass entropy, [J/(kg*K)]
- S_ideal_gas_mass
- S_ideal_gas_standard_state()¶
- S_mass(phase=None)[source]¶
Method to calculate and return mass entropy of the phase.
- Returns
- S_mass
float
Mass enthalpy, [J/(kg*K)]
- S_mass
- S_reactive()¶
Method to calculate and return the constant-temperature and constant phase-fraction reactive entropy of the bulk phase. This is a phase-fraction weighted calculation.
- Returns
- S_reactive
float
Reactive molar entropy, [J/(mol*K)]
- S_reactive
- S_reactive_mass()¶
Method to calculate and return mass entropy on a reactive basis of the phase.
- Returns
- S_reactive_mass
float
Mass entropy on a reactive basis, [J/(kg*K)]
- S_reactive_mass
- Samarium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Samarium, [atoms/s]
- Samarium_atom_flow()¶
Method to calculate and return the mole flow that is Samarium, [mol/s]
- Samarium_atom_fraction()¶
Method to calculate and return the mole fraction that is Samarium element, [-]
- Samarium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Samarium element, [kg/s]
- Samarium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Samarium element, [-]
- Scandium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Scandium, [atoms/s]
- Scandium_atom_flow()¶
Method to calculate and return the mole flow that is Scandium, [mol/s]
- Scandium_atom_fraction()¶
Method to calculate and return the mole fraction that is Scandium element, [-]
- Scandium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Scandium element, [kg/s]
- Scandium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Scandium element, [-]
- Seaborgium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Seaborgium, [atoms/s]
- Seaborgium_atom_flow()¶
Method to calculate and return the mole flow that is Seaborgium, [mol/s]
- Seaborgium_atom_fraction()¶
Method to calculate and return the mole fraction that is Seaborgium element, [-]
- Seaborgium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Seaborgium element, [kg/s]
- Seaborgium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Seaborgium element, [-]
- Selenium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Selenium, [atoms/s]
- Selenium_atom_flow()¶
Method to calculate and return the mole flow that is Selenium, [mol/s]
- Selenium_atom_fraction()¶
Method to calculate and return the mole fraction that is Selenium element, [-]
- Selenium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Selenium element, [kg/s]
- Selenium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Selenium element, [-]
- property Sfgs¶
Ideal gas standard molar entropies of formation for each component, [J/(mol*K)].
- property Sfgs_mass¶
Ideal gas standard entropies of formation for each component, [J/(kg*K)].
- Silicon_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Silicon, [atoms/s]
- Silicon_atom_flow()¶
Method to calculate and return the mole flow that is Silicon, [mol/s]
- Silicon_atom_fraction()¶
Method to calculate and return the mole fraction that is Silicon element, [-]
- Silicon_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Silicon element, [kg/s]
- Silicon_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Silicon element, [-]
- Silver_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Silver, [atoms/s]
- Silver_atom_flow()¶
Method to calculate and return the mole flow that is Silver, [mol/s]
- Silver_atom_fraction()¶
Method to calculate and return the mole fraction that is Silver element, [-]
- Silver_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Silver element, [kg/s]
- Silver_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Silver element, [-]
- property Skins¶
Whether each compound can be absorbed through the skin or not, [-].
- Sodium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Sodium, [atoms/s]
- Sodium_atom_flow()¶
Method to calculate and return the mole flow that is Sodium, [mol/s]
- Sodium_atom_fraction()¶
Method to calculate and return the mole fraction that is Sodium element, [-]
- Sodium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Sodium element, [kg/s]
- Sodium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Sodium element, [-]
- Ss_ideal_gas_standard_state()¶
- property StielPolars¶
Stiel polar factors for each component, [-].
- property Stockmayers¶
Lennard-Jones Stockmayer parameters (depth of potential-energy minimum over k) for each component, [K].
- Strontium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Strontium, [atoms/s]
- Strontium_atom_flow()¶
Method to calculate and return the mole flow that is Strontium, [mol/s]
- Strontium_atom_fraction()¶
Method to calculate and return the mole fraction that is Strontium element, [-]
- Strontium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Strontium element, [kg/s]
- Strontium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Strontium element, [-]
- property SublimationPressures¶
Wrapper to obtain the list of SublimationPressures objects of the associated
PropertyCorrelationsPackage
.
- Sulfur_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Sulfur, [atoms/s]
- Sulfur_atom_flow()¶
Method to calculate and return the mole flow that is Sulfur, [mol/s]
- Sulfur_atom_fraction()¶
Method to calculate and return the mole fraction that is Sulfur element, [-]
- Sulfur_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Sulfur element, [kg/s]
- Sulfur_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Sulfur element, [-]
- property SurfaceTensionMixture¶
Wrapper to obtain the list of SurfaceTensionMixture objects of the associated
PropertyCorrelationsPackage
.
- property SurfaceTensions¶
Wrapper to obtain the list of SurfaceTensions objects of the associated
PropertyCorrelationsPackage
.
- T¶
- property TWAs¶
Time-weighted average exposure limits to chemicals (and their units; ppm or mg/m^3), [various].
- T_REF_IG = 298.15¶
- T_REF_IG_INV = 0.0033540164346805303¶
- property T_calc¶
- Tantalum_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Tantalum, [atoms/s]
- Tantalum_atom_flow()¶
Method to calculate and return the mole flow that is Tantalum, [mol/s]
- Tantalum_atom_fraction()¶
Method to calculate and return the mole fraction that is Tantalum element, [-]
- Tantalum_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Tantalum element, [kg/s]
- Tantalum_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Tantalum element, [-]
- property Tautoignitions¶
Autoignition temperatures for each component, [K].
- property Tbs¶
Boiling temperatures for each component, [K].
- property Tcs¶
Critical temperatures for each component, [K].
- Technetium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Technetium, [atoms/s]
- Technetium_atom_flow()¶
Method to calculate and return the mole flow that is Technetium, [mol/s]
- Technetium_atom_fraction()¶
Method to calculate and return the mole fraction that is Technetium element, [-]
- Technetium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Technetium element, [kg/s]
- Technetium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Technetium element, [-]
- Tellurium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Tellurium, [atoms/s]
- Tellurium_atom_flow()¶
Method to calculate and return the mole flow that is Tellurium, [mol/s]
- Tellurium_atom_fraction()¶
Method to calculate and return the mole fraction that is Tellurium element, [-]
- Tellurium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Tellurium element, [kg/s]
- Tellurium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Tellurium element, [-]
- Tennessine_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Tennessine, [atoms/s]
- Tennessine_atom_flow()¶
Method to calculate and return the mole flow that is Tennessine, [mol/s]
- Tennessine_atom_fraction()¶
Method to calculate and return the mole fraction that is Tennessine element, [-]
- Tennessine_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Tennessine element, [kg/s]
- Tennessine_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Tennessine element, [-]
- Terbium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Terbium, [atoms/s]
- Terbium_atom_flow()¶
Method to calculate and return the mole flow that is Terbium, [mol/s]
- Terbium_atom_fraction()¶
Method to calculate and return the mole fraction that is Terbium element, [-]
- Terbium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Terbium element, [kg/s]
- Terbium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Terbium element, [-]
- property Tflashs¶
Flash point temperatures for each component, [K].
- Thallium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Thallium, [atoms/s]
- Thallium_atom_flow()¶
Method to calculate and return the mole flow that is Thallium, [mol/s]
- Thallium_atom_fraction()¶
Method to calculate and return the mole fraction that is Thallium element, [-]
- Thallium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Thallium element, [kg/s]
- Thallium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Thallium element, [-]
- property ThermalConductivityGasMixture¶
Wrapper to obtain the list of ThermalConductivityGasMixture objects of the associated
PropertyCorrelationsPackage
.
- property ThermalConductivityGases¶
Wrapper to obtain the list of ThermalConductivityGases objects of the associated
PropertyCorrelationsPackage
.
- property ThermalConductivityLiquidMixture¶
Wrapper to obtain the list of ThermalConductivityLiquidMixture objects of the associated
PropertyCorrelationsPackage
.
- property ThermalConductivityLiquids¶
Wrapper to obtain the list of ThermalConductivityLiquids objects of the associated
PropertyCorrelationsPackage
.
- property ThermalConductivitySolids¶
Wrapper to obtain the list of ThermalConductivitySolids objects of the associated
PropertyCorrelationsPackage
.
- Thorium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Thorium, [atoms/s]
- Thorium_atom_flow()¶
Method to calculate and return the mole flow that is Thorium, [mol/s]
- Thorium_atom_fraction()¶
Method to calculate and return the mole fraction that is Thorium element, [-]
- Thorium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Thorium element, [kg/s]
- Thorium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Thorium element, [-]
- Thulium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Thulium, [atoms/s]
- Thulium_atom_flow()¶
Method to calculate and return the mole flow that is Thulium, [mol/s]
- Thulium_atom_fraction()¶
Method to calculate and return the mole fraction that is Thulium element, [-]
- Thulium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Thulium element, [kg/s]
- Thulium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Thulium element, [-]
- Tin_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Tin, [atoms/s]
- Tin_atom_flow()¶
Method to calculate and return the mole flow that is Tin, [mol/s]
- Tin_atom_fraction()¶
Method to calculate and return the mole fraction that is Tin element, [-]
- Tin_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Tin element, [kg/s]
- Tin_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Tin element, [-]
- Titanium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Titanium, [atoms/s]
- Titanium_atom_flow()¶
Method to calculate and return the mole flow that is Titanium, [mol/s]
- Titanium_atom_fraction()¶
Method to calculate and return the mole fraction that is Titanium element, [-]
- Titanium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Titanium element, [kg/s]
- Titanium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Titanium element, [-]
- Tmc(phase=None)[source]¶
Method to calculate and return the mechanical critical temperature of the phase.
- Returns
- Tmc
float
Mechanical critical temperature, [K]
- Tmc
- property Tms¶
Melting temperatures for each component, [K].
- property Tts¶
Triple point temperatures for each component, [K].
- Tungsten_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Tungsten, [atoms/s]
- Tungsten_atom_flow()¶
Method to calculate and return the mole flow that is Tungsten, [mol/s]
- Tungsten_atom_fraction()¶
Method to calculate and return the mole fraction that is Tungsten element, [-]
- Tungsten_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Tungsten element, [kg/s]
- Tungsten_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Tungsten element, [-]
- U()¶
Method to calculate and return the internal energy of the phase.
- Returns
- U
float
Internal energy, [J/mol]
- U
- property UFLs¶
Upper flammability limits for each component, [-].
- property UNIFAC_Dortmund_groups¶
UNIFAC_Dortmund_group: count groups for each component, [-].
- property UNIFAC_Qs¶
UNIFAC Q parameters for each component, [-].
- property UNIFAC_Rs¶
UNIFAC R parameters for each component, [-].
- property UNIFAC_groups¶
UNIFAC_group: count groups for each component, [-].
- U_dep()¶
Method to calculate and return the departure internal energy of the phase.
- Returns
- U_dep
float
Departure internal energy, [J/mol]
- U_dep
- U_dep_flow(phase=None)[source]¶
Method to return the flow rate of the difference between the ideal-gas internal energy of this phase and the actual internal energy of the phase This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- U_dep_flow
float
Flow rate of departure internal energy, [J/s]
- U_dep_flow
- U_dep_mass()¶
Method to calculate and return the departure mass internal energy of the phase.
- Returns
- U_dep_mass
float
Departure mass internal energy, [J/kg]
- U_dep_mass
- U_flow(phase=None)[source]¶
Method to return the flow rate of internal energy of this phase. This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- U_flow
float
Flow rate of internal energy, [J/s]
- U_flow
- U_formation_ideal_gas(phase=None)[source]¶
Method to calculate and return the ideal-gas internal energy of formation of the phase (as if the phase was an ideal gas).
- Returns
- U_formation_ideal_gas
float
Internal energy of formation of the phase on a reactive basis as an ideal gas, [J/(mol)]
- U_formation_ideal_gas
- U_formation_ideal_gas_mass()¶
Method to calculate and return the ideal-gas formation mass internal energy of the phase.
- Returns
- U_formation_ideal_gas_mass
float
Formation mass internal energy, [J/kg]
- U_formation_ideal_gas_mass
- U_ideal_gas(phase=None)[source]¶
Method to calculate and return the ideal-gas internal energy of the phase.
- Returns
- U_ideal_gas
float
Ideal gas internal energy, [J/(mol)]
- U_ideal_gas
- U_ideal_gas_mass()¶
Method to calculate and return the mass ideal-gas internal energy of the phase.
- Returns
- U_ideal_gas_mass
float
Ideal gas mass internal energy, [J/(kg)]
- U_ideal_gas_mass
- U_mass(phase=None)[source]¶
Method to calculate and return mass internal energy of the phase.
- Returns
- U_mass
float
Mass internal energy, [J/(kg)]
- U_mass
- U_reactive()¶
Method to calculate and return the internal energy of the phase on a reactive basis.
- Returns
- U_reactive
float
Internal energy of the phase on a reactive basis, [J/(mol)]
- U_reactive
- U_reactive_mass()¶
Method to calculate and return mass internal energy on a reactive basis of the phase.
- Returns
- U_reactive_mass
float
Mass internal energy on a reactive basis, [J/kg]
- U_reactive_mass
- Uranium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Uranium, [atoms/s]
- Uranium_atom_flow()¶
Method to calculate and return the mole flow that is Uranium, [mol/s]
- Uranium_atom_fraction()¶
Method to calculate and return the mole fraction that is Uranium element, [-]
- Uranium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Uranium element, [kg/s]
- Uranium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Uranium element, [-]
- V()¶
Method to calculate and return the molar volume of the bulk phase. This is a phase-fraction weighted calculation.
- Returns
- V
float
Molar volume, [m^3/mol]
- V
- property VF¶
Method to return the vapor fraction of the equilibrium state. If no vapor/gas is present, 0 is always returned.
- Returns
- VF
float
Vapor molar fraction, [-]
- VF
- property VF_calc¶
- V_dep()¶
Method to calculate and return the departure (from ideal gas behavior) molar volume of the phase.
- Returns
- V_dep
float
Departure molar volume, [m^3/mol]
- V_dep
- V_gas(phase=None)[source]¶
Method to calculate and return the ideal-gas molar volume of the phase at the chosen reference temperature and pressure, according to the temperature variable T_gas_ref and pressure variable P_gas_ref of the
thermo.bulk.BulkSettings
.- Returns
- V_gas
float
Ideal gas molar volume at the reference temperature and pressure, [m^3/mol]
- V_gas
- V_gas_normal(phase=None)[source]¶
Method to calculate and return the ideal-gas molar volume of the phase at the normal temperature and pressure, according to the temperature variable T_normal and pressure variable P_normal of the
thermo.bulk.BulkSettings
.- Returns
- V_gas_normal
float
Ideal gas molar volume at normal temperature and pressure, [m^3/mol]
- V_gas_normal
- V_gas_standard(phase=None)[source]¶
Method to calculate and return the ideal-gas molar volume of the phase at the standard temperature and pressure, according to the temperature variable T_standard and pressure variable P_standard of the
thermo.bulk.BulkSettings
.- Returns
- V_gas_standard
float
Ideal gas molar volume at standard temperature and pressure, [m^3/mol]
- V_gas_standard
- V_ideal_gas(phase=None)[source]¶
Method to calculate and return the ideal-gas molar volume of the phase.
- Returns
- V
float
Ideal gas molar volume, [m^3/mol]
- V
- V_iter(phase=None, force=False)[source]¶
Method to calculate and return the volume of the phase in a way suitable for a TV resolution to converge on the same pressure. This often means the return value of this method is an mpmath mpf. This dummy method simply returns the implemented V method.
- Returns
- V
float
ormpf
Molar volume, [m^3/mol]
- V
- V_liquid_ref(phase=None)[source]¶
Method to calculate and return the liquid reference molar volume according to the temperature variable T_liquid_volume_ref of
thermo.bulk.BulkSettings
and the composition of the phase.- Returns
- V_liquid_ref
float
Liquid molar volume at the reference condition, [m^3/mol]
- V_liquid_ref
- V_liquids_ref()[source]¶
Method to calculate and return the liquid reference molar volumes according to the temperature variable T_liquid_volume_ref of
thermo.bulk.BulkSettings
.
- V_mass(phase=None)[source]¶
Method to calculate and return the specific volume of the phase.
- Returns
- V_mass
float
Specific volume of the phase, [m^3/kg]
- V_mass
- property Van_der_Waals_areas¶
Unnormalized Van der Waals areas for each component, [m^2/mol].
- property Van_der_Waals_volumes¶
Unnormalized Van der Waals volumes for each component, [m^3/mol].
- Vanadium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Vanadium, [atoms/s]
- Vanadium_atom_flow()¶
Method to calculate and return the mole flow that is Vanadium, [mol/s]
- Vanadium_atom_fraction()¶
Method to calculate and return the mole fraction that is Vanadium element, [-]
- Vanadium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Vanadium element, [kg/s]
- Vanadium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Vanadium element, [-]
- property VaporPressures¶
Wrapper to obtain the list of VaporPressures objects of the associated
PropertyCorrelationsPackage
.
- property Vcs¶
Critical molar volumes for each component, [m^3/mol].
- Vfgs(phase=None)[source]¶
Method to calculate and return the ideal-gas volume fractions of the components of the phase. This is the same as the mole fractions.
- property Vfgs_calc¶
- Vfls(phase=None)[source]¶
Method to calculate and return the ideal-liquid volume fractions of the components of the phase, using the standard liquid densities at the temperature variable T_liquid_volume_ref of
thermo.bulk.BulkSettings
and the composition of the phase.
- property Vfls_calc¶
- property ViscosityGasMixture¶
Wrapper to obtain the list of ViscosityGasMixture objects of the associated
PropertyCorrelationsPackage
.
- property ViscosityGases¶
Wrapper to obtain the list of ViscosityGases objects of the associated
PropertyCorrelationsPackage
.
- property ViscosityLiquidMixture¶
Wrapper to obtain the list of ViscosityLiquidMixture objects of the associated
PropertyCorrelationsPackage
.
- property ViscosityLiquids¶
Wrapper to obtain the list of ViscosityLiquids objects of the associated
PropertyCorrelationsPackage
.
- Vls()[source]¶
Method to calculate and return the pure-component liquid temperature-dependent molar volume of each species from the
thermo.volume.VolumeLiquid
objects.These values are normally along the saturation line.
- Vmc(phase=None)[source]¶
Method to calculate and return the mechanical critical volume of the phase.
- Returns
- Vmc
float
Mechanical critical volume, [m^3/mol]
- Vmc
- property Vmg_STPs¶
Gas molar volumes for each component at STP; metastable if normally another state, [m^3/mol].
- property Vml_60Fs¶
Liquid molar volumes for each component at 60 °F, [m^3/mol].
- property Vml_STPs¶
Liquid molar volumes for each component at STP, [m^3/mol].
- property Vml_Tms¶
Liquid molar volumes for each component at their respective melting points, [m^3/mol].
- property Vms_Tms¶
Solid molar volumes for each component at their respective melting points, [m^3/mol].
- property VolumeGasMixture¶
Wrapper to obtain the list of VolumeGasMixture objects of the associated
PropertyCorrelationsPackage
.
- property VolumeGases¶
Wrapper to obtain the list of VolumeGases objects of the associated
PropertyCorrelationsPackage
.
- property VolumeLiquidMixture¶
Wrapper to obtain the list of VolumeLiquidMixture objects of the associated
PropertyCorrelationsPackage
.
- property VolumeLiquids¶
Wrapper to obtain the list of VolumeLiquids objects of the associated
PropertyCorrelationsPackage
.
- property VolumeSolidMixture¶
Wrapper to obtain the list of VolumeSolidMixture objects of the associated
PropertyCorrelationsPackage
.
- property VolumeSolids¶
Wrapper to obtain the list of VolumeSolids objects of the associated
PropertyCorrelationsPackage
.
- Vss()[source]¶
Method to calculate and return the pure-component solid temperature-dependent molar volume of each species from the
thermo.volume.VolumeSolid
objects.
- Wobbe_index(phase=None)[source]¶
Method to calculate and return the molar Wobbe index of the object, [J/mol].
- Returns
- Wobbe_index
float
Molar Wobbe index, [J/(mol)]
- Wobbe_index
- Wobbe_index_lower(phase=None)[source]¶
- Method to calculate and return the molar lower Wobbe index of the
object, [J/mol].
- Returns
- Wobbe_index_lower
float
Molar lower Wobbe index, [J/(mol)]
- Wobbe_index_lower
- Wobbe_index_lower_mass(phase=None)[source]¶
Method to calculate and return the lower mass Wobbe index of the object, [J/kg].
- Returns
- Wobbe_index_lower_mass
float
Mass lower Wobbe index, [J/(kg)]
- Wobbe_index_lower_mass
- Wobbe_index_lower_normal(phase=None)[source]¶
Method to calculate and return the volumetric normal lower Wobbe index of the object, [J/m^3]. The normal gas volume is used in this calculation.
- Returns
- Wobbe_index_lower_normal
float
Volumetric normal lower Wobbe index, [J/(m^3)]
- Wobbe_index_lower_normal
- Wobbe_index_lower_standard(phase=None)[source]¶
Method to calculate and return the volumetric standard lower Wobbe index of the object, [J/m^3]. The standard gas volume is used in this calculation.
- Returns
- Wobbe_index_lower_standard
float
Volumetric standard lower Wobbe index, [J/(m^3)]
- Wobbe_index_lower_standard
- Wobbe_index_mass(phase=None)[source]¶
Method to calculate and return the mass Wobbe index of the object, [J/kg].
- Returns
- Wobbe_index_mass
float
Mass Wobbe index, [J/(kg)]
- Wobbe_index_mass
- Wobbe_index_normal(phase=None)[source]¶
Method to calculate and return the volumetric normal Wobbe index of the object, [J/m^3]. The normal gas volume is used in this calculation.
- Returns
- Wobbe_index
float
Volumetric normal Wobbe index, [J/(m^3)]
- Wobbe_index
- Wobbe_index_standard(phase=None)[source]¶
Method to calculate and return the volumetric standard Wobbe index of the object, [J/m^3]. The standard gas volume is used in this calculation.
- Returns
- Wobbe_index_standard
float
Volumetric standard Wobbe index, [J/(m^3)]
- Wobbe_index_standard
- Xenon_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Xenon, [atoms/s]
- Xenon_atom_flow()¶
Method to calculate and return the mole flow that is Xenon, [mol/s]
- Xenon_atom_fraction()¶
Method to calculate and return the mole fraction that is Xenon element, [-]
- Xenon_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Xenon element, [kg/s]
- Xenon_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Xenon element, [-]
- Ytterbium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Ytterbium, [atoms/s]
- Ytterbium_atom_flow()¶
Method to calculate and return the mole flow that is Ytterbium, [mol/s]
- Ytterbium_atom_fraction()¶
Method to calculate and return the mole fraction that is Ytterbium element, [-]
- Ytterbium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Ytterbium element, [kg/s]
- Ytterbium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Ytterbium element, [-]
- Yttrium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Yttrium, [atoms/s]
- Yttrium_atom_flow()¶
Method to calculate and return the mole flow that is Yttrium, [mol/s]
- Yttrium_atom_fraction()¶
Method to calculate and return the mole fraction that is Yttrium element, [-]
- Yttrium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Yttrium element, [kg/s]
- Yttrium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Yttrium element, [-]
- Z()¶
Method to calculate and return the compressibility factor of the phase.
- Returns
- Z
float
Compressibility factor, [-]
- Z
- property Zcs¶
Critical compressibilities for each component, [-].
- Zinc_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Zinc, [atoms/s]
- Zinc_atom_flow()¶
Method to calculate and return the mole flow that is Zinc, [mol/s]
- Zinc_atom_fraction()¶
Method to calculate and return the mole fraction that is Zinc element, [-]
- Zinc_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Zinc element, [kg/s]
- Zinc_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Zinc element, [-]
- Zirconium_atom_count_flow()¶
Method to calculate and return the number of atoms in the flow which are Zirconium, [atoms/s]
- Zirconium_atom_flow()¶
Method to calculate and return the mole flow that is Zirconium, [mol/s]
- Zirconium_atom_fraction()¶
Method to calculate and return the mole fraction that is Zirconium element, [-]
- Zirconium_atom_mass_flow()¶
Method to calculate and return the mass flow of atoms that are Zirconium element, [kg/s]
- Zirconium_atom_mass_fraction()¶
Method to calculate and return the mass fraction of the phase that is Zirconium element, [-]
- Zmc(phase=None)[source]¶
Method to calculate and return the mechanical critical compressibility of the phase.
- Returns
- Zmc
float
Mechanical critical compressibility, [-]
- Zmc
- activities(phase=None)¶
- property aliases¶
Aliases for each component, [-].
- alpha()¶
Method to calculate and return the thermal diffusivity of the phase.
- Returns
- alpha
float
Thermal diffusivity, [m^2/s]
- alpha
- ammonia_molar_weight()¶
Method to calculate and return the effective quantiy of ammonia in the phase as a molar weight, [g/mol].
This is the molecular weight of the phase times the mass fraction of the ammonia component.
- ammonia_partial_pressure()¶
Method to calculate and return the ideal partial pressure of ammonia, [Pa]
- argon_molar_weight()¶
Method to calculate and return the effective quantiy of argon in the phase as a molar weight, [g/mol].
This is the molecular weight of the phase times the mass fraction of the argon component.
- argon_partial_pressure()¶
Method to calculate and return the ideal partial pressure of argon, [Pa]
- atom_content(phase=None)[source]¶
Method to calculate and return the number of moles of each atom in the phase per mole of the phase; returns a dictionary of atom counts, containing only those elements who are present.
- atom_count_flows(phase=None)[source]¶
Method to calculate and return the atom count flow rates of the phase; returns a dictionary of atom count flows, containing only those elements who are present.
- atom_flows(phase=None)[source]¶
Method to calculate and return the atomic flow rates of the phase; returns a dictionary of atom flows, containing only those elements who are present.
- atom_fractions(phase=None)[source]¶
Method to calculate and return the atomic composition of the phase; returns a dictionary of atom fraction (by count), containing only those elements who are present.
- atom_mass_flows(phase=None)[source]¶
Method to calculate and return the atomic mass flow rates of the phase; returns a dictionary of atom mass flows, containing only those elements who are present.
- atom_mass_fractions(phase=None)[source]¶
Method to calculate and return the atomic mass fractions of the phase; returns a dictionary of atom fraction (by mass), containing only those elements who arxe present.
- property atomss¶
Breakdown of each component into its elements and their counts, as a dict, [-].
- betas¶
- property betas_liquids¶
Method to calculate and return the fraction of the liquid phase that each liquid phase is, by molar phase fraction. If the system is VLLL with phase fractions of 0.125 vapor, and [.25, .125, .5] for the three liquids phases respectively, the return value would be [0.28571428, 0.142857142, 0.57142857].
- property betas_mass¶
Method to calculate and return the mass fraction of all of the phases in the system.
- property betas_mass_liquids¶
Method to calculate and return the fraction of the liquid phase that each liquid phase is, by mass phase fraction. If the system is VLLL with mass phase fractions of 0.125 vapor, and [.25, .125, .5] for the three liquids phases respectively, the return value would be [0.28571428, 0.142857142, 0.57142857].
- property betas_mass_states¶
Method to return the mass phase fractions of each of the three fundamental types of phases.
- property betas_states¶
Method to return the molar phase fractions of each of the three fundamental types of phases.
- property betas_volume¶
Method to calculate and return the volume fraction of all of the phases in the system.
- property betas_volume_liquid_ref¶
Method to calculate and return the standard liquid volume fraction of all of the phases in the bulk.
- property betas_volume_liquids¶
Method to calculate and return the fraction of the liquid phase that each liquid phase is, by volume phase fraction. If the system is VLLL with volume phase fractions of 0.125 vapor, and [.25, .125, .5] for the three liquids phases respectively, the return value would be [0.28571428, 0.142857142, 0.57142857].
- property betas_volume_states¶
Method to return the volume phase fractions of each of the three fundamental types of phases.
- bulk¶
- carbon_dioxide_molar_weight()¶
Method to calculate and return the effective quantiy of carbon_dioxide in the phase as a molar weight, [g/mol].
This is the molecular weight of the phase times the mass fraction of the carbon_dioxide component.
- carbon_dioxide_partial_pressure()¶
Method to calculate and return the ideal partial pressure of carbon_dioxide, [Pa]
- property charges¶
Charge number (valence) for each component, [-].
- concentrations()¶
Method to return the molar concentrations of each component in the phase in units of mol/m^3. Molarity is a term used in chemistry for a similar concept, usually given in units of mol/L.
- concentrations_gas()¶
Method to return the molar concentrations of each component in the phase in units of mol/m^3, using the ideal-gas molar volume of the phase at the chosen reference temperature and pressure.
- concentrations_gas_normal()¶
Method to return the molar concentrations of each component in the phase in units of mol/m^3, using the ideal-gas molar volume of the phase at the normal temperature and pressure.
- concentrations_gas_standard()¶
Method to return the molar concentrations of each component in the phase in units of mol/m^3, using the ideal-gas molar volume of the phase at the standard temperature and pressure.
- concentrations_mass()¶
Method to return the mass concentrations of each component in the phase in units of kg/m^3.
- concentrations_mass_gas()¶
Method to return the mass concentrations of each component in the phase in units of kg/m^3, using the ideal-gas molar volume of the phase at the chosen reference temperature and pressure.
- concentrations_mass_gas_normal()¶
Method to return the mass concentrations of each component in the phase in units of kg/m^3, using the ideal-gas molar volume of the phase at the normal temperature and pressure.
- concentrations_mass_gas_standard()¶
Method to return the mass concentrations of each component in the phase in units of kg/m^3, using the ideal-gas molar volume of the phase at the standard temperature and pressure.
- property conductivities¶
Electrical conductivities for each component, [S/m].
- property conductivity_Ts¶
Temperatures at which the electrical conductivities for each component were measured, [K].
- constants¶
- correlations¶
- d2G_dP2()¶
- d2G_dPdT()¶
- d2G_dT2()¶
- d2G_dTdP()¶
- d2G_mass_dP2()¶
- d2G_mass_dPdT()¶
- d2G_mass_dT2()¶
- d2G_mass_dTdP()¶
- d2P_dT2()¶
Method to calculate and return the second temperature derivative of pressure of the bulk according to the selected calculation methodology.
- Returns
- d2P_dT2
float
Second temperature derivative of pressure, [Pa/K^2]
- d2P_dT2
- d2P_dT2_frozen()¶
Method to calculate and return the second constant-volume derivative of pressure with respect to temperature of the bulk phase, at constant phase fractions and phase compositions. This is a molar phase-fraction weighted calculation.
- Returns
- d2P_dT2_frozen
float
Frozen constant-volume second derivative of pressure with respect to temperature of the bulk phase, [Pa/K^2]
- d2P_dT2_frozen
- d2P_dTdV()¶
Method to calculate and return the second derivative of pressure with respect to temperature and volume of the bulk according to the selected calculation methodology.
- Returns
- d2P_dTdV
float
Second volume derivative of pressure, [mol*Pa^2/(J*K)]
- d2P_dTdV
- d2P_dTdV_frozen()¶
Method to calculate and return the second derivative of pressure with respect to volume and temperature of the bulk phase, at constant phase fractions and phase compositions. This is a molar phase-fraction weighted calculation.
- Returns
- d2P_dTdV_frozen
float
Frozen second derivative of pressure with respect to volume and temperature of the bulk phase, [Pa*mol^2/m^6]
- d2P_dTdV_frozen
- d2P_dV2()¶
Method to calculate and return the second volume derivative of pressure of the bulk according to the selected calculation methodology.
- Returns
- d2P_dV2
float
Second volume derivative of pressure, [Pa*mol^2/m^6]
- d2P_dV2
- d2P_dV2_frozen()¶
Method to calculate and return the constant-temperature second derivative of pressure with respect to volume of the bulk phase, at constant phase fractions and phase compositions. This is a molar phase-fraction weighted calculation.
- Returns
- d2P_dV2_frozen
float
Frozen constant-temperature second derivative of pressure with respect to volume of the bulk phase, [Pa*mol^2/m^6]
- d2P_dV2_frozen
- dA_dP()¶
Method to calculate and return the constant-temperature pressure derivative of Helmholtz energy.
- Returns
- dA_dP
float
Constant-temperature pressure derivative of Helmholtz energy, [J/(mol*Pa)]
- dA_dP
- dA_dP_T()¶
Method to calculate and return the constant-temperature pressure derivative of Helmholtz energy.
- Returns
- dA_dP
float
Constant-temperature pressure derivative of Helmholtz energy, [J/(mol*Pa)]
- dA_dP
- dA_dP_V()¶
Method to calculate and return the constant-volume pressure derivative of Helmholtz energy.
- Returns
- dA_dP_V
float
Constant-volume pressure derivative of Helmholtz energy, [J/(mol*Pa)]
- dA_dP_V
- dA_dT()¶
Method to calculate and return the constant-pressure temperature derivative of Helmholtz energy.
- Returns
- dA_dT
float
Constant-pressure temperature derivative of Helmholtz energy, [J/(mol*K)]
- dA_dT
- dA_dT_P()¶
Method to calculate and return the constant-pressure temperature derivative of Helmholtz energy.
- Returns
- dA_dT
float
Constant-pressure temperature derivative of Helmholtz energy, [J/(mol*K)]
- dA_dT
- dA_dT_V()¶
Method to calculate and return the constant-volume temperature derivative of Helmholtz energy.
- Returns
- dA_dT_V
float
Constant-volume temperature derivative of Helmholtz energy, [J/(mol*K)]
- dA_dT_V
- dA_dV_P()¶
Method to calculate and return the constant-pressure volume derivative of Helmholtz energy.
- Returns
- dA_dV_P
float
Constant-pressure volume derivative of Helmholtz energy, [J/(m^3)]
- dA_dV_P
- dA_dV_T()¶
Method to calculate and return the constant-temperature volume derivative of Helmholtz energy.
- Returns
- dA_dV_T
float
Constant-temperature volume derivative of Helmholtz energy, [J/(m^3)]
- dA_dV_T
- dA_mass_dP()¶
Method to calculate and return the pressure derivative of mass Helmholtz energy of the phase at constant temperature.
- Returns
- dA_mass_dP
float
The pressure derivative of mass Helmholtz energy of the phase at constant temperature, [J/mol/Pa]
- dA_mass_dP
- dA_mass_dP_T()¶
Method to calculate and return the pressure derivative of mass Helmholtz energy of the phase at constant temperature.
- Returns
- dA_mass_dP_T
float
The pressure derivative of mass Helmholtz energy of the phase at constant temperature, [J/mol/Pa]
- dA_mass_dP_T
- dA_mass_dP_V()¶
Method to calculate and return the pressure derivative of mass Helmholtz energy of the phase at constant volume.
- Returns
- dA_mass_dP_V
float
The pressure derivative of mass Helmholtz energy of the phase at constant volume, [J/mol/Pa]
- dA_mass_dP_V
- dA_mass_dT()¶
Method to calculate and return the temperature derivative of mass Helmholtz energy of the phase at constant pressure.
- Returns
- dA_mass_dT
float
The temperature derivative of mass Helmholtz energy of the phase at constant pressure, [J/mol/K]
- dA_mass_dT
- dA_mass_dT_P()¶
Method to calculate and return the temperature derivative of mass Helmholtz energy of the phase at constant pressure.
- Returns
- dA_mass_dT_P
float
The temperature derivative of mass Helmholtz energy of the phase at constant pressure, [J/mol/K]
- dA_mass_dT_P
- dA_mass_dT_V()¶
Method to calculate and return the temperature derivative of mass Helmholtz energy of the phase at constant volume.
- Returns
- dA_mass_dT_V
float
The temperature derivative of mass Helmholtz energy of the phase at constant volume, [J/mol/K]
- dA_mass_dT_V
- dA_mass_dV_P()¶
Method to calculate and return the volume derivative of mass Helmholtz energy of the phase at constant pressure.
- Returns
- dA_mass_dV_P
float
The volume derivative of mass Helmholtz energy of the phase at constant pressure, [J/mol/m^3/mol]
- dA_mass_dV_P
- dA_mass_dV_T()¶
Method to calculate and return the volume derivative of mass Helmholtz energy of the phase at constant temperature.
- Returns
- dA_mass_dV_T
float
The volume derivative of mass Helmholtz energy of the phase at constant temperature, [J/mol/m^3/mol]
- dA_mass_dV_T
- dCv_dP_T()¶
Method to calculate the pressure derivative of Cv, constant volume heat capacity, at constant temperature.
- Returns
- dCv_dP_T
float
Pressure derivative of constant volume heat capacity at constant temperature, [J/mol/K/Pa]
- dCv_dP_T
Notes
Requires d2V_dTdP, d2P_dTdP, and d2H_dTdP.
- dCv_dT_P()¶
Method to calculate the temperature derivative of Cv, constant volume heat capacity, at constant pressure.
- Returns
- dCv_dT_P
float
Temperature derivative of constant volume heat capacity at constant pressure, [J/mol/K^2]
- dCv_dT_P
Notes
Requires d2P_dT2_PV, d2P_dVdT_TP, and d2H_dT2.
- dCv_mass_dP_T()¶
Method to calculate and return the pressure derivative of mass Constant-volume heat capacity of the phase at constant temperature.
- Returns
- dCv_mass_dP_T
float
The pressure derivative of mass Constant-volume heat capacity of the phase at constant temperature, [J/(mol*K)/Pa]
- dCv_mass_dP_T
- dCv_mass_dT_P()¶
Method to calculate and return the temperature derivative of mass Constant-volume heat capacity of the phase at constant pressure.
- Returns
- dCv_mass_dT_P
float
The temperature derivative of mass Constant-volume heat capacity of the phase at constant pressure, [J/(mol*K)/K]
- dCv_mass_dT_P
- dG_dP()¶
Method to calculate and return the constant-temperature pressure derivative of Gibbs free energy.
- Returns
- dG_dP
float
Constant-temperature pressure derivative of Gibbs free energy, [J/(mol*Pa)]
- dG_dP
- dG_dP_T()¶
Method to calculate and return the constant-temperature pressure derivative of Gibbs free energy.
- Returns
- dG_dP
float
Constant-temperature pressure derivative of Gibbs free energy, [J/(mol*Pa)]
- dG_dP
- dG_dP_V()¶
Method to calculate and return the constant-volume pressure derivative of Gibbs free energy.
- Returns
- dG_dP_V
float
Constant-volume pressure derivative of Gibbs free energy, [J/(mol*Pa)]
- dG_dP_V
- dG_dT()¶
Method to calculate and return the constant-pressure temperature derivative of Gibbs free energy.
- Returns
- dG_dT
float
Constant-pressure temperature derivative of Gibbs free energy, [J/(mol*K)]
- dG_dT
- dG_dT_P()¶
Method to calculate and return the constant-pressure temperature derivative of Gibbs free energy.
- Returns
- dG_dT
float
Constant-pressure temperature derivative of Gibbs free energy, [J/(mol*K)]
- dG_dT
- dG_dT_V()¶
Method to calculate and return the constant-volume temperature derivative of Gibbs free energy.
- Returns
- dG_dT_V
float
Constant-volume temperature derivative of Gibbs free energy, [J/(mol*K)]
- dG_dT_V
- dG_dV_P()¶
Method to calculate and return the constant-pressure volume derivative of Gibbs free energy.
- Returns
- dG_dV_P
float
Constant-pressure volume derivative of Gibbs free energy, [J/(m^3)]
- dG_dV_P
- dG_dV_T()¶
Method to calculate and return the constant-temperature volume derivative of Gibbs free energy.
- Returns
- dG_dV_T
float
Constant-temperature volume derivative of Gibbs free energy, [J/(m^3)]
- dG_dV_T
- dG_mass_dP()¶
Method to calculate and return the pressure derivative of mass Gibbs free energy of the phase at constant temperature.
- Returns
- dG_mass_dP
float
The pressure derivative of mass Gibbs free energy of the phase at constant temperature, [J/mol/Pa]
- dG_mass_dP
- dG_mass_dP_T()¶
Method to calculate and return the pressure derivative of mass Gibbs free energy of the phase at constant temperature.
- Returns
- dG_mass_dP_T
float
The pressure derivative of mass Gibbs free energy of the phase at constant temperature, [J/mol/Pa]
- dG_mass_dP_T
- dG_mass_dP_V()¶
Method to calculate and return the pressure derivative of mass Gibbs free energy of the phase at constant volume.
- Returns
- dG_mass_dP_V
float
The pressure derivative of mass Gibbs free energy of the phase at constant volume, [J/mol/Pa]
- dG_mass_dP_V
- dG_mass_dT()¶
Method to calculate and return the temperature derivative of mass Gibbs free energy of the phase at constant pressure.
- Returns
- dG_mass_dT
float
The temperature derivative of mass Gibbs free energy of the phase at constant pressure, [J/mol/K]
- dG_mass_dT
- dG_mass_dT_P()¶
Method to calculate and return the temperature derivative of mass Gibbs free energy of the phase at constant pressure.
- Returns
- dG_mass_dT_P
float
The temperature derivative of mass Gibbs free energy of the phase at constant pressure, [J/mol/K]
- dG_mass_dT_P
- dG_mass_dT_V()¶
Method to calculate and return the temperature derivative of mass Gibbs free energy of the phase at constant volume.
- Returns
- dG_mass_dT_V
float
The temperature derivative of mass Gibbs free energy of the phase at constant volume, [J/mol/K]
- dG_mass_dT_V
- dG_mass_dV_P()¶
Method to calculate and return the volume derivative of mass Gibbs free energy of the phase at constant pressure.
- Returns
- dG_mass_dV_P
float
The volume derivative of mass Gibbs free energy of the phase at constant pressure, [J/mol/m^3/mol]
- dG_mass_dV_P
- dG_mass_dV_T()¶
Method to calculate and return the volume derivative of mass Gibbs free energy of the phase at constant temperature.
- Returns
- dG_mass_dV_T
float
The volume derivative of mass Gibbs free energy of the phase at constant temperature, [J/mol/m^3/mol]
- dG_mass_dV_T
- dH_dP()¶
Method to calculate and return the pressure derivative of enthalpy of the phase at constant pressure.
- Returns
- dH_dP_T
float
Pressure derivative of enthalpy, [J/(mol*Pa)]
- dH_dP_T
- dH_dP_T()¶
Method to calculate and return the pressure derivative of enthalpy of the phase at constant pressure.
- Returns
- dH_dP_T
float
Pressure derivative of enthalpy, [J/(mol*Pa)]
- dH_dP_T
- dH_dT()¶
Method to calculate and return the constant-temperature and constant phase-fraction heat capacity of the bulk phase. This is a phase-fraction weighted calculation.
- Returns
- Cp
float
Molar heat capacity, [J/(mol*K)]
- Cp
- dH_dT_P()¶
Method to calculate and return the temperature derivative of enthalpy of the phase at constant pressure.
- Returns
- dH_dT_P
float
Temperature derivative of enthalpy, [J/(mol*K)]
- dH_dT_P
- dH_mass_dP()¶
Method to calculate and return the pressure derivative of mass enthalpy of the phase at constant temperature.
- Returns
- dH_mass_dP
float
The pressure derivative of mass enthalpy of the phase at constant temperature, [J/mol/Pa]
- dH_mass_dP
- dH_mass_dP_T()¶
Method to calculate and return the pressure derivative of mass enthalpy of the phase at constant temperature.
- Returns
- dH_mass_dP_T
float
The pressure derivative of mass enthalpy of the phase at constant temperature, [J/mol/Pa]
- dH_mass_dP_T
- dH_mass_dP_V()¶
Method to calculate and return the pressure derivative of mass enthalpy of the phase at constant volume.
- Returns
- dH_mass_dP_V
float
The pressure derivative of mass enthalpy of the phase at constant volume, [J/mol/Pa]
- dH_mass_dP_V
- dH_mass_dT()¶
Method to calculate and return the temperature derivative of mass enthalpy of the phase at constant pressure.
- Returns
- dH_mass_dT
float
The temperature derivative of mass enthalpy of the phase at constant pressure, [J/mol/K]
- dH_mass_dT
- dH_mass_dT_P()¶
Method to calculate and return the temperature derivative of mass enthalpy of the phase at constant pressure.
- Returns
- dH_mass_dT_P
float
The temperature derivative of mass enthalpy of the phase at constant pressure, [J/mol/K]
- dH_mass_dT_P
- dH_mass_dT_V()¶
Method to calculate and return the temperature derivative of mass enthalpy of the phase at constant volume.
- Returns
- dH_mass_dT_V
float
The temperature derivative of mass enthalpy of the phase at constant volume, [J/mol/K]
- dH_mass_dT_V
- dH_mass_dV_P()¶
Method to calculate and return the volume derivative of mass enthalpy of the phase at constant pressure.
- Returns
- dH_mass_dV_P
float
The volume derivative of mass enthalpy of the phase at constant pressure, [J/mol/m^3/mol]
- dH_mass_dV_P
- dH_mass_dV_T()¶
Method to calculate and return the volume derivative of mass enthalpy of the phase at constant temperature.
- Returns
- dH_mass_dV_T
float
The volume derivative of mass enthalpy of the phase at constant temperature, [J/mol/m^3/mol]
- dH_mass_dV_T
- dP_dT()¶
Method to calculate and return the first temperature derivative of pressure of the bulk according to the selected calculation methodology.
- Returns
- dP_dT
float
First temperature derivative of pressure, [Pa/K]
- dP_dT
- dP_dT_A()¶
Method to calculate and return the temperature derivative of pressure of the phase at constant Helmholtz energy.
- Returns
- dP_dT_A
float
The temperature derivative of pressure of the phase at constant Helmholtz energy, [Pa/K]
- dP_dT_A
- dP_dT_G()¶
Method to calculate and return the temperature derivative of pressure of the phase at constant Gibbs energy.
- Returns
- dP_dT_G
float
The temperature derivative of pressure of the phase at constant Gibbs energy, [Pa/K]
- dP_dT_G
- dP_dT_H()¶
Method to calculate and return the temperature derivative of pressure of the phase at constant enthalpy.
- Returns
- dP_dT_H
float
The temperature derivative of pressure of the phase at constant enthalpy, [Pa/K]
- dP_dT_H
- dP_dT_S()¶
Method to calculate and return the temperature derivative of pressure of the phase at constant entropy.
- Returns
- dP_dT_S
float
The temperature derivative of pressure of the phase at constant entropy, [Pa/K]
- dP_dT_S
- dP_dT_U()¶
Method to calculate and return the temperature derivative of pressure of the phase at constant internal energy.
- Returns
- dP_dT_U
float
The temperature derivative of pressure of the phase at constant internal energy, [Pa/K]
- dP_dT_U
- dP_dT_frozen()¶
Method to calculate and return the constant-volume derivative of pressure with respect to temperature of the bulk phase, at constant phase fractions and phase compositions. This is a molar phase-fraction weighted calculation.
- Returns
- dP_dT_frozen
float
Frozen constant-volume derivative of pressure with respect to temperature of the bulk phase, [Pa/K]
- dP_dT_frozen
- dP_dV()¶
Method to calculate and return the first volume derivative of pressure of the bulk according to the selected calculation methodology.
- Returns
- dP_dV
float
First volume derivative of pressure, [Pa*mol/m^3]
- dP_dV
- dP_dV_A()¶
Method to calculate and return the volume derivative of pressure of the phase at constant Helmholtz energy.
- Returns
- dP_dV_A
float
The volume derivative of pressure of the phase at constant Helmholtz energy, [Pa/m^3/mol]
- dP_dV_A
- dP_dV_G()¶
Method to calculate and return the volume derivative of pressure of the phase at constant Gibbs energy.
- Returns
- dP_dV_G
float
The volume derivative of pressure of the phase at constant Gibbs energy, [Pa/m^3/mol]
- dP_dV_G
- dP_dV_H()¶
Method to calculate and return the volume derivative of pressure of the phase at constant enthalpy.
- Returns
- dP_dV_H
float
The volume derivative of pressure of the phase at constant enthalpy, [Pa/m^3/mol]
- dP_dV_H
- dP_dV_S()¶
Method to calculate and return the volume derivative of pressure of the phase at constant entropy.
- Returns
- dP_dV_S
float
The volume derivative of pressure of the phase at constant entropy, [Pa/m^3/mol]
- dP_dV_S
- dP_dV_U()¶
Method to calculate and return the volume derivative of pressure of the phase at constant internal energy.
- Returns
- dP_dV_U
float
The volume derivative of pressure of the phase at constant internal energy, [Pa/m^3/mol]
- dP_dV_U
- dP_dV_frozen()¶
Method to calculate and return the constant-temperature derivative of pressure with respect to volume of the bulk phase, at constant phase fractions and phase compositions. This is a molar phase-fraction weighted calculation.
- Returns
- dP_dV_frozen
float
Frozen constant-temperature derivative of pressure with respect to volume of the bulk phase, [Pa*mol/m^3]
- dP_dV_frozen
- dP_drho_A()¶
Method to calculate and return the density derivative of pressure of the phase at constant Helmholtz energy.
- Returns
- dP_drho_A
float
The density derivative of pressure of the phase at constant Helmholtz energy, [Pa/mol/m^3]
- dP_drho_A
- dP_drho_G()¶
Method to calculate and return the density derivative of pressure of the phase at constant Gibbs energy.
- Returns
- dP_drho_G
float
The density derivative of pressure of the phase at constant Gibbs energy, [Pa/mol/m^3]
- dP_drho_G
- dP_drho_H()¶
Method to calculate and return the density derivative of pressure of the phase at constant enthalpy.
- Returns
- dP_drho_H
float
The density derivative of pressure of the phase at constant enthalpy, [Pa/mol/m^3]
- dP_drho_H
- dP_drho_S()¶
Method to calculate and return the density derivative of pressure of the phase at constant entropy.
- Returns
- dP_drho_S
float
The density derivative of pressure of the phase at constant entropy, [Pa/mol/m^3]
- dP_drho_S
- dP_drho_U()¶
Method to calculate and return the density derivative of pressure of the phase at constant internal energy.
- Returns
- dP_drho_U
float
The density derivative of pressure of the phase at constant internal energy, [Pa/mol/m^3]
- dP_drho_U
- dS_dP()¶
Method to calculate and return the pressure derivative of entropy of the phase at constant pressure.
- Returns
- dS_dP_T
float
Pressure derivative of entropy, [J/(mol*K*Pa)]
- dS_dP_T
- dS_dP_T()¶
Method to calculate and return the pressure derivative of entropy of the phase at constant pressure.
- Returns
- dS_dP_T
float
Pressure derivative of entropy, [J/(mol*K*Pa)]
- dS_dP_T
- dS_dV_P()¶
Method to calculate and return the volume derivative of entropy of the phase at constant pressure.
- Returns
- dS_dV_P
float
Volume derivative of entropy, [J/(K*m^3)]
- dS_dV_P
- dS_dV_T()¶
Method to calculate and return the volume derivative of entropy of the phase at constant temperature.
- Returns
- dS_dV_T
float
Volume derivative of entropy, [J/(K*m^3)]
- dS_dV_T
- dS_mass_dP()¶
Method to calculate and return the pressure derivative of mass entropy of the phase at constant temperature.
- Returns
- dS_mass_dP
float
The pressure derivative of mass entropy of the phase at constant temperature, [J/(mol*K)/Pa]
- dS_mass_dP
- dS_mass_dP_T()¶
Method to calculate and return the pressure derivative of mass entropy of the phase at constant temperature.
- Returns
- dS_mass_dP_T
float
The pressure derivative of mass entropy of the phase at constant temperature, [J/(mol*K)/Pa]
- dS_mass_dP_T
- dS_mass_dP_V()¶
Method to calculate and return the pressure derivative of mass entropy of the phase at constant volume.
- Returns
- dS_mass_dP_V
float
The pressure derivative of mass entropy of the phase at constant volume, [J/(mol*K)/Pa]
- dS_mass_dP_V
- dS_mass_dT()¶
Method to calculate and return the temperature derivative of mass entropy of the phase at constant pressure.
- Returns
- dS_mass_dT
float
The temperature derivative of mass entropy of the phase at constant pressure, [J/(mol*K)/K]
- dS_mass_dT
- dS_mass_dT_P()¶
Method to calculate and return the temperature derivative of mass entropy of the phase at constant pressure.
- Returns
- dS_mass_dT_P
float
The temperature derivative of mass entropy of the phase at constant pressure, [J/(mol*K)/K]
- dS_mass_dT_P
- dS_mass_dT_V()¶
Method to calculate and return the temperature derivative of mass entropy of the phase at constant volume.
- Returns
- dS_mass_dT_V
float
The temperature derivative of mass entropy of the phase at constant volume, [J/(mol*K)/K]
- dS_mass_dT_V
- dS_mass_dV_P()¶
Method to calculate and return the volume derivative of mass entropy of the phase at constant pressure.
- Returns
- dS_mass_dV_P
float
The volume derivative of mass entropy of the phase at constant pressure, [J/(mol*K)/m^3/mol]
- dS_mass_dV_P
- dS_mass_dV_T()¶
Method to calculate and return the volume derivative of mass entropy of the phase at constant temperature.
- Returns
- dS_mass_dV_T
float
The volume derivative of mass entropy of the phase at constant temperature, [J/(mol*K)/m^3/mol]
- dS_mass_dV_T
- dT_dP_A()¶
Method to calculate and return the pressure derivative of temperature of the phase at constant Helmholtz energy.
- Returns
- dT_dP_A
float
The pressure derivative of temperature of the phase at constant Helmholtz energy, [K/Pa]
- dT_dP_A
- dT_dP_G()¶
Method to calculate and return the pressure derivative of temperature of the phase at constant Gibbs energy.
- Returns
- dT_dP_G
float
The pressure derivative of temperature of the phase at constant Gibbs energy, [K/Pa]
- dT_dP_G
- dT_dP_H()¶
Method to calculate and return the pressure derivative of temperature of the phase at constant enthalpy.
- Returns
- dT_dP_H
float
The pressure derivative of temperature of the phase at constant enthalpy, [K/Pa]
- dT_dP_H
- dT_dP_S()¶
Method to calculate and return the pressure derivative of temperature of the phase at constant entropy.
- Returns
- dT_dP_S
float
The pressure derivative of temperature of the phase at constant entropy, [K/Pa]
- dT_dP_S
- dT_dP_U()¶
Method to calculate and return the pressure derivative of temperature of the phase at constant internal energy.
- Returns
- dT_dP_U
float
The pressure derivative of temperature of the phase at constant internal energy, [K/Pa]
- dT_dP_U
- dT_dV_A()¶
Method to calculate and return the volume derivative of temperature of the phase at constant Helmholtz energy.
- Returns
- dT_dV_A
float
The volume derivative of temperature of the phase at constant Helmholtz energy, [K/m^3/mol]
- dT_dV_A
- dT_dV_G()¶
Method to calculate and return the volume derivative of temperature of the phase at constant Gibbs energy.
- Returns
- dT_dV_G
float
The volume derivative of temperature of the phase at constant Gibbs energy, [K/m^3/mol]
- dT_dV_G
- dT_dV_H()¶
Method to calculate and return the volume derivative of temperature of the phase at constant enthalpy.
- Returns
- dT_dV_H
float
The volume derivative of temperature of the phase at constant enthalpy, [K/m^3/mol]
- dT_dV_H
- dT_dV_S()¶
Method to calculate and return the volume derivative of temperature of the phase at constant entropy.
- Returns
- dT_dV_S
float
The volume derivative of temperature of the phase at constant entropy, [K/m^3/mol]
- dT_dV_S
- dT_dV_U()¶
Method to calculate and return the volume derivative of temperature of the phase at constant internal energy.
- Returns
- dT_dV_U
float
The volume derivative of temperature of the phase at constant internal energy, [K/m^3/mol]
- dT_dV_U
- dT_drho_A()¶
Method to calculate and return the density derivative of temperature of the phase at constant Helmholtz energy.
- Returns
- dT_drho_A
float
The density derivative of temperature of the phase at constant Helmholtz energy, [K/mol/m^3]
- dT_drho_A
- dT_drho_G()¶
Method to calculate and return the density derivative of temperature of the phase at constant Gibbs energy.
- Returns
- dT_drho_G
float
The density derivative of temperature of the phase at constant Gibbs energy, [K/mol/m^3]
- dT_drho_G
- dT_drho_H()¶
Method to calculate and return the density derivative of temperature of the phase at constant enthalpy.
- Returns
- dT_drho_H
float
The density derivative of temperature of the phase at constant enthalpy, [K/mol/m^3]
- dT_drho_H
- dT_drho_S()¶
Method to calculate and return the density derivative of temperature of the phase at constant entropy.
- Returns
- dT_drho_S
float
The density derivative of temperature of the phase at constant entropy, [K/mol/m^3]
- dT_drho_S
- dT_drho_U()¶
Method to calculate and return the density derivative of temperature of the phase at constant internal energy.
- Returns
- dT_drho_U
float
The density derivative of temperature of the phase at constant internal energy, [K/mol/m^3]
- dT_drho_U
- dU_dP()¶
Method to calculate and return the constant-temperature pressure derivative of internal energy.
- Returns
- dU_dP
float
Constant-temperature pressure derivative of internal energy, [J/(mol*Pa)]
- dU_dP
- dU_dP_T()¶
Method to calculate and return the constant-temperature pressure derivative of internal energy.
- Returns
- dU_dP
float
Constant-temperature pressure derivative of internal energy, [J/(mol*Pa)]
- dU_dP
- dU_dP_V()¶
Method to calculate and return the constant-volume pressure derivative of internal energy.
- Returns
- dU_dP_V
float
Constant-volume pressure derivative of internal energy, [J/(mol*Pa)]
- dU_dP_V
- dU_dT()¶
Method to calculate and return the constant-pressure temperature derivative of internal energy.
- Returns
- dU_dT
float
Constant-pressure temperature derivative of internal energy, [J/(mol*K)]
- dU_dT
- dU_dT_P()¶
Method to calculate and return the constant-pressure temperature derivative of internal energy.
- Returns
- dU_dT
float
Constant-pressure temperature derivative of internal energy, [J/(mol*K)]
- dU_dT
- dU_dT_V()¶
Method to calculate and return the constant-volume temperature derivative of internal energy.
- Returns
- dU_dT_V
float
Constant-volume temperature derivative of internal energy, [J/(mol*K)]
- dU_dT_V
- dU_dV_P()¶
Method to calculate and return the constant-pressure volume derivative of internal energy.
- Returns
- dU_dV_P
float
Constant-pressure volume derivative of internal energy, [J/(m^3)]
- dU_dV_P
- dU_dV_T()¶
Method to calculate and return the constant-temperature volume derivative of internal energy.
- Returns
- dU_dV_T
float
Constant-temperature volume derivative of internal energy, [J/(m^3)]
- dU_dV_T
- dU_mass_dP()¶
Method to calculate and return the pressure derivative of mass internal energy of the phase at constant temperature.
- Returns
- dU_mass_dP
float
The pressure derivative of mass internal energy of the phase at constant temperature, [J/mol/Pa]
- dU_mass_dP
- dU_mass_dP_T()¶
Method to calculate and return the pressure derivative of mass internal energy of the phase at constant temperature.
- Returns
- dU_mass_dP_T
float
The pressure derivative of mass internal energy of the phase at constant temperature, [J/mol/Pa]
- dU_mass_dP_T
- dU_mass_dP_V()¶
Method to calculate and return the pressure derivative of mass internal energy of the phase at constant volume.
- Returns
- dU_mass_dP_V
float
The pressure derivative of mass internal energy of the phase at constant volume, [J/mol/Pa]
- dU_mass_dP_V
- dU_mass_dT()¶
Method to calculate and return the temperature derivative of mass internal energy of the phase at constant pressure.
- Returns
- dU_mass_dT
float
The temperature derivative of mass internal energy of the phase at constant pressure, [J/mol/K]
- dU_mass_dT
- dU_mass_dT_P()¶
Method to calculate and return the temperature derivative of mass internal energy of the phase at constant pressure.
- Returns
- dU_mass_dT_P
float
The temperature derivative of mass internal energy of the phase at constant pressure, [J/mol/K]
- dU_mass_dT_P
- dU_mass_dT_V()¶
Method to calculate and return the temperature derivative of mass internal energy of the phase at constant volume.
- Returns
- dU_mass_dT_V
float
The temperature derivative of mass internal energy of the phase at constant volume, [J/mol/K]
- dU_mass_dT_V
- dU_mass_dV_P()¶
Method to calculate and return the volume derivative of mass internal energy of the phase at constant pressure.
- Returns
- dU_mass_dV_P
float
The volume derivative of mass internal energy of the phase at constant pressure, [J/mol/m^3/mol]
- dU_mass_dV_P
- dU_mass_dV_T()¶
Method to calculate and return the volume derivative of mass internal energy of the phase at constant temperature.
- Returns
- dU_mass_dV_T
float
The volume derivative of mass internal energy of the phase at constant temperature, [J/mol/m^3/mol]
- dU_mass_dV_T
- dV_dP_A()¶
Method to calculate and return the pressure derivative of volume of the phase at constant Helmholtz energy.
- Returns
- dV_dP_A
float
The pressure derivative of volume of the phase at constant Helmholtz energy, [m^3/mol/Pa]
- dV_dP_A
- dV_dP_G()¶
Method to calculate and return the pressure derivative of volume of the phase at constant Gibbs energy.
- Returns
- dV_dP_G
float
The pressure derivative of volume of the phase at constant Gibbs energy, [m^3/mol/Pa]
- dV_dP_G
- dV_dP_H()¶
Method to calculate and return the pressure derivative of volume of the phase at constant enthalpy.
- Returns
- dV_dP_H
float
The pressure derivative of volume of the phase at constant enthalpy, [m^3/mol/Pa]
- dV_dP_H
- dV_dP_S()¶
Method to calculate and return the pressure derivative of volume of the phase at constant entropy.
- Returns
- dV_dP_S
float
The pressure derivative of volume of the phase at constant entropy, [m^3/mol/Pa]
- dV_dP_S
- dV_dP_U()¶
Method to calculate and return the pressure derivative of volume of the phase at constant internal energy.
- Returns
- dV_dP_U
float
The pressure derivative of volume of the phase at constant internal energy, [m^3/mol/Pa]
- dV_dP_U
- dV_dT_A()¶
Method to calculate and return the temperature derivative of volume of the phase at constant Helmholtz energy.
- Returns
- dV_dT_A
float
The temperature derivative of volume of the phase at constant Helmholtz energy, [m^3/mol/K]
- dV_dT_A
- dV_dT_G()¶
Method to calculate and return the temperature derivative of volume of the phase at constant Gibbs energy.
- Returns
- dV_dT_G
float
The temperature derivative of volume of the phase at constant Gibbs energy, [m^3/mol/K]
- dV_dT_G
- dV_dT_H()¶
Method to calculate and return the temperature derivative of volume of the phase at constant enthalpy.
- Returns
- dV_dT_H
float
The temperature derivative of volume of the phase at constant enthalpy, [m^3/mol/K]
- dV_dT_H
- dV_dT_S()¶
Method to calculate and return the temperature derivative of volume of the phase at constant entropy.
- Returns
- dV_dT_S
float
The temperature derivative of volume of the phase at constant entropy, [m^3/mol/K]
- dV_dT_S
- dV_dT_U()¶
Method to calculate and return the temperature derivative of volume of the phase at constant internal energy.
- Returns
- dV_dT_U
float
The temperature derivative of volume of the phase at constant internal energy, [m^3/mol/K]
- dV_dT_U
- dV_drho_A()¶
Method to calculate and return the density derivative of volume of the phase at constant Helmholtz energy.
- Returns
- dV_drho_A
float
The density derivative of volume of the phase at constant Helmholtz energy, [m^3/mol/mol/m^3]
- dV_drho_A
- dV_drho_G()¶
Method to calculate and return the density derivative of volume of the phase at constant Gibbs energy.
- Returns
- dV_drho_G
float
The density derivative of volume of the phase at constant Gibbs energy, [m^3/mol/mol/m^3]
- dV_drho_G
- dV_drho_H()¶
Method to calculate and return the density derivative of volume of the phase at constant enthalpy.
- Returns
- dV_drho_H
float
The density derivative of volume of the phase at constant enthalpy, [m^3/mol/mol/m^3]
- dV_drho_H
- dV_drho_S()¶
Method to calculate and return the density derivative of volume of the phase at constant entropy.
- Returns
- dV_drho_S
float
The density derivative of volume of the phase at constant entropy, [m^3/mol/mol/m^3]
- dV_drho_S
- dV_drho_U()¶
Method to calculate and return the density derivative of volume of the phase at constant internal energy.
- Returns
- dV_drho_U
float
The density derivative of volume of the phase at constant internal energy, [m^3/mol/mol/m^3]
- dV_drho_U
- dfugacities_dP(phase=None)¶
- dfugacities_dT(phase=None)¶
- property dipoles¶
Dipole moments for each component, [debye].
- dlnphis_dP(phase=None)¶
- dlnphis_dT(phase=None)¶
- dlnphis_dns(phase=None)¶
- dphis_dP(phase=None)¶
- dphis_dT(phase=None)¶
- dphis_dzs(phase=None)¶
- drho_dP_A()¶
Method to calculate and return the pressure derivative of density of the phase at constant Helmholtz energy.
- Returns
- drho_dP_A
float
The pressure derivative of density of the phase at constant Helmholtz energy, [mol/m^3/Pa]
- drho_dP_A
- drho_dP_G()¶
Method to calculate and return the pressure derivative of density of the phase at constant Gibbs energy.
- Returns
- drho_dP_G
float
The pressure derivative of density of the phase at constant Gibbs energy, [mol/m^3/Pa]
- drho_dP_G
- drho_dP_H()¶
Method to calculate and return the pressure derivative of density of the phase at constant enthalpy.
- Returns
- drho_dP_H
float
The pressure derivative of density of the phase at constant enthalpy, [mol/m^3/Pa]
- drho_dP_H
- drho_dP_S()¶
Method to calculate and return the pressure derivative of density of the phase at constant entropy.
- Returns
- drho_dP_S
float
The pressure derivative of density of the phase at constant entropy, [mol/m^3/Pa]
- drho_dP_S
- drho_dP_U()¶
Method to calculate and return the pressure derivative of density of the phase at constant internal energy.
- Returns
- drho_dP_U
float
The pressure derivative of density of the phase at constant internal energy, [mol/m^3/Pa]
- drho_dP_U
- drho_dT_A()¶
Method to calculate and return the temperature derivative of density of the phase at constant Helmholtz energy.
- Returns
- drho_dT_A
float
The temperature derivative of density of the phase at constant Helmholtz energy, [mol/m^3/K]
- drho_dT_A
- drho_dT_G()¶
Method to calculate and return the temperature derivative of density of the phase at constant Gibbs energy.
- Returns
- drho_dT_G
float
The temperature derivative of density of the phase at constant Gibbs energy, [mol/m^3/K]
- drho_dT_G
- drho_dT_H()¶
Method to calculate and return the temperature derivative of density of the phase at constant enthalpy.
- Returns
- drho_dT_H
float
The temperature derivative of density of the phase at constant enthalpy, [mol/m^3/K]
- drho_dT_H
- drho_dT_S()¶
Method to calculate and return the temperature derivative of density of the phase at constant entropy.
- Returns
- drho_dT_S
float
The temperature derivative of density of the phase at constant entropy, [mol/m^3/K]
- drho_dT_S
- drho_dT_U()¶
Method to calculate and return the temperature derivative of density of the phase at constant internal energy.
- Returns
- drho_dT_U
float
The temperature derivative of density of the phase at constant internal energy, [mol/m^3/K]
- drho_dT_U
- drho_dV_A()¶
Method to calculate and return the volume derivative of density of the phase at constant Helmholtz energy.
- Returns
- drho_dV_A
float
The volume derivative of density of the phase at constant Helmholtz energy, [mol/m^3/m^3/mol]
- drho_dV_A
- drho_dV_G()¶
Method to calculate and return the volume derivative of density of the phase at constant Gibbs energy.
- Returns
- drho_dV_G
float
The volume derivative of density of the phase at constant Gibbs energy, [mol/m^3/m^3/mol]
- drho_dV_G
- drho_dV_H()¶
Method to calculate and return the volume derivative of density of the phase at constant enthalpy.
- Returns
- drho_dV_H
float
The volume derivative of density of the phase at constant enthalpy, [mol/m^3/m^3/mol]
- drho_dV_H
- drho_dV_S()¶
Method to calculate and return the volume derivative of density of the phase at constant entropy.
- Returns
- drho_dV_S
float
The volume derivative of density of the phase at constant entropy, [mol/m^3/m^3/mol]
- drho_dV_S
- drho_dV_U()¶
Method to calculate and return the volume derivative of density of the phase at constant internal energy.
- Returns
- drho_dV_U
float
The volume derivative of density of the phase at constant internal energy, [mol/m^3/m^3/mol]
- drho_dV_U
- property economic_statuses¶
Status of each component in in relation to import and export from various regions, [-].
- property energy¶
Method to return the energy (enthalpy times flow rate) of this phase. This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- energy
float
Enthalpy flow rate, [W]
- energy
- property energy_calc¶
Method to return the energy (enthalpy times flow rate) of this phase. This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- energy
float
Enthalpy flow rate, [W]
- energy
- property energy_reactive¶
Method to return the reactive energy (reactive enthalpy times flow rate) of this phase. This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- energy_reactive
float
Reactive enthalpy flow rate, [W]
- energy_reactive
- property energy_reactive_calc¶
Method to return the reactive energy (reactive enthalpy times flow rate) of this phase. This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- energy_reactive
float
Reactive enthalpy flow rate, [W]
- energy_reactive
- flash_convergence¶
- flash_specs¶
- flashed = True¶
- flasher¶
- property formulas¶
Formulas of each component, [-].
- fugacities(phase=None)¶
- property functional_groups¶
Set of functional group constants present in each component, [-].
- gas¶
- gas_beta¶
- gas_count¶
- property heaviest_liquid¶
The liquid-like phase with the highest mass density, [-]
- helium_molar_weight()¶
Method to calculate and return the effective quantiy of helium in the phase as a molar weight, [g/mol].
This is the molecular weight of the phase times the mass fraction of the helium component.
- helium_partial_pressure()¶
Method to calculate and return the ideal partial pressure of helium, [Pa]
- humidity_ratio(phase=None)[source]¶
Method to calculate and return the humidity ratio of the phase; normally defined as the kg water/kg dry air, the definition here is kg water/(kg rest of the phase) [-]
- Returns
- humidity_ratio
float
Humidity ratio, [-]
- humidity_ratio
- hydrogen_molar_weight()¶
Method to calculate and return the effective quantiy of hydrogen in the phase as a molar weight, [g/mol].
This is the molecular weight of the phase times the mass fraction of the hydrogen component.
- hydrogen_partial_pressure()¶
Method to calculate and return the ideal partial pressure of hydrogen, [Pa]
- hydrogen_sulfide_molar_weight()¶
Method to calculate and return the effective quantiy of hydrogen_sulfide in the phase as a molar weight, [g/mol].
This is the molecular weight of the phase times the mass fraction of the hydrogen_sulfide component.
- hydrogen_sulfide_partial_pressure()¶
Method to calculate and return the ideal partial pressure of hydrogen_sulfide, [Pa]
- isentropic_exponent()¶
Method to calculate and return the real gas isentropic exponent of the phase, which satisfies the relationship .
- Returns
- k_PV
float
Isentropic exponent of a real fluid, [-]
- k_PV
- isentropic_exponent_PT()¶
Method to calculate and return the real gas isentropic exponent of the phase, which satisfies the relationship .
- Returns
- k_PT
float
Isentropic exponent of a real fluid, [-]
- k_PT
- isentropic_exponent_PV()¶
Method to calculate and return the real gas isentropic exponent of the phase, which satisfies the relationship .
- Returns
- k_PV
float
Isentropic exponent of a real fluid, [-]
- k_PV
- isentropic_exponent_TV()¶
Method to calculate and return the real gas isentropic exponent of the phase, which satisfies the relationship .
- Returns
- k_TV
float
Isentropic exponent of a real fluid, [-]
- k_TV
- isobaric_expansion()¶
Method to calculate and return the isobatic expansion coefficient of the bulk according to the selected calculation methodology.
- Returns
- beta
float
Isobaric coefficient of a thermal expansion, [1/K]
- beta
- isothermal_bulk_modulus()¶
Method to calculate and return the isothermal bulk modulus of the phase.
- Returns
- isothermal_bulk_modulus
float
Isothermal bulk modulus, [Pa]
- isothermal_bulk_modulus
- json_version = 1¶
- k()¶
Calculate and return the thermal conductivity of the bulk according to the selected thermal conductivity settings in
BulkSettings
, the settings inThermalConductivityGasMixture
andThermalConductivityLiquidMixture
, and the configured pure-component settings inThermalConductivityGas
andThermalConductivityLiquid
.- Returns
- k
float
Thermal Conductivity of bulk phase calculated with mixing rules, [Pa*s]
- k
- kappa()¶
Method to calculate and return the isothermal compressibility of the bulk according to the selected calculation methodology.
- Returns
- kappa
float
Isothermal coefficient of compressibility, [1/Pa]
- kappa
- kgs()[source]¶
Method to calculate and return the pure-component gas temperature-dependent thermal conductivity of each species from the
thermo.thermal_conductivity.ThermalConductivityGas
objects.These values are normally at low pressure, not along the saturation line.
- kinematic_viscosity()¶
Method to calculate and return the kinematic viscosity of the phase, [m^2/s]
- Returns
- nu
float
Kinematic viscosity, [m^2/s]
- nu
- kls()[source]¶
Method to calculate and return the pure-component liquid temperature-dependent thermal conductivity of each species from the
thermo.thermal_conductivity.ThermalConductivityLiquid
objects.These values are normally at low pressure, not along the saturation line.
- kss()[source]¶
Method to calculate and return the pure-component solid temperature-dependent thermal conductivity of each species from the
thermo.thermal_conductivity.ThermalConductivitySolid
objects.
- property legal_statuses¶
Status of each component in in relation to import and export rules from various regions, [-].
- property lightest_liquid¶
The liquid-like phase with the lowest mass density, [-]
- liquid0¶
- liquid1¶
- liquid2¶
- liquid_bulk = None¶
- liquid_count¶
- liquid_zs¶
- liquids¶
- liquids_betas¶
- lnphis(phase=None)¶
- property logPs¶
Octanol-water partition coefficients for each component, [-].
- log_zs()¶
Method to calculate and return the log of mole fractions specified. These are used in calculating entropy and in many other formulas.
- m()¶
Method to return the mass flow rate of this phase. This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- m
float
Mass flow of the phase, [kg/s]
- m
- property m_calc¶
- max_liquid_phases = 1¶
- methane_molar_weight()¶
Method to calculate and return the effective quantiy of methane in the phase as a molar weight, [g/mol].
This is the molecular weight of the phase times the mass fraction of the methane component.
- methane_partial_pressure()¶
Method to calculate and return the ideal partial pressure of methane, [Pa]
- property molecular_diameters¶
Lennard-Jones molecular diameters for each component, [angstrom].
- ms()¶
Method to return the mass flow rates of each component in this phase. This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- ms
float
Mass flow of the components in the phase, [kg/s]
- ms
- property ms_calc¶
Method to return the mass flow rates of each component in this phase. This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- ms
float
Mass flow of the components in the phase, [kg/s]
- ms
- mu()¶
Calculate and return the viscosity of the bulk according to the selected viscosity settings in
BulkSettings
, the settings inViscosityGasMixture
andViscosityLiquidMixture
, and the configured pure-component settings inViscosityGas
andViscosityLiquid
.- Returns
- mu
float
Viscosity of bulk phase calculated with mixing rules, [Pa*s]
- mu
- mugs()[source]¶
Method to calculate and return the pure-component gas temperature-dependent viscosity of each species from the
thermo.viscosity.ViscosityGas
objects.These values are normally at low pressure, not along the saturation line.
- muls()[source]¶
Method to calculate and return the pure-component liquid temperature-dependent viscosity of each species from the
thermo.viscosity.ViscosityLiquid
objects.These values are normally at low pressure, not along the saturation line.
- n()¶
Method to return the molar flow rate of this phase. This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- n
float
Molar flow of the phase, [mol/s]
- n
- property n_calc¶
- nitrogen_molar_weight()¶
Method to calculate and return the effective quantiy of nitrogen in the phase as a molar weight, [g/mol].
This is the molecular weight of the phase times the mass fraction of the nitrogen component.
- nitrogen_partial_pressure()¶
Method to calculate and return the ideal partial pressure of nitrogen, [Pa]
- non_json_attributes = []¶
- ns()¶
Method to return the molar flow rates of each component in this phase. This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- ns
float
Molar flow of the components in the phase, [mol/s]
- ns
- property ns_calc¶
Method to return the molar flow rates of each component in this phase. This method is only available when the phase is linked to an EquilibriumStream.
- Returns
- ns
float
Molar flow of the components in the phase, [mol/s]
- ns
- nu()[source]¶
Method to calculate and return the kinematic viscosity of the phase, [m^2/s]
- Returns
- nu
float
Kinematic viscosity, [m^2/s]
- nu
- obj_references = ('liquid_bulk', 'solid_bulk', 'bulk', 'gas', 'liquids', 'phases', 'solids', 'settings', 'constants', 'correlations', 'flasher', 'liquid0', 'liquid1', 'liquid2')¶
- property omegas¶
Acentric factors for each component, [-].
- oxygen_molar_weight()¶
Method to calculate and return the effective quantiy of oxygen in the phase as a molar weight, [g/mol].
This is the molecular weight of the phase times the mass fraction of the oxygen component.
- oxygen_partial_pressure()¶
Method to calculate and return the ideal partial pressure of oxygen, [Pa]
- partial_pressures()¶
Method to return the partial pressures of each component in the phase. Note that this is the conventional definition assumed in almost every source; there is also a non-ideal definition.
- property phase¶
Method to calculate and return a string representing the phase of the mixture. The return string uses ‘V’ to represent the gas phase, ‘L’ to represent a liquid phase, and ‘S’ to represent a solid phase (always in that order).
A state with three liquids, two solids, and a gas would return ‘VLLLSS’.
- Returns
- phase
str
Phase string, [-]
- phase
- property phase_STPs¶
Standard states (‘g’, ‘l’, or ‘s’) for each component, [-].
- phase_count¶
- phases¶
- pseudo_Pc(phase=None)[source]¶
Method to calculate and return the pseudocritical pressure calculated using Kay’s rule (linear mole fractions):
- Returns
- pseudo_Pc
float
Pseudocritical pressure of the phase, [Pa]
- pseudo_Pc
- pseudo_Tc(phase=None)[source]¶
Method to calculate and return the pseudocritical temperature calculated using Kay’s rule (linear mole fractions):
- Returns
- pseudo_Tc
float
Pseudocritical temperature of the phase, [K]
- pseudo_Tc
- pseudo_Vc(phase=None)[source]¶
Method to calculate and return the pseudocritical volume calculated using Kay’s rule (linear mole fractions):
- Returns
- pseudo_Vc
float
Pseudocritical volume of the phase, [m^3/mol]
- pseudo_Vc
- pseudo_Zc(phase=None)[source]¶
Method to calculate and return the pseudocritical compressibility calculated using Kay’s rule (linear mole fractions):
- Returns
- pseudo_Zc
float
Pseudocritical compressibility of the phase, [-]
- pseudo_Zc
- pseudo_omega(phase=None)[source]¶
Method to calculate and return the pseudocritical acentric factor calculated using Kay’s rule (linear mole fractions):
- Returns
- pseudo_omega
float
Pseudo acentric factor of the phase, [-]
- pseudo_omega
- property quality¶
Method to return the mass vapor fraction of the equilibrium state. If no vapor/gas is present, 0 is always returned. This is normally called the quality.
- Returns
- quality
float
Vapor mass fraction, [-]
- quality
- reacted = False¶
- rho()¶
Method to calculate and return the molar density of the phase.
- Returns
- rho
float
Molar density, [mol/m^3]
- rho
- rho_gas(phase=None)[source]¶
Method to calculate and return the ideal-gas molar density of the phase at the chosen reference temperature and pressure, according to the temperature variable T_gas_ref and pressure variable P_gas_ref of the
thermo.bulk.BulkSettings
.- Returns
- rho_gas
float
Ideal gas molar density at the reference temperature and pressure, [mol/m^3]
- rho_gas
- rho_gas_normal(phase=None)[source]¶
Method to calculate and return the ideal-gas molar density of the phase at the normal temperature and pressure, according to the temperature variable T_normal and pressure variable P_normal of the
thermo.bulk.BulkSettings
.- Returns
- rho_gas_normal
float
Ideal gas molar density at normal temperature and pressure, [mol/m^3]
- rho_gas_normal
- rho_gas_standard(phase=None)[source]¶
Method to calculate and return the ideal-gas molar density of the phase at the standard temperature and pressure, according to the temperature variable T_standard and pressure variable P_standard of the
thermo.bulk.BulkSettings
.- Returns
- rho_gas_standard
float
Ideal gas molar density at standard temperature and pressure, [mol/m^3]
- rho_gas_standard
- rho_mass(phase=None)[source]¶
Method to calculate and return mass density of the phase.
- Returns
- rho_mass
float
Mass density, [kg/m^3]
- rho_mass
- rho_mass_gas(phase=None)[source]¶
Method to calculate and return the ideal-gas mass density of the phase at the chosen reference temperature and pressure, according to the temperature variable T_gas_ref and pressure variable P_gas_ref of the
thermo.bulk.BulkSettings
.- Returns
- rho_mass_gas
float
Ideal gas molar density at the reference temperature and pressure, [kg/m^3]
- rho_mass_gas
- rho_mass_gas_normal(phase=None)[source]¶
Method to calculate and return the ideal-gas mass density of the phase at the normal temperature and pressure, according to the temperature variable T_normal and pressure variable P_normal of the
thermo.bulk.BulkSettings
.- Returns
- rho_mass_gas_normal
float
Ideal gas molar density at normal temperature and pressure, [kg/m^3]
- rho_mass_gas_normal
- rho_mass_gas_standard(phase=None)[source]¶
Method to calculate and return the ideal-gas mass density of the phase at the standard temperature and pressure, according to the temperature variable T_standard and pressure variable P_standard of the
thermo.bulk.BulkSettings
.- Returns
- rho_mass_gas_standard
float
Ideal gas molar density at standard temperature and pressure, [kg/m^3]
- rho_mass_gas_standard
- rho_mass_liquid_ref(phase=None)[source]¶
Method to calculate and return the liquid reference mass density according to the temperature variable T_liquid_volume_ref of
thermo.bulk.BulkSettings
and the composition of the phase.- Returns
- rho_mass_liquid_ref
float
Liquid mass density at the reference condition, [kg/m^3]
- rho_mass_liquid_ref
- property rhocs¶
Molar densities at the critical point for each component, [mol/m^3].
- property rhocs_mass¶
Densities at the critical point for each component, [kg/m^3].
- property rhog_STPs¶
Molar gas densities at STP for each component; metastable if normally another state, [mol/m^3].
- property rhog_STPs_mass¶
Gas densities at STP for each component; metastable if normally another state, [kg/m^3].
- property rhol_60Fs¶
Liquid molar densities for each component at 60 °F, [mol/m^3].
- property rhol_60Fs_mass¶
Liquid mass densities for each component at 60 °F, [kg/m^3].
- property rhol_STPs¶
Molar liquid densities at STP for each component, [mol/m^3].
- property rhol_STPs_mass¶
Liquid densities at STP for each component, [kg/m^3].
- property rhos_Tms¶
Solid molar densities for each component at their respective melting points, [mol/m^3].
- property rhos_Tms_mass¶
Solid mass densities for each component at their melting point, [kg/m^3].
- settings¶
- sigma()¶
Calculate and return the surface tension of the bulk according to the selected surface tension settings in
BulkSettings
, the settings inSurfaceTensionMixture
and the configured pure-component settings inSurfaceTension
.- Returns
- sigma
float
Surface tension of bulk phase calculated with mixing rules, [N/m]
- sigma
Notes
A value is only returned if all phases in the bulk are liquids; this property is for a liquid-ideal gas calculation, not the interfacial tension between two liquid phases.
- property sigma_STPs¶
Liquid-air surface tensions at 298.15 K and the higher of 101325 Pa or the saturation pressure, [N/m].
- property sigma_Tbs¶
Liquid-air surface tensions at the normal boiling point and 101325 Pa, [N/m].
- property sigma_Tms¶
Liquid-air surface tensions at the melting point and 101325 Pa, [N/m].
- sigmas()[source]¶
Method to calculate and return the pure-component surface tensions of each species from the
thermo.interface.SurfaceTension
objects.
- property similarity_variables¶
Similarity variables for each component, [mol/g].
- property smiless¶
SMILES identifiers for each component, [-].
- solid_bulk = None¶
- solid_count¶
- solids¶
- solids_betas¶
- property solubility_parameters¶
Solubility parameters for each component at 298.15 K, [Pa^0.5].
- speed_of_sound()¶
Method to calculate and return the molar speed of sound of the bulk according to the selected calculation methodology.
A similar expression based on molar density is:
- Returns
- w
float
Speed of sound for a real gas, [m*kg^0.5/(s*mol^0.5)]
- w
- speed_of_sound_ideal_gas()¶
Method to calculate and return the molar speed of sound of an ideal gas phase at the current conditions.
- Returns
- w
float
Speed of sound for a real gas, [m*kg^0.5/(s*mol^0.5)]
- w
- speed_of_sound_ideal_gas_mass()¶
Method to calculate and return the mass speed of sound of an ideal gas phase at the current conditions.
- Returns
- w
float
Speed of sound for an ideal gas, [m/s]
- w
- speed_of_sound_mass()¶
Method to calculate and return the speed of sound of the phase.
- Returns
- w
float
Speed of sound for a real gas, [m/s]
- w
- thermal_diffusivity()¶
Method to calculate and return the thermal diffusivity of the phase.
- Returns
- alpha
float
Thermal diffusivity, [m^2/s]
- alpha
- value(name, phase=None)[source]¶
Method to retrieve a property from a string. This more or less wraps getattr, but also allows for the property to be returned for a specific phase if phase is provided.
name could be a python property like ‘Tms’ or a callable method like ‘H’; and if the property is on a per-phase basis like ‘betas_mass’, a phase object can be provided as the second argument and only the value for that phase will be returned.
- Parameters
- name
str
String representing the property, [-]
- phase
thermo.phase.Phase
,optional
Phase to retrieve the property for only (if specified), [-]
- name
- Returns
- value
various
Value specified, [various]
- value
- vectorized = False¶
- property water_index¶
The index of the component water in the components. None if water is not present. Water is recognized by its CAS number.
- Returns
- water_index
int
The index of the component water, [-]
- water_index
- water_molar_weight()¶
Method to calculate and return the effective quantiy of water in the phase as a molar weight, [g/mol].
This is the molecular weight of the phase times the mass fraction of the water component.
- water_partial_pressure()¶
Method to calculate and return the ideal partial pressure of water, [Pa]
- property water_phase¶
The liquid-like phase with the highest water mole fraction, [-]
- property water_phase_index¶
The liquid-like phase with the highest mole fraction of water, [-]
- Returns
- water_phase_index
int
Index into the attribute
EquilibriumState.liquids
which refers to the liquid-like phase with the highest water mole fraction, [-]
- water_phase_index
- property ws_calc¶
- ws_no_water(phase=None)[source]¶
Method to calculate and return the mass fractions of all species in the phase, normalized to a water-free basis (the mass fraction of water returned is zero).
- zs¶
- property zs_calc¶