|
| Metal (const std::string &infile, std::string id="") |
|
bool | operator! () |
|
bool | ready () const |
| Returns a bool indicating whether the object is ready for use. More...
|
|
virtual std::string | type () const |
| String indicating the thermodynamic model implemented. More...
|
|
virtual doublereal | enthalpy_mole () const |
| Molar enthalpy. Units: J/kmol. More...
|
|
virtual doublereal | intEnergy_mole () const |
| Molar internal energy. Units: J/kmol. More...
|
|
virtual doublereal | entropy_mole () const |
| Molar entropy. Units: J/kmol/K. More...
|
|
virtual doublereal | gibbs_mole () const |
| Molar Gibbs function. Units: J/kmol. More...
|
|
virtual doublereal | cp_mole () const |
| Molar heat capacity at constant pressure. Units: J/kmol/K. More...
|
|
virtual doublereal | cv_mole () const |
| Molar heat capacity at constant volume. Units: J/kmol/K. More...
|
|
virtual void | setPressure (doublereal pres) |
| Set the internally stored pressure (Pa) at constant temperature and composition. More...
|
|
virtual doublereal | pressure () const |
| Return the thermodynamic pressure (Pa). More...
|
|
virtual void | getChemPotentials (doublereal *mu) const |
| Get the species chemical potentials. Units: J/kmol. More...
|
|
virtual void | getEnthalpy_RT (doublereal *hrt) const |
| Get the nondimensional Enthalpy functions for the species at their standard states at the current T and P of the solution. More...
|
|
virtual void | getEntropy_R (doublereal *sr) const |
| Get the array of nondimensional Entropy functions for the standard state species at the current T and P of the solution. More...
|
|
virtual void | getStandardChemPotentials (doublereal *mu0) const |
| Get the array of chemical potentials at unit activity for the species at their standard states at the current T and P of the solution. More...
|
|
virtual void | getActivityConcentrations (doublereal *c) const |
| This method returns an array of generalized concentrations. More...
|
|
virtual doublereal | standardConcentration (size_t k=0) const |
| Return the standard concentration for the kth species. More...
|
|
virtual doublereal | logStandardConc (size_t k=0) const |
| Natural logarithm of the standard concentration of the kth species. More...
|
|
virtual void | setParametersFromXML (const XML_Node &eosdata) |
| Set equation of state parameter values from XML entries. More...
|
|
| ThermoPhase () |
| Constructor. More...
|
|
doublereal | RT () const |
| Return the Gas Constant multiplied by the current temperature. More...
|
|
virtual doublereal | refPressure () const |
| Returns the reference pressure in Pa. More...
|
|
virtual doublereal | minTemp (size_t k=npos) const |
| Minimum temperature for which the thermodynamic data for the species or phase are valid. More...
|
|
doublereal | Hf298SS (const size_t k) const |
| Report the 298 K Heat of Formation of the standard state of one species (J kmol-1) More...
|
|
virtual void | modifyOneHf298SS (const size_t k, const doublereal Hf298New) |
| Modify the value of the 298 K Heat of Formation of one species in the phase (J kmol-1) More...
|
|
virtual void | resetHf298 (const size_t k=npos) |
| Restore the original heat of formation of one or more species. More...
|
|
virtual doublereal | maxTemp (size_t k=npos) const |
| Maximum temperature for which the thermodynamic data for the species are valid. More...
|
|
bool | chargeNeutralityNecessary () const |
| Returns the chargeNeutralityNecessity boolean. More...
|
|
virtual doublereal | isothermalCompressibility () const |
| Returns the isothermal compressibility. Units: 1/Pa. More...
|
|
virtual doublereal | thermalExpansionCoeff () const |
| Return the volumetric thermal expansion coefficient. Units: 1/K. More...
|
|
void | setElectricPotential (doublereal v) |
| Set the electric potential of this phase (V). More...
|
|
doublereal | electricPotential () const |
| Returns the electric potential of this phase (V). More...
|
|
virtual int | activityConvention () const |
| This method returns the convention used in specification of the activities, of which there are currently two, molar- and molality-based conventions. More...
|
|
virtual int | standardStateConvention () const |
| This method returns the convention used in specification of the standard state, of which there are currently two, temperature based, and variable pressure based. More...
|
|
virtual void | getActivities (doublereal *a) const |
| Get the array of non-dimensional activities at the current solution temperature, pressure, and solution concentration. More...
|
|
virtual void | getActivityCoefficients (doublereal *ac) const |
| Get the array of non-dimensional molar-based activity coefficients at the current solution temperature, pressure, and solution concentration. More...
|
|
virtual void | getLnActivityCoefficients (doublereal *lnac) const |
| Get the array of non-dimensional molar-based ln activity coefficients at the current solution temperature, pressure, and solution concentration. More...
|
|
virtual void | getChemPotentials_RT (doublereal *mu) const |
| Get the array of non-dimensional species chemical potentials These are partial molar Gibbs free energies. More...
|
|
void | getElectrochemPotentials (doublereal *mu) const |
| Get the species electrochemical potentials. More...
|
|
virtual void | getPartialMolarEnthalpies (doublereal *hbar) const |
| Returns an array of partial molar enthalpies for the species in the mixture. More...
|
|
virtual void | getPartialMolarEntropies (doublereal *sbar) const |
| Returns an array of partial molar entropies of the species in the solution. More...
|
|
virtual void | getPartialMolarIntEnergies (doublereal *ubar) const |
| Return an array of partial molar internal energies for the species in the mixture. More...
|
|
virtual void | getPartialMolarCp (doublereal *cpbar) const |
| Return an array of partial molar heat capacities for the species in the mixture. More...
|
|
virtual void | getPartialMolarVolumes (doublereal *vbar) const |
| Return an array of partial molar volumes for the species in the mixture. More...
|
|
virtual void | getGibbs_RT (doublereal *grt) const |
| Get the nondimensional Gibbs functions for the species in their standard states at the current T and P of the solution. More...
|
|
virtual void | getPureGibbs (doublereal *gpure) const |
| Get the Gibbs functions for the standard state of the species at the current T and P of the solution. More...
|
|
virtual void | getIntEnergy_RT (doublereal *urt) const |
| Returns the vector of nondimensional Internal Energies of the standard state species at the current T and P of the solution. More...
|
|
virtual void | getCp_R (doublereal *cpr) const |
| Get the nondimensional Heat Capacities at constant pressure for the species standard states at the current T and P of the solution. More...
|
|
virtual void | getStandardVolumes (doublereal *vol) const |
| Get the molar volumes of the species standard states at the current T and P of the solution. More...
|
|
virtual void | getEnthalpy_RT_ref (doublereal *hrt) const |
| Returns the vector of nondimensional enthalpies of the reference state at the current temperature of the solution and the reference pressure for the species. More...
|
|
virtual void | getGibbs_RT_ref (doublereal *grt) const |
| Returns the vector of nondimensional Gibbs Free Energies of the reference state at the current temperature of the solution and the reference pressure for the species. More...
|
|
virtual void | getGibbs_ref (doublereal *g) const |
| Returns the vector of the Gibbs function of the reference state at the current temperature of the solution and the reference pressure for the species. More...
|
|
virtual void | getEntropy_R_ref (doublereal *er) const |
| Returns the vector of nondimensional entropies of the reference state at the current temperature of the solution and the reference pressure for each species. More...
|
|
virtual void | getIntEnergy_RT_ref (doublereal *urt) const |
| Returns the vector of nondimensional internal Energies of the reference state at the current temperature of the solution and the reference pressure for each species. More...
|
|
virtual void | getCp_R_ref (doublereal *cprt) const |
| Returns the vector of nondimensional constant pressure heat capacities of the reference state at the current temperature of the solution and reference pressure for each species. More...
|
|
virtual void | getStandardVolumes_ref (doublereal *vol) const |
| Get the molar volumes of the species reference states at the current T and P_ref of the solution. More...
|
|
doublereal | enthalpy_mass () const |
| Specific enthalpy. Units: J/kg. More...
|
|
doublereal | intEnergy_mass () const |
| Specific internal energy. Units: J/kg. More...
|
|
doublereal | entropy_mass () const |
| Specific entropy. Units: J/kg/K. More...
|
|
doublereal | gibbs_mass () const |
| Specific Gibbs function. Units: J/kg. More...
|
|
doublereal | cp_mass () const |
| Specific heat at constant pressure. Units: J/kg/K. More...
|
|
doublereal | cv_mass () const |
| Specific heat at constant volume. Units: J/kg/K. More...
|
|
virtual void | setState_TPX (doublereal t, doublereal p, const doublereal *x) |
| Set the temperature (K), pressure (Pa), and mole fractions. More...
|
|
virtual void | setState_TPX (doublereal t, doublereal p, const compositionMap &x) |
| Set the temperature (K), pressure (Pa), and mole fractions. More...
|
|
virtual void | setState_TPX (doublereal t, doublereal p, const std::string &x) |
| Set the temperature (K), pressure (Pa), and mole fractions. More...
|
|
virtual void | setState_TPY (doublereal t, doublereal p, const doublereal *y) |
| Set the internally stored temperature (K), pressure (Pa), and mass fractions of the phase. More...
|
|
virtual void | setState_TPY (doublereal t, doublereal p, const compositionMap &y) |
| Set the internally stored temperature (K), pressure (Pa), and mass fractions of the phase. More...
|
|
virtual void | setState_TPY (doublereal t, doublereal p, const std::string &y) |
| Set the internally stored temperature (K), pressure (Pa), and mass fractions of the phase. More...
|
|
virtual void | setState_TP (doublereal t, doublereal p) |
| Set the temperature (K) and pressure (Pa) More...
|
|
virtual void | setState_PX (doublereal p, doublereal *x) |
| Set the pressure (Pa) and mole fractions. More...
|
|
virtual void | setState_PY (doublereal p, doublereal *y) |
| Set the internally stored pressure (Pa) and mass fractions. More...
|
|
virtual void | setState_HP (double h, double p, double tol=1e-9) |
| Set the internally stored specific enthalpy (J/kg) and pressure (Pa) of the phase. More...
|
|
virtual void | setState_UV (double u, double v, double tol=1e-9) |
| Set the specific internal energy (J/kg) and specific volume (m^3/kg). More...
|
|
virtual void | setState_SP (double s, double p, double tol=1e-9) |
| Set the specific entropy (J/kg/K) and pressure (Pa). More...
|
|
virtual void | setState_SV (double s, double v, double tol=1e-9) |
| Set the specific entropy (J/kg/K) and specific volume (m^3/kg). More...
|
|
virtual void | setState_ST (double s, double t, double tol=1e-9) |
| Set the specific entropy (J/kg/K) and temperature (K). More...
|
|
virtual void | setState_TV (double t, double v, double tol=1e-9) |
| Set the temperature (K) and specific volume (m^3/kg). More...
|
|
virtual void | setState_PV (double p, double v, double tol=1e-9) |
| Set the pressure (Pa) and specific volume (m^3/kg). More...
|
|
virtual void | setState_UP (double u, double p, double tol=1e-9) |
| Set the specific internal energy (J/kg) and pressure (Pa). More...
|
|
virtual void | setState_VH (double v, double h, double tol=1e-9) |
| Set the specific volume (m^3/kg) and the specific enthalpy (J/kg) More...
|
|
virtual void | setState_TH (double t, double h, double tol=1e-9) |
| Set the temperature (K) and the specific enthalpy (J/kg) More...
|
|
virtual void | setState_SH (double s, double h, double tol=1e-9) |
| Set the specific entropy (J/kg/K) and the specific enthalpy (J/kg) More...
|
|
virtual void | setState_RP (doublereal rho, doublereal p) |
| Set the density (kg/m**3) and pressure (Pa) at constant composition. More...
|
|
virtual void | setState_RPX (doublereal rho, doublereal p, const doublereal *x) |
| Set the density (kg/m**3), pressure (Pa) and mole fractions. More...
|
|
virtual void | setState_RPX (doublereal rho, doublereal p, const compositionMap &x) |
| Set the density (kg/m**3), pressure (Pa) and mole fractions. More...
|
|
virtual void | setState_RPX (doublereal rho, doublereal p, const std::string &x) |
| Set the density (kg/m**3), pressure (Pa) and mole fractions. More...
|
|
virtual void | setState_RPY (doublereal rho, doublereal p, const doublereal *y) |
| Set the density (kg/m**3), pressure (Pa) and mass fractions. More...
|
|
virtual void | setState_RPY (doublereal rho, doublereal p, const compositionMap &y) |
| Set the density (kg/m**3), pressure (Pa) and mass fractions. More...
|
|
virtual void | setState_RPY (doublereal rho, doublereal p, const std::string &y) |
| Set the density (kg/m**3), pressure (Pa) and mass fractions. More...
|
|
void | equilibrate (const std::string &XY, const std::string &solver="auto", double rtol=1e-9, int max_steps=50000, int max_iter=100, int estimate_equil=0, int log_level=0) |
| Equilibrate a ThermoPhase object. More...
|
|
virtual void | setToEquilState (const doublereal *lambda_RT) |
| This method is used by the ChemEquil equilibrium solver. More...
|
|
void | setElementPotentials (const vector_fp &lambda) |
| Stores the element potentials in the ThermoPhase object. More...
|
|
bool | getElementPotentials (doublereal *lambda) const |
| Returns the element potentials stored in the ThermoPhase object. More...
|
|
virtual bool | compatibleWithMultiPhase () const |
| Indicates whether this phase type can be used with class MultiPhase for equilibrium calculations. More...
|
|
virtual doublereal | critTemperature () const |
| Critical temperature (K). More...
|
|
virtual doublereal | critPressure () const |
| Critical pressure (Pa). More...
|
|
virtual doublereal | critVolume () const |
| Critical volume (m3/kmol). More...
|
|
virtual doublereal | critCompressibility () const |
| Critical compressibility (unitless). More...
|
|
virtual doublereal | critDensity () const |
| Critical density (kg/m3). More...
|
|
virtual doublereal | satTemperature (doublereal p) const |
| Return the saturation temperature given the pressure. More...
|
|
virtual doublereal | satPressure (doublereal t) |
| Return the saturation pressure given the temperature. More...
|
|
virtual doublereal | vaporFraction () const |
| Return the fraction of vapor at the current conditions. More...
|
|
virtual void | setState_Tsat (doublereal t, doublereal x) |
| Set the state to a saturated system at a particular temperature. More...
|
|
virtual void | setState_Psat (doublereal p, doublereal x) |
| Set the state to a saturated system at a particular pressure. More...
|
|
virtual bool | addSpecies (shared_ptr< Species > spec) |
|
virtual void | modifySpecies (size_t k, shared_ptr< Species > spec) |
| Modify the thermodynamic data associated with a species. More...
|
|
void | saveSpeciesData (const size_t k, const XML_Node *const data) |
| Store a reference pointer to the XML tree containing the species data for this phase. More...
|
|
const std::vector< const XML_Node * > & | speciesData () const |
| Return a pointer to the vector of XML nodes containing the species data for this phase. More...
|
|
virtual MultiSpeciesThermo & | speciesThermo (int k=-1) |
| Return a changeable reference to the calculation manager for species reference-state thermodynamic properties. More...
|
|
virtual void | initThermoFile (const std::string &inputFile, const std::string &id) |
|
virtual void | initThermoXML (XML_Node &phaseNode, const std::string &id) |
| Import and initialize a ThermoPhase object using an XML tree. More...
|
|
virtual void | initThermo () |
| Initialize the ThermoPhase object after all species have been set up. More...
|
|
virtual void | setParameters (int n, doublereal *const c) |
| Set the equation of state parameters. More...
|
|
virtual void | getParameters (int &n, doublereal *const c) const |
| Get the equation of state parameters in a vector. More...
|
|
virtual void | setStateFromXML (const XML_Node &state) |
| Set the initial state of the phase to the conditions specified in the state XML element. More...
|
|
virtual void | invalidateCache () |
| Invalidate any cached values which are normally updated only when a change in state is detected. More...
|
|
virtual void | getdlnActCoeffds (const doublereal dTds, const doublereal *const dXds, doublereal *dlnActCoeffds) const |
| Get the change in activity coefficients wrt changes in state (temp, mole fraction, etc) along a line in parameter space or along a line in physical space. More...
|
|
virtual void | getdlnActCoeffdlnX_diag (doublereal *dlnActCoeffdlnX_diag) const |
| Get the array of ln mole fraction derivatives of the log activity coefficients - diagonal component only. More...
|
|
virtual void | getdlnActCoeffdlnN_diag (doublereal *dlnActCoeffdlnN_diag) const |
| Get the array of log species mole number derivatives of the log activity coefficients. More...
|
|
virtual void | getdlnActCoeffdlnN (const size_t ld, doublereal *const dlnActCoeffdlnN) |
| Get the array of derivatives of the log activity coefficients with respect to the log of the species mole numbers. More...
|
|
virtual void | getdlnActCoeffdlnN_numderiv (const size_t ld, doublereal *const dlnActCoeffdlnN) |
|
virtual std::string | report (bool show_thermo=true, doublereal threshold=-1e-14) const |
| returns a summary of the state of the phase as a string More...
|
|
virtual void | reportCSV (std::ofstream &csvFile) const |
| returns a summary of the state of the phase to a comma separated file. More...
|
|
| Phase () |
| Default constructor. More...
|
|
| Phase (const Phase &)=delete |
|
Phase & | operator= (const Phase &)=delete |
|
XML_Node & | xml () const |
| Returns a const reference to the XML_Node that describes the phase. More...
|
|
void | setXMLdata (XML_Node &xmlPhase) |
| Stores the XML tree information for the current phase. More...
|
|
void | saveState (vector_fp &state) const |
| Save the current internal state of the phase. More...
|
|
void | saveState (size_t lenstate, doublereal *state) const |
| Write to array 'state' the current internal state. More...
|
|
void | restoreState (const vector_fp &state) |
| Restore a state saved on a previous call to saveState. More...
|
|
void | restoreState (size_t lenstate, const doublereal *state) |
| Restore the state of the phase from a previously saved state vector. More...
|
|
doublereal | molecularWeight (size_t k) const |
| Molecular weight of species k . More...
|
|
void | getMolecularWeights (vector_fp &weights) const |
| Copy the vector of molecular weights into vector weights. More...
|
|
void | getMolecularWeights (doublereal *weights) const |
| Copy the vector of molecular weights into array weights. More...
|
|
const vector_fp & | molecularWeights () const |
| Return a const reference to the internal vector of molecular weights. More...
|
|
virtual double | size (size_t k) const |
|
doublereal | charge (size_t k) const |
| Dimensionless electrical charge of a single molecule of species k The charge is normalized by the the magnitude of the electron charge. More...
|
|
doublereal | chargeDensity () const |
| Charge density [C/m^3]. More...
|
|
size_t | nDim () const |
| Returns the number of spatial dimensions (1, 2, or 3) More...
|
|
void | setNDim (size_t ndim) |
| Set the number of spatial dimensions (1, 2, or 3). More...
|
|
int | stateMFNumber () const |
| Return the State Mole Fraction Number. More...
|
|
std::string | id () const |
| Return the string id for the phase. More...
|
|
void | setID (const std::string &id) |
| Set the string id for the phase. More...
|
|
std::string | name () const |
| Return the name of the phase. More...
|
|
void | setName (const std::string &nm) |
| Sets the string name for the phase. More...
|
|
std::string | elementName (size_t m) const |
| Name of the element with index m. More...
|
|
size_t | elementIndex (const std::string &name) const |
| Return the index of element named 'name'. More...
|
|
const std::vector< std::string > & | elementNames () const |
| Return a read-only reference to the vector of element names. More...
|
|
doublereal | atomicWeight (size_t m) const |
| Atomic weight of element m. More...
|
|
doublereal | entropyElement298 (size_t m) const |
| Entropy of the element in its standard state at 298 K and 1 bar. More...
|
|
int | atomicNumber (size_t m) const |
| Atomic number of element m. More...
|
|
int | elementType (size_t m) const |
| Return the element constraint type Possible types include: More...
|
|
int | changeElementType (int m, int elem_type) |
| Change the element type of the mth constraint Reassigns an element type. More...
|
|
const vector_fp & | atomicWeights () const |
| Return a read-only reference to the vector of atomic weights. More...
|
|
size_t | nElements () const |
| Number of elements. More...
|
|
void | checkElementIndex (size_t m) const |
| Check that the specified element index is in range. More...
|
|
void | checkElementArraySize (size_t mm) const |
| Check that an array size is at least nElements(). More...
|
|
doublereal | nAtoms (size_t k, size_t m) const |
| Number of atoms of element m in species k . More...
|
|
void | getAtoms (size_t k, double *atomArray) const |
| Get a vector containing the atomic composition of species k. More...
|
|
size_t | speciesIndex (const std::string &name) const |
| Returns the index of a species named 'name' within the Phase object. More...
|
|
std::string | speciesName (size_t k) const |
| Name of the species with index k. More...
|
|
std::string | speciesSPName (int k) const |
| Returns the expanded species name of a species, including the phase name This is guaranteed to be unique within a Cantera problem. More...
|
|
const std::vector< std::string > & | speciesNames () const |
| Return a const reference to the vector of species names. More...
|
|
size_t | nSpecies () const |
| Returns the number of species in the phase. More...
|
|
void | checkSpeciesIndex (size_t k) const |
| Check that the specified species index is in range. More...
|
|
void | checkSpeciesArraySize (size_t kk) const |
| Check that an array size is at least nSpecies(). More...
|
|
void | setMoleFractionsByName (const compositionMap &xMap) |
| Set the species mole fractions by name. More...
|
|
void | setMoleFractionsByName (const std::string &x) |
| Set the mole fractions of a group of species by name. More...
|
|
void | setMassFractionsByName (const compositionMap &yMap) |
| Set the species mass fractions by name. More...
|
|
void | setMassFractionsByName (const std::string &x) |
| Set the species mass fractions by name. More...
|
|
void | setState_TRX (doublereal t, doublereal dens, const doublereal *x) |
| Set the internally stored temperature (K), density, and mole fractions. More...
|
|
void | setState_TRX (doublereal t, doublereal dens, const compositionMap &x) |
| Set the internally stored temperature (K), density, and mole fractions. More...
|
|
void | setState_TRY (doublereal t, doublereal dens, const doublereal *y) |
| Set the internally stored temperature (K), density, and mass fractions. More...
|
|
void | setState_TRY (doublereal t, doublereal dens, const compositionMap &y) |
| Set the internally stored temperature (K), density, and mass fractions. More...
|
|
void | setState_TNX (doublereal t, doublereal n, const doublereal *x) |
| Set the internally stored temperature (K), molar density (kmol/m^3), and mole fractions. More...
|
|
void | setState_TR (doublereal t, doublereal rho) |
| Set the internally stored temperature (K) and density (kg/m^3) More...
|
|
void | setState_TX (doublereal t, doublereal *x) |
| Set the internally stored temperature (K) and mole fractions. More...
|
|
void | setState_TY (doublereal t, doublereal *y) |
| Set the internally stored temperature (K) and mass fractions. More...
|
|
void | setState_RX (doublereal rho, doublereal *x) |
| Set the density (kg/m^3) and mole fractions. More...
|
|
void | setState_RY (doublereal rho, doublereal *y) |
| Set the density (kg/m^3) and mass fractions. More...
|
|
compositionMap | getMoleFractionsByName (double threshold=0.0) const |
| Get the mole fractions by name. More...
|
|
doublereal | moleFraction (size_t k) const |
| Return the mole fraction of a single species. More...
|
|
doublereal | moleFraction (const std::string &name) const |
| Return the mole fraction of a single species. More...
|
|
compositionMap | getMassFractionsByName (double threshold=0.0) const |
| Get the mass fractions by name. More...
|
|
doublereal | massFraction (size_t k) const |
| Return the mass fraction of a single species. More...
|
|
doublereal | massFraction (const std::string &name) const |
| Return the mass fraction of a single species. More...
|
|
void | getMoleFractions (doublereal *const x) const |
| Get the species mole fraction vector. More...
|
|
virtual void | setMoleFractions (const doublereal *const x) |
| Set the mole fractions to the specified values. More...
|
|
virtual void | setMoleFractions_NoNorm (const doublereal *const x) |
| Set the mole fractions to the specified values without normalizing. More...
|
|
void | getMassFractions (doublereal *const y) const |
| Get the species mass fractions. More...
|
|
const doublereal * | massFractions () const |
| Return a const pointer to the mass fraction array. More...
|
|
virtual void | setMassFractions (const doublereal *const y) |
| Set the mass fractions to the specified values and normalize them. More...
|
|
virtual void | setMassFractions_NoNorm (const doublereal *const y) |
| Set the mass fractions to the specified values without normalizing. More...
|
|
void | getConcentrations (doublereal *const c) const |
| Get the species concentrations (kmol/m^3). More...
|
|
doublereal | concentration (const size_t k) const |
| Concentration of species k. More...
|
|
virtual void | setConcentrations (const doublereal *const conc) |
| Set the concentrations to the specified values within the phase. More...
|
|
virtual void | setConcentrationsNoNorm (const double *const conc) |
| Set the concentrations without ignoring negative concentrations. More...
|
|
doublereal | elementalMassFraction (const size_t m) const |
| Elemental mass fraction of element m. More...
|
|
doublereal | elementalMoleFraction (const size_t m) const |
| Elemental mole fraction of element m. More...
|
|
const doublereal * | moleFractdivMMW () const |
| Returns a const pointer to the start of the moleFraction/MW array. More...
|
|
doublereal | temperature () const |
| Temperature (K). More...
|
|
virtual doublereal | density () const |
| Density (kg/m^3). More...
|
|
doublereal | molarDensity () const |
| Molar density (kmol/m^3). More...
|
|
doublereal | molarVolume () const |
| Molar volume (m^3/kmol). More...
|
|
virtual void | setDensity (const doublereal density_) |
| Set the internally stored density (kg/m^3) of the phase. More...
|
|
virtual void | setMolarDensity (const doublereal molarDensity) |
| Set the internally stored molar density (kmol/m^3) of the phase. More...
|
|
virtual void | setTemperature (const doublereal temp) |
| Set the internally stored temperature of the phase (K). More...
|
|
doublereal | mean_X (const doublereal *const Q) const |
| Evaluate the mole-fraction-weighted mean of an array Q. More...
|
|
doublereal | mean_X (const vector_fp &Q) const |
| Evaluate the mole-fraction-weighted mean of an array Q. More...
|
|
doublereal | meanMolecularWeight () const |
| The mean molecular weight. Units: (kg/kmol) More...
|
|
doublereal | sum_xlogx () const |
| Evaluate \( \sum_k X_k \log X_k \). More...
|
|
size_t | addElement (const std::string &symbol, doublereal weight=-12345.0, int atomicNumber=0, doublereal entropy298=ENTROPY298_UNKNOWN, int elem_type=CT_ELEM_TYPE_ABSPOS) |
| Add an element. More...
|
|
shared_ptr< Species > | species (const std::string &name) const |
| Return the Species object for the named species. More...
|
|
shared_ptr< Species > | species (size_t k) const |
| Return the Species object for species whose index is k. More...
|
|
void | ignoreUndefinedElements () |
| Set behavior when adding a species containing undefined elements to just skip the species. More...
|
|
void | addUndefinedElements () |
| Set behavior when adding a species containing undefined elements to add those elements to the phase. More...
|
|
void | throwUndefinedElements () |
| Set the behavior when adding a species containing undefined elements to throw an exception. More...
|
|