Cantera  2.0
Public Member Functions | Protected Member Functions | Protected Attributes | Private Types | Private Member Functions | Private Attributes | Friends | List of all members
LiquidTransport Class Reference

Class LiquidTransport implements models for transport properties for liquid phases. More...

#include <LiquidTransport.h>

Inheritance diagram for LiquidTransport:
[legend]
Collaboration diagram for LiquidTransport:
[legend]

Public Member Functions

 LiquidTransport (thermo_t *thermo=0, int ndim=1)
 Default constructor.
 
 LiquidTransport (const LiquidTransport &right)
 Copy Constructor for the LiquidThermo object.
 
LiquidTransportoperator= (const LiquidTransport &right)
 Assignment operator.
 
virtual TransportduplMyselfAsTransport () const
 Duplication routine for objects which inherit from Transport.
 
virtual ~LiquidTransport ()
 virtual destructor
 
virtual bool initLiquid (LiquidTransportParams &tr)
 Initialize the transport object.
 
virtual int model () const
 Return the model id for this transport parameterization.
 
virtual doublereal viscosity ()
 Returns the viscosity of the solution.
 
virtual void getSpeciesViscosities (doublereal *const visc)
 Returns the pure species viscosities for all species.
 
virtual doublereal ionConductivity ()
 Returns the ionic conductivity of the solution.
 
virtual void getSpeciesIonConductivity (doublereal *const ionCond)
 Returns the pure species ionic conductivities for all species.
 
virtual void mobilityRatio (doublereal *mobRat)
 Returns the pointer to the mobility ratios of the binary combinations of the transported species for the solution Has size of the number of binary interactions = nsp*nsp.
 
virtual void getSpeciesMobilityRatio (doublereal **mobRat)
 Returns a double pointer to the mobility ratios of the transported species in each pure species phase.
 
virtual void selfDiffusion (doublereal *const selfDiff)
 Returns the self diffusion coefficients of the species in the phase.
 
virtual void getSpeciesSelfDiffusion (doublereal **selfDiff)
 Returns the self diffusion coefficients in the pure species phases.
 
virtual void getSpeciesHydrodynamicRadius (doublereal *const radius)
 Returns the hydrodynamic radius for all species.
 
virtual void getBinaryDiffCoeffs (const size_t ld, doublereal *const d)
 Returns the binary diffusion coefficients.
 
virtual void getMixDiffCoeffs (doublereal *const d)
 Get the Mixture diffusion coefficients.
 
virtual void getThermalDiffCoeffs (doublereal *const dt)
 Return the thermal diffusion coefficients.
 
virtual doublereal thermalConductivity ()
 Return the thermal conductivity of the solution.
 
virtual void getMobilities (doublereal *const mobil_e)
 Get the Electrical mobilities (m^2/V/s).
 
virtual void getFluidMobilities (doublereal *const mobil_f)
 Get the fluid mobilities (s kmol/kg).
 
virtual void set_Grad_V (const doublereal *const grad_V)
 Specify the value of the gradient of the voltage.
 
virtual void set_Grad_T (const doublereal *const grad_T)
 Specify the value of the gradient of the temperature.
 
virtual void set_Grad_X (const doublereal *const grad_X)
 Specify the value of the gradient of the MoleFractions.
 
virtual doublereal getElectricConduct ()
 Compute the mixture electrical conductivity from the Stefan-Maxwell equation.
 
virtual void getElectricCurrent (int ndim, const doublereal *grad_T, int ldx, const doublereal *grad_X, int ldf, const doublereal *grad_V, doublereal *current)
 Compute the electric current density in A/m^2.
 
virtual void getSpeciesVdiff (size_t ndim, const doublereal *grad_T, int ldx, const doublereal *grad_X, int ldf, doublereal *Vdiff)
 Get the species diffusive velocities wrt to the averaged velocity, given the gradients in mole fraction and temperature.
 
virtual void getSpeciesVdiffES (size_t ndim, const doublereal *grad_T, int ldx, const doublereal *grad_X, int ldf, const doublereal *grad_Phi, doublereal *Vdiff)
 Get the species diffusive velocities wrt to the averaged velocity, given the gradients in mole fraction, temperature and electrostatic potential.
 
virtual void getSpeciesFluxes (size_t ndim, const doublereal *const grad_T, size_t ldx, const doublereal *const grad_X, size_t ldf, doublereal *const fluxes)
 Return the species diffusive mass fluxes wrt to the averaged velocity in [kmol/m^2/s].
 
virtual void getSpeciesFluxesES (size_t ndim, const doublereal *grad_T, int ldx, const doublereal *grad_X, int ldf, const doublereal *grad_Phi, doublereal *fluxes)
 Return the species diffusive mass fluxes wrt to the averaged velocity in [kmol/m^2/s].
 
virtual void getSpeciesVdiffExt (size_t ldf, doublereal *Vdiff)
 Return the species diffusive velocities relative to the averaged velocity.
 
virtual void getSpeciesFluxesExt (size_t ldf, doublereal *fluxes)
 Return the species diffusive fluxes relative to the averaged velocity.
 
thermo_tthermo ()
 Phase object.
 
bool ready ()
 Returns true if the transport manager is ready for use.
 
void setNDim (const int ndim)
 Set the number of dimensions to be expected in flux expressions.
 
size_t nDim () const
 Return the number of dimensions in flux expressions.
 
void checkSpeciesIndex (size_t k) const
 Check that the specified species index is in range Throws an exception if k is greater than nSpecies()
 
void checkSpeciesArraySize (size_t kk) const
 Check that an array size is at least nSpecies() Throws an exception if kk is less than nSpecies().
 
virtual void getSpeciesFluxesES (size_t ndim, const doublereal *grad_T, size_t ldx, const doublereal *grad_X, size_t ldf, const doublereal *grad_Phi, doublereal *fluxes)
 Get the species diffusive mass fluxes wrt to the mass averaged velocity, given the gradients in mole fraction, temperature and electrostatic potential.
 
virtual void getMolarFluxes (const doublereal *const state1, const doublereal *const state2, const doublereal delta, doublereal *const cfluxes)
 Get the molar fluxes [kmol/m^2/s], given the thermodynamic state at two nearby points.
 
virtual void getMassFluxes (const doublereal *state1, const doublereal *state2, doublereal delta, doublereal *mfluxes)
 Get the mass fluxes [kg/m^2/s], given the thermodynamic state at two nearby points.
 
virtual void getMultiDiffCoeffs (const size_t ld, doublereal *const d)
 Return the Multicomponent diffusion coefficients. Units: [m^2/s].
 
virtual void getMixDiffCoeffsMole (doublereal *const d)
 Returns a vector of mixture averaged diffusion coefficients.
 
virtual void getMixDiffCoeffsMass (doublereal *const d)
 Returns a vector of mixture averaged diffusion coefficients.
 
virtual void setParameters (const int type, const int k, const doublereal *const p)
 Set model parameters for derived classes.
 
void setVelocityBasis (VelocityBasis ivb)
 Sets the velocity basis.
 
VelocityBasis getVelocityBasis () const
 Gets the velocity basis.
 
Transport Properties
virtual doublereal bulkViscosity ()
 The bulk viscosity in Pa-s.
 
virtual doublereal electricalConductivity ()
 The electrical conductivity (Siemens/m).
 

Protected Member Functions

virtual bool update_T ()
 Returns true if temperature has changed, in which case flags are set to recompute transport properties.
 
virtual bool update_C ()
 Returns true if mixture composition has changed, in which case flags are set to recompute transport properties.
 
virtual void update_Grad_lnAC ()
 Updates the internal value of the gradient of the logarithm of the activity, which is used in the gradient of the chemical potential.
 
void stefan_maxwell_solve ()
 Solve the stefan_maxell equations for the diffusive fluxes.
 
void updateViscosity_T ()
 Updates the array of pure species viscosities internally.
 
void updateIonConductivity_T ()
 Update the temperature-dependent ionic conductivity terms for each species internally.
 
void updateMobilityRatio_T ()
 Updates the array of pure species mobility ratios internally.
 
void updateSelfDiffusion_T ()
 Updates the array of pure species self diffusion coeffs internally.
 
void updateHydrodynamicRadius_T ()
 Update the temperature-dependent hydrodynamic radius terms for each species internally.
 
void updateCond_T ()
 Update the temperature-dependent parts of the mixture-averaged thermal conductivity internally.
 
void updateViscosities_C ()
 Update the concentration parts of the viscosities.
 
void updateIonConductivity_C ()
 Update the concentration parts of the ionic conductivity.
 
void updateMobilityRatio_C ()
 Update the concentration parts of the mobility ratio.
 
void updateSelfDiffusion_C ()
 Update the concentration parts of the self diffusion.
 
void updateHydrodynamicRadius_C ()
 Update the concentration dependence of the hydrodynamic radius.
 
void updateDiff_T ()
 Update the binary Stefan-Maxwell diffusion coefficients wrt T using calls to the appropriate LTPspecies subclass.
 
Transport manager construction

These methods are used internally during construction.

virtual bool initGas (GasTransportParams &tr)
 Called by TransportFactory to set parameters.
 
void setThermo (thermo_t &thermo)
 Specifies the ThermPhase object.
 
void finalize ()
 Enable the transport object for use.
 

Protected Attributes

thermo_tm_thermo
 pointer to the object representing the phase
 
bool m_ready
 true if finalize has been called
 
size_t m_nsp
 Number of species.
 
int m_velocityBasis
 Velocity basis from which diffusion velocities are computed.
 

Private Types

typedef std::vector< LTPspecies * > LTPvector
 Type def for LTPvector equating it with a vector of pointers to LTPspecies.
 

Private Member Functions

doublereal err (std::string msg) const
 Throw an exception if this method is invoked.
 

Private Attributes

size_t m_nsp2
 Number of species squared.
 
doublereal m_tmin
 Minimum temperature applicable to the transport property eval.
 
doublereal m_tmax
 Maximum temperature applicable to the transport property evaluator.
 
vector_fp m_mw
 Local copy of the molecular weights of the species.
 
std::vector< LTPspecies * > m_viscTempDep_Ns
 Viscosity for each species expressed as an appropriate subclass of LTPspecies.
 
LiquidTranInteractionm_viscMixModel
 Viscosity of the mixture expressed as a subclass of LiquidTranInteraction.
 
std::vector< LTPspecies * > m_ionCondTempDep_Ns
 Ionic conductivity for each species expressed as an appropriate subclass of LTPspecies.
 
LiquidTranInteractionm_ionCondMixModel
 Ionic Conductivity of the mixture expressed as a subclass of LiquidTranInteraction.
 
std::vector< LTPvectorm_mobRatTempDep_Ns
 Mobility ratio for the binary cominations of each species in each pure phase expressed as an appropriate subclass of LTPspecies.
 
std::vector
< LiquidTranInteraction * > 
m_mobRatMixModel
 Mobility ratio for each binary combination of mobile species in the mixture expressed as a subclass of LiquidTranInteraction.
 
std::vector< LTPvectorm_selfDiffTempDep_Ns
 Self Diffusion for each species in each pure species phase expressed as an appropriate subclass of LTPspecies.
 
std::vector
< LiquidTranInteraction * > 
m_selfDiffMixModel
 Self Diffusion for each species in the mixture expressed as a subclass of LiquidTranInteraction.
 
std::vector< LTPspecies * > m_lambdaTempDep_Ns
 Thermal conductivity for each species expressed as an appropriate subclass of LTPspecies.
 
LiquidTranInteractionm_lambdaMixModel
 Thermal conductivity of the mixture expressed as a subclass of LiquidTranInteraction.
 
std::vector< LTPspecies * > m_diffTempDep_Ns
 (NOT USED IN LiquidTransport.) Diffusion coefficient model for each species expressed as an appropriate subclass of LTPspecies
 
LiquidTranInteractionm_diffMixModel
 Species diffusivity of the mixture expressed as a subclass of LiquidTranInteraction.
 
DenseMatrix m_diff_Dij
 Setfan-Maxwell diffusion coefficients.
 
std::vector< LTPspecies * > m_radiusTempDep_Ns
 Hydrodynamic radius for each species expressed as an appropriate subclass of LTPspecies.
 
LiquidTranInteractionm_radiusMixModel
 (Not used in LiquidTransport) Hydrodynamic radius of the mixture expressed as a subclass of LiquidTranInteraction
 
vector_fp m_hydrodynamic_radius
 Species hydrodynamic radius.
 
vector_fp m_Grad_X
 Hydrodynamic radius.
 
vector_fp m_Grad_lnAC
 Gradient of the logarithm of the activity.
 
vector_fp m_Grad_T
 Internal value of the gradient of the Temperature vector.
 
vector_fp m_Grad_P
 Internal value of the gradient of the Pressure vector.
 
vector_fp m_Grad_V
 Internal value of the gradient of the Electric Voltage.
 
vector_fp m_Grad_mu
 Gradient of the electrochemical potential.
 
DenseMatrix m_bdiff
 Array of Binary Diffusivities.
 
vector_fp m_viscSpecies
 Internal value of the species viscosities.
 
vector_fp m_ionCondSpecies
 Internal value of the species ionic conductivities.
 
DenseMatrix m_mobRatSpecies
 Internal value of the species mobility ratios.
 
DenseMatrix m_selfDiffSpecies
 Internal value of the species self diffusion coefficients.
 
vector_fp m_lambdaSpecies
 Internal value of the species individual thermal conductivities.
 
int m_iStateMF
 State of the mole fraction vector.
 
vector_fp m_massfracs
 Local copy of the mass fractions of the species in the phase.
 
vector_fp m_massfracs_tran
 Local copy of the mass fractions of the species in the phase.
 
vector_fp m_molefracs
 Local copy of the mole fractions of the species in the phase.
 
vector_fp m_molefracs_tran
 Non-zero mole fraction vector used in transport property calculations.
 
vector_fp m_concentrations
 Local copy of the concentrations of the species in the phase.
 
doublereal concTot_
 Local copy of the total concentration.
 
doublereal concTot_tran_
 Local copy of the total concentration.
 
doublereal meanMolecularWeight_
 Mean molecular mass.
 
doublereal dens_
 Density.
 
vector_fp m_chargeSpecies
 Local copy of the charge of each species.
 
vector_fp m_volume_spec
 Specific volume for each species. Local copy from thermo object.
 
vector_fp m_actCoeff
 Vector of activity coefficients.
 
DenseMatrix m_B
 RHS to the stefan-maxwell equation.
 
DenseMatrix m_A
 Matrix for the stefan maxwell equation.
 
doublereal m_temp
 Current Temperature -> locally stored.
 
doublereal m_press
 Current value of the pressure.
 
Array2D m_flux
 Solution of the Stefan Maxwell equation in terms of flux.
 
Array2D m_Vdiff
 Solution of the Stefan Maxwell equation.
 
doublereal m_lambda
 Saved value of the mixture thermal conductivity.
 
doublereal m_viscmix
 Saved value of the mixture viscosity.
 
doublereal m_ionCondmix
 Saved value of the mixture ionic conductivity.
 
vector_fp m_mobRatMix
 Saved values of the mixture mobility ratios.
 
vector_fp m_selfDiffMix
 Saved values of the mixture self diffusion coefficients.
 
vector_fp m_spwork
 work space
 
bool m_visc_mix_ok
 Boolean indicating that the top-level mixture viscosity is current.
 
bool m_visc_temp_ok
 Boolean indicating that weight factors wrt viscosity is current.
 
bool m_visc_conc_ok
 Flag to indicate that the pure species viscosities are current wrt the concentration.
 
bool m_ionCond_mix_ok
 Boolean indicating that the top-level mixture ionic conductivity is current.
 
bool m_ionCond_temp_ok
 Boolean indicating that weight factors wrt ionic conductivty is current.
 
bool m_ionCond_conc_ok
 Flag to indicate that the pure species ionic conductivities are current wrt the concentration.
 
bool m_cond_mix_ok
 Flag to indicate that the mixture conductivity is current.
 
bool m_mobRat_mix_ok
 Boolean indicating that the top-level mixture mobility ratio is current.
 
bool m_mobRat_temp_ok
 Boolean indicating that weight factors wrt mobility ratio is current.
 
bool m_mobRat_conc_ok
 Flag to indicate that the pure species mobility ratios are current wrt the concentration.
 
bool m_selfDiff_mix_ok
 Boolean indicating that the top-level mixture self diffusion is current.
 
bool m_selfDiff_temp_ok
 Boolean indicating that weight factors wrt self diffusion is current.
 
bool m_selfDiff_conc_ok
 Flag to indicate that the pure species self diffusion are current wrt the concentration.
 
bool m_radi_mix_ok
 Boolean indicating that mixture diffusion coeffs are current.
 
bool m_radi_temp_ok
 Boolean indicating that temperature dependence of hydrodynamic radius is current.
 
bool m_radi_conc_ok
 Flag to indicate that the hydrodynamic radius is current is current wrt the concentration.
 
bool m_diff_mix_ok
 Boolean indicating that mixture diffusion coeffs are current.
 
bool m_diff_temp_ok
 Boolean indicating that binary diffusion coeffs are current.
 
bool m_lambda_temp_ok
 Flag to indicate that the pure species conductivities are current wrt the temperature.
 
bool m_lambda_mix_ok
 Boolean indicating that mixture conductivity is current.
 
int m_mode
 Mode indicator for transport models – currently unused.
 
bool m_debug
 Debugging flags.
 
size_t m_nDim
 Number of dimensions.
 

Friends

class TransportFactory
 

Detailed Description

Class LiquidTransport implements models for transport properties for liquid phases.

Liquid Transport is set up with some flexibility in this class. Transport properties like viscosity and thermal conductivity are allowed flexibility within the constraints of the LiquidTransportProperty and LiquidTransportInteractions classes. For species diffusion, the LiquidTransport class focuses on the Stefan-Maxwell equation to determine the diffusion velocities. Other options for liquid diffusion include solvent-dominated diffusion, and a class SolventTransport should be forthcoming.

The class LiquidTransport has several roles.

  1. It brings together the individual species transport properties, expressed as subclasses of LTPspecies (Liquid Transport Properties of Species) through LiquidTransportData, with models for the composition dependence of liquid transport properties expressed as subclasses of LiquidTranInteraction (mixing rules) through LiquidTransportParams. Calculating mixture properties generally consists of calling the getMixTansProp member of LiquidTranInteraction by passing a vector of LTPSpecies
  2. It calculates the bulk velocity \( \vec{v} \) and individual species diffusion velocities, \( \vec{V_i} \) using the Stefan-Maxwell equations. It is possible to set a flag to calculate relative to a mass-averaged bulk velocity, relative to a mole-averaged bulk velocity or relative to a single species velocity using the <velocityBasis basis="mass">, <velocityBasis basis="mass">, or <velocityBasis basis="Cl-"> keyword. Mass-averaged velocities are the default for which the diffusion velocities satisfy

    \[ \sum_{i} Y_i \vec{V_i} = 0 \]

    for mass fraction \( Y_i \). For mole-averaged velocities

    \[ \sum_{i} X_i \vec{V_i} = 0 \]

    for mole fraction \( X_i \). or

    \[ \vec{V_i} = 0 \]

    for reference species \( i \).
  3. It provides access to a number of derived quantities related to transport properties as described in the various methods below.

Within LiquidTransport, the state is presumed to be defined in terms of the species mole fraction, temperature and pressure. Charged species are expected and quantities like the electric current are computed based on a combined electrochemcial potential.

Definition at line 90 of file LiquidTransport.h.

Member Typedef Documentation

typedef std::vector<LTPspecies*> LTPvector
private

Type def for LTPvector equating it with a vector of pointers to LTPspecies.

Definition at line 930 of file LiquidTransport.h.

Constructor & Destructor Documentation

LiquidTransport ( thermo_t thermo = 0,
int  ndim = 1 
)

Default constructor.

This requires call to initLiquid(LiquidTransportParams& tr) after filling LiquidTransportParams to complete instantiation. The filling of LiquidTransportParams is currently carried out in the TransportFactory class, but might be moved at some point.

Parameters
thermoThermoPhase object holding species information.
ndimNumber of spatial dimensions.

Definition at line 32 of file LiquidTransport.cpp.

Referenced by LiquidTransport::duplMyselfAsTransport().

LiquidTransport ( const LiquidTransport right)

Copy Constructor for the LiquidThermo object.

Parameters
rightLiquidTransport to be copied

Definition at line 79 of file LiquidTransport.cpp.

~LiquidTransport ( )
virtual

Member Function Documentation

LiquidTransport & operator= ( const LiquidTransport right)

Assignment operator.

This is NOT a virtual function.

Parameters
rightReference to LiquidTransport object to be copied into the current one.

Definition at line 130 of file LiquidTransport.cpp.

References LiquidTransport::m_A, LiquidTransport::m_actCoeff, LiquidTransport::m_B, LiquidTransport::m_bdiff, LiquidTransport::m_chargeSpecies, LiquidTransport::m_concentrations, LiquidTransport::m_debug, LiquidTransport::m_diff_mix_ok, LiquidTransport::m_diff_temp_ok, LiquidTransport::m_diffMixModel, LiquidTransport::m_diffTempDep_Ns, LiquidTransport::m_flux, LiquidTransport::m_Grad_lnAC, LiquidTransport::m_Grad_mu, LiquidTransport::m_Grad_T, LiquidTransport::m_Grad_V, LiquidTransport::m_Grad_X, LiquidTransport::m_hydrodynamic_radius, LiquidTransport::m_ionCond_conc_ok, LiquidTransport::m_ionCond_mix_ok, LiquidTransport::m_ionCond_temp_ok, LiquidTransport::m_ionCondmix, LiquidTransport::m_ionCondMixModel, LiquidTransport::m_ionCondSpecies, LiquidTransport::m_ionCondTempDep_Ns, LiquidTransport::m_iStateMF, LiquidTransport::m_lambda, LiquidTransport::m_lambda_mix_ok, LiquidTransport::m_lambda_temp_ok, LiquidTransport::m_lambdaMixModel, LiquidTransport::m_lambdaSpecies, LiquidTransport::m_lambdaTempDep_Ns, LiquidTransport::m_massfracs, LiquidTransport::m_massfracs_tran, LiquidTransport::m_mobRat_conc_ok, LiquidTransport::m_mobRat_mix_ok, LiquidTransport::m_mobRat_temp_ok, LiquidTransport::m_mobRatMix, LiquidTransport::m_mobRatMixModel, LiquidTransport::m_mobRatSpecies, LiquidTransport::m_mobRatTempDep_Ns, LiquidTransport::m_mode, LiquidTransport::m_molefracs, LiquidTransport::m_molefracs_tran, LiquidTransport::m_mw, LiquidTransport::m_nDim, LiquidTransport::m_nsp2, LiquidTransport::m_press, LiquidTransport::m_radi_conc_ok, LiquidTransport::m_radi_mix_ok, LiquidTransport::m_radi_temp_ok, LiquidTransport::m_radiusTempDep_Ns, LiquidTransport::m_selfDiff_conc_ok, LiquidTransport::m_selfDiff_mix_ok, LiquidTransport::m_selfDiff_temp_ok, LiquidTransport::m_selfDiffMix, LiquidTransport::m_selfDiffMixModel, LiquidTransport::m_selfDiffSpecies, LiquidTransport::m_selfDiffTempDep_Ns, LiquidTransport::m_spwork, LiquidTransport::m_temp, LiquidTransport::m_tmax, LiquidTransport::m_tmin, LiquidTransport::m_Vdiff, LiquidTransport::m_visc_conc_ok, LiquidTransport::m_visc_mix_ok, LiquidTransport::m_visc_temp_ok, LiquidTransport::m_viscmix, LiquidTransport::m_viscMixModel, LiquidTransport::m_viscSpecies, LiquidTransport::m_viscTempDep_Ns, and Transport::operator=().

Transport * duplMyselfAsTransport ( ) const
virtual

Duplication routine for objects which inherit from Transport.

This virtual routine can be used to duplicate Transport objects inherited from Transport even if the application only has a pointer to Transport to work with.

These routines are basically wrappers around the derived copy constructor.

Reimplemented from Transport.

Definition at line 213 of file LiquidTransport.cpp.

References LiquidTransport::LiquidTransport().

bool initLiquid ( LiquidTransportParams tr)
virtual

Initialize the transport object.

Here we change all of the internal dimensions to be sufficient. We get the object ready to do property evaluations. A lot of the input required to do property evaluations is contained in the LiquidTransportParams class that is filled in TransportFactory.

Parameters
trTransport parameters for all of the species in the phase.

Reimplemented from Transport.

Definition at line 288 of file LiquidTransport.cpp.

References Phase::charge(), LiquidTransportData::hydroRadius, LiquidTransportData::ionConductivity, LiquidTransportParams::ionConductivity, LiquidTransportParams::LTData, LiquidTransport::m_actCoeff, LiquidTransport::m_bdiff, LiquidTransport::m_chargeSpecies, LiquidTransport::m_concentrations, LiquidTransport::m_diff_mix_ok, LiquidTransport::m_diff_temp_ok, LiquidTransport::m_diffMixModel, LiquidTransport::m_diffTempDep_Ns, LiquidTransport::m_flux, LiquidTransport::m_Grad_lnAC, LiquidTransport::m_Grad_mu, LiquidTransport::m_Grad_T, LiquidTransport::m_Grad_V, LiquidTransport::m_Grad_X, LiquidTransport::m_hydrodynamic_radius, LiquidTransport::m_ionCond_conc_ok, LiquidTransport::m_ionCond_mix_ok, LiquidTransport::m_ionCond_temp_ok, LiquidTransport::m_ionCondMixModel, LiquidTransport::m_ionCondSpecies, LiquidTransport::m_ionCondTempDep_Ns, LiquidTransport::m_lambda_mix_ok, LiquidTransport::m_lambda_temp_ok, LiquidTransport::m_lambdaMixModel, LiquidTransport::m_lambdaSpecies, LiquidTransport::m_lambdaTempDep_Ns, LiquidTransport::m_massfracs, LiquidTransport::m_massfracs_tran, LiquidTransport::m_mobRat_conc_ok, LiquidTransport::m_mobRat_mix_ok, LiquidTransport::m_mobRat_temp_ok, LiquidTransport::m_mobRatMix, LiquidTransport::m_mobRatMixModel, LiquidTransport::m_mobRatSpecies, LiquidTransport::m_mobRatTempDep_Ns, LiquidTransport::m_mode, LiquidTransport::m_molefracs, LiquidTransport::m_molefracs_tran, LiquidTransport::m_mw, LiquidTransport::m_nDim, Transport::m_nsp, LiquidTransport::m_nsp2, LiquidTransport::m_radi_conc_ok, LiquidTransport::m_radi_temp_ok, LiquidTransport::m_radiusTempDep_Ns, LiquidTransport::m_selfDiff_conc_ok, LiquidTransport::m_selfDiff_mix_ok, LiquidTransport::m_selfDiff_temp_ok, LiquidTransport::m_selfDiffMix, LiquidTransport::m_selfDiffMixModel, LiquidTransport::m_selfDiffSpecies, LiquidTransport::m_selfDiffTempDep_Ns, LiquidTransport::m_spwork, Transport::m_thermo, LiquidTransport::m_tmax, LiquidTransport::m_tmin, LiquidTransport::m_Vdiff, Transport::m_velocityBasis, LiquidTransport::m_visc_conc_ok, LiquidTransport::m_visc_mix_ok, LiquidTransport::m_visc_temp_ok, LiquidTransport::m_viscMixModel, LiquidTransport::m_viscSpecies, LiquidTransport::m_viscTempDep_Ns, LiquidTransport::m_volume_spec, ThermoPhase::maxTemp(), ThermoPhase::minTemp(), LiquidTransportData::mobilityRatio, LiquidTransportParams::mobilityRatio, TransportParams::mode_, Phase::molecularWeights(), Phase::nSpecies(), DenseMatrix::resize(), Array2D::resize(), LiquidTransportData::selfDiffusion, LiquidTransportParams::selfDiffusion, LiquidTransportData::speciesDiffusivity, LiquidTransportParams::speciesDiffusivity, Phase::speciesName(), LiquidTransportData::thermalCond, LiquidTransportParams::thermalCond, TransportParams::thermo, TransportParams::velocityBasis_, LiquidTransportData::viscosity, and LiquidTransportParams::viscosity.

virtual int model ( ) const
inlinevirtual

Return the model id for this transport parameterization.

Reimplemented from Transport.

Definition at line 153 of file LiquidTransport.h.

Referenced by LiquidTransport::err().

doublereal viscosity ( )
virtual

Returns the viscosity of the solution.

The viscosity calculation is handled by subclasses of LiquidTranInteraction as specified in the input file. These in turn employ subclasses of LTPspecies to determine the individual species viscosities.

Reimplemented from Transport.

Definition at line 477 of file LiquidTransport.cpp.

References LiquidTranInteraction::getMixTransProp(), LiquidTransport::m_visc_mix_ok, LiquidTransport::m_viscmix, LiquidTransport::m_viscMixModel, LiquidTransport::m_viscTempDep_Ns, LiquidTransport::update_C(), and LiquidTransport::update_T().

void getSpeciesViscosities ( doublereal *const  visc)
virtual

Returns the pure species viscosities for all species.

The pure species viscosities are evaluated using the appropriate subclasses of LTPspecies as specified in the input file.

Parameters
viscarray of length "number of species" to hold returned viscosities.

Reimplemented from Transport.

Definition at line 502 of file LiquidTransport.cpp.

References LiquidTransport::m_visc_temp_ok, LiquidTransport::m_viscSpecies, LiquidTransport::update_T(), and LiquidTransport::updateViscosity_T().

doublereal ionConductivity ( )
virtual

Returns the ionic conductivity of the solution.

The ionic conductivity calculation is handled by subclasses of LiquidTranInteraction as specified in the input file. These in turn employ subclasses of LTPspecies to determine the individual species ionic conductivities.

Reimplemented from Transport.

Definition at line 520 of file LiquidTransport.cpp.

References LiquidTranInteraction::getMixTransProp(), LiquidTransport::m_ionCond_mix_ok, LiquidTransport::m_ionCondmix, LiquidTransport::m_ionCondMixModel, LiquidTransport::m_ionCondTempDep_Ns, LiquidTransport::update_C(), and LiquidTransport::update_T().

void getSpeciesIonConductivity ( doublereal *const  ionCond)
virtual

Returns the pure species ionic conductivities for all species.

The pure species ionic conductivities are evaluated using the appropriate subclasses of LTPspecies as specified in the input file.

Parameters
ionCondArray of length "number of species" to hold returned ionic conductivities.

Reimplemented from Transport.

Definition at line 556 of file LiquidTransport.cpp.

References LiquidTransport::m_ionCond_temp_ok, LiquidTransport::m_ionCondSpecies, LiquidTransport::update_T(), and LiquidTransport::updateIonConductivity_T().

void mobilityRatio ( doublereal *  mobRat)
virtual

Returns the pointer to the mobility ratios of the binary combinations of the transported species for the solution Has size of the number of binary interactions = nsp*nsp.

The mobility ratio calculation is handled by subclasses of LiquidTranInteraction as specified in the input file. These in turn employ subclasses of LTPspecies to determine the mobility ratios in the pure species.

Parameters
mobRatVector of mobility ratios

Reimplemented from Transport.

Definition at line 574 of file LiquidTransport.cpp.

References LiquidTransport::m_mobRat_mix_ok, LiquidTransport::m_mobRatMix, LiquidTransport::m_mobRatMixModel, LiquidTransport::m_mobRatTempDep_Ns, Transport::m_nsp, LiquidTransport::m_nsp2, LiquidTransport::update_C(), and LiquidTransport::update_T().

void getSpeciesMobilityRatio ( doublereal **  mobRat)
virtual

Returns a double pointer to the mobility ratios of the transported species in each pure species phase.

Has size of the number of binary interactions by the number of species (nsp*nsp X nsp) The pure species mobility ratios are evaluated using the appropriate subclasses of LTPspecies as specified in the input file.

Parameters
mobRatarray of length "number of species" to hold returned mobility ratios.

Reimplemented from Transport.

Definition at line 605 of file LiquidTransport.cpp.

References LiquidTransport::m_mobRat_temp_ok, LiquidTransport::m_mobRatSpecies, Transport::m_nsp, LiquidTransport::m_nsp2, LiquidTransport::update_T(), and LiquidTransport::updateMobilityRatio_T().

void selfDiffusion ( doublereal *const  selfDiff)
virtual

Returns the self diffusion coefficients of the species in the phase.

Has size of nsp(coeffs)

The self diffusion coefficient is the diffusion coefficient of a tracer species at the current temperature and composition of the species. Therefore, the dilute limit of transport is assumed for the tracer species. The effective formula may be calculated from the stefan-maxwell formulation by adding another row for the tracer species, assigning all D's to be equal to the respective species D's, and then taking the limit as the tracer species mole fraction goes to zero. The corresponding flux equation for the tracer species k in units of kmol m-2 s-1 is.

\[ J_k = - D^{sd}_k \frac{C_k}{R T} \nabla \mu_k \]

The derivative is taken at constant T and P.

The self diffusion calculation is handled by subclasses of LiquidTranInteraction as specified in the input file. These in turn employ subclasses of LTPspecies to determine the individual species self diffusion coeffs.

Parameters
selfDiffVector of self-diffusion coefficients Length = number of species in phase units = m**2 s-1

Reimplemented from Transport.

Definition at line 644 of file LiquidTransport.cpp.

References Transport::m_nsp, LiquidTransport::m_selfDiff_mix_ok, LiquidTransport::m_selfDiffMix, LiquidTransport::m_selfDiffMixModel, LiquidTransport::m_selfDiffTempDep_Ns, LiquidTransport::update_C(), and LiquidTransport::update_T().

void getSpeciesSelfDiffusion ( doublereal **  selfDiff)
virtual

Returns the self diffusion coefficients in the pure species phases.

Has size of nsp(coeffs) x nsp(phases)

The pure species molar volumes are evaluated using the appropriate subclasses of LTPspecies as specified in the input file.

Parameters
selfDiffarray of length "number of species" to hold returned self diffusion coeffs.

Reimplemented from Transport.

Definition at line 667 of file LiquidTransport.cpp.

References Transport::m_nsp, LiquidTransport::m_selfDiff_temp_ok, LiquidTransport::m_selfDiffSpecies, LiquidTransport::update_T(), and LiquidTransport::updateSelfDiffusion_T().

void getSpeciesHydrodynamicRadius ( doublereal *const  radius)
virtual

Returns the hydrodynamic radius for all species.

The species hydrodynamic radii are evaluated using the appropriate subclasses of LTPspecies as specified in the input file.

Parameters
radiusarray of length "number of species" to hold returned radii.

Definition at line 690 of file LiquidTransport.cpp.

References LiquidTransport::m_hydrodynamic_radius, LiquidTransport::m_radi_temp_ok, LiquidTransport::update_T(), and LiquidTransport::updateHydrodynamicRadius_T().

void getBinaryDiffCoeffs ( const size_t  ld,
doublereal *const  d 
)
virtual

Returns the binary diffusion coefficients.

The binary diffusion coefficients are specified in the input file through the LiquidTransportInteractions class. These are the binary interaction coefficients employed in the Stefan-Maxwell equation.

Parameters
ldnumber of species in system
dvector of binary diffusion coefficients units = m2 s-1. length = ld*ld = (number of species)^2

Reimplemented from Transport.

Definition at line 753 of file LiquidTransport.cpp.

References LiquidTransport::m_bdiff, LiquidTransport::m_diff_temp_ok, Transport::m_nsp, LiquidTransport::update_T(), and LiquidTransport::updateDiff_T().

void getMixDiffCoeffs ( doublereal *const  d)
virtual

Get the Mixture diffusion coefficients.

The mixture diffusion coefficients are not well defined in the context of LiquidTransport because the Stefan Maxwell equation is solved. Here the mixture diffusion coefficients are defined according to Ficks law:

\[ X_i \vec{V_i} = -D_i \nabla X_i. \]

Solving Ficks Law for \( D_i \) gives a mixture diffusion coefficient

\[ D_i = - X_i \vec{V_i} / ( \nabla X_i ). \]

If \( \nabla X_i = 0 \) this is undefined and the nonsensical value -1 is returned.

Note that this evaluation of \( \vec{V_i} \) requires a solve of the Stefan Maxwell equation making this determination of the mixture averaged diffusion coefficients a slow method for obtaining diffusion coefficients.

Also note that the Stefan Maxwell solve will be based upon the thermodynamic state (including gradients) most recently set. Gradients can be set specifically using set_Grad_V, set_Grad_X and set_Grad_T or through calls to getSpeciesFluxes, getSpeciesFluxesES, getSpeciesVdiff, getSpeciesVdiffES, etc.

Parameters
dvector of mixture diffusion coefficients units = m2 s-1. length = number of species

Reimplemented from Transport.

Definition at line 1249 of file LiquidTransport.cpp.

References LiquidTransport::m_Grad_X, LiquidTransport::m_molefracs, LiquidTransport::m_nDim, Transport::m_nsp, LiquidTransport::m_Vdiff, and LiquidTransport::stefan_maxwell_solve().

Referenced by LiquidTransport::getFluidMobilities(), and LiquidTransport::getMobilities().

void getThermalDiffCoeffs ( doublereal *const  dt)
virtual

Return the thermal diffusion coefficients.

These are all zero for this simple implementaion

Parameters
dtthermal diffusion coefficients

Reimplemented from Transport.

Definition at line 732 of file LiquidTransport.cpp.

References Transport::m_nsp.

doublereal thermalConductivity ( )
virtual

Return the thermal conductivity of the solution.

The thermal conductivity calculation is handled by subclasses of LiquidTranInteraction as specified in the input file. These in turn employ subclasses of LTPspecies to determine the individual species thermal condictivities.

Reimplemented from Transport.

Definition at line 709 of file LiquidTransport.cpp.

References LiquidTranInteraction::getMixTransProp(), LiquidTransport::m_cond_mix_ok, LiquidTransport::m_lambda, LiquidTransport::m_lambda_mix_ok, LiquidTransport::m_lambdaMixModel, LiquidTransport::m_lambdaTempDep_Ns, LiquidTransport::update_C(), and LiquidTransport::update_T().

void getMobilities ( doublereal *const  mobil_e)
virtual

Get the Electrical mobilities (m^2/V/s).

The electrical mobilities are not well defined in the context of LiquidTransport because the Stefan Maxwell equation is solved. Here the electrical mobilities are calculated from the mixture-averaged diffusion coefficients through a call to getMixDiffCoeffs() using the Einstein relation

\[ \mu^e_k = \frac{F D_k}{R T} \]

Note that this call to getMixDiffCoeffs() requires a solve of the Stefan Maxwell equation making this determination of the mixture averaged diffusion coefficients a slow method for obtaining diffusion coefficients.

Also note that the Stefan Maxwell solve will be based upon the thermodynamic state (including gradients) most recently set. Gradients can be set specifically using set_Grad_V, set_Grad_X and set_Grad_T or through calls to getSpeciesFluxes, getSpeciesFluxesES, getSpeciesVdiff, getSpeciesVdiffES, etc.

Parameters
mobil_eReturns the electrical mobilities of the species in array mobil_e. The array must be dimensioned at least as large as the number of species.

Reimplemented from Transport.

Definition at line 806 of file LiquidTransport.cpp.

References Cantera::Boltzmann, DATA_PTR, LiquidTransport::getMixDiffCoeffs(), Transport::m_nsp, LiquidTransport::m_spwork, and LiquidTransport::m_temp.

void getFluidMobilities ( doublereal *const  mobil_f)
virtual

Get the fluid mobilities (s kmol/kg).

The fluid mobilities are not well defined in the context of LiquidTransport because the Stefan Maxwell equation is solved. Here the fluid mobilities are calculated from the mixture-averaged diffusion coefficients through a call to getMixDiffCoeffs() using the Einstein relation

\[ \mu^f_k = \frac{D_k}{R T} \]

Note that this call to getMixDiffCoeffs() requires a solve of the Stefan Maxwell equation making this determination of the mixture averaged diffusion coefficients a slow method for obtaining diffusion coefficients.

Also note that the Stefan Maxwell solve will be based upon the thermodynamic state (including gradients) most recently set. Gradients can be set specifically using set_Grad_V, set_Grad_X and set_Grad_T or through calls to getSpeciesFluxes, getSpeciesFluxesES, getSpeciesVdiff, getSpeciesVdiffES, etc.

Parameters
mobil_fReturns the fluid mobilities of the species in array mobil_f. The array must be dimensioned at least as large as the number of species.

Reimplemented from Transport.

Definition at line 844 of file LiquidTransport.cpp.

References DATA_PTR, Cantera::GasConstant, LiquidTransport::getMixDiffCoeffs(), Transport::m_nsp, LiquidTransport::m_spwork, and LiquidTransport::m_temp.

void set_Grad_V ( const doublereal *const  grad_V)
virtual

Specify the value of the gradient of the voltage.

Parameters
grad_VGradient of the voltage (length num dimensions);

Definition at line 869 of file LiquidTransport.cpp.

References LiquidTransport::m_Grad_V, and LiquidTransport::m_nDim.

Referenced by LiquidTransport::getElectricConduct(), LiquidTransport::getElectricCurrent(), LiquidTransport::getSpeciesFluxesES(), and LiquidTransport::getSpeciesVdiffES().

void set_Grad_T ( const doublereal *const  grad_T)
virtual

Specify the value of the gradient of the temperature.

Parameters
grad_TGradient of the temperature (length num dimensions);

Definition at line 857 of file LiquidTransport.cpp.

References LiquidTransport::m_Grad_T, and LiquidTransport::m_nDim.

Referenced by LiquidTransport::getElectricConduct(), LiquidTransport::getElectricCurrent(), LiquidTransport::getSpeciesFluxes(), LiquidTransport::getSpeciesFluxesES(), LiquidTransport::getSpeciesVdiff(), and LiquidTransport::getSpeciesVdiffES().

void set_Grad_X ( const doublereal *const  grad_X)
virtual

Specify the value of the gradient of the MoleFractions.

Parameters
grad_XGradient of the mole fractions(length nsp * num dimensions);

Definition at line 881 of file LiquidTransport.cpp.

References LiquidTransport::m_Grad_X, LiquidTransport::m_nDim, and Transport::m_nsp.

Referenced by LiquidTransport::getElectricConduct(), LiquidTransport::getElectricCurrent(), LiquidTransport::getSpeciesFluxes(), LiquidTransport::getSpeciesFluxesES(), LiquidTransport::getSpeciesVdiff(), and LiquidTransport::getSpeciesVdiffES().

doublereal getElectricConduct ( )
virtual

Compute the mixture electrical conductivity from the Stefan-Maxwell equation.

To compute the mixture electrical conductance, the Stefan Maxwell equation is solved for zero species gradients and for unit potential gradient, \( \nabla V \). The species fluxes are converted to current by summing over the charge-weighted fluxes according to

\[ \vec{i} = \sum_{i} z_i F \rho \vec{V_i} / W_i \]

where \( z_i \) is the charge on species i, \( F \) is Faradays constant, \( \rho \) is the density, \( W_i \) is the molecular mass of species i. The conductance, \( \kappa \) is obtained from

\[ \kappa = \vec{i} / \nabla V. \]

Reimplemented from Transport.

Definition at line 909 of file LiquidTransport.cpp.

References LiquidTransport::getSpeciesFluxesExt(), LiquidTransport::m_chargeSpecies, LiquidTransport::m_mw, LiquidTransport::m_nDim, Transport::m_nsp, LiquidTransport::set_Grad_T(), LiquidTransport::set_Grad_V(), and LiquidTransport::set_Grad_X().

void getElectricCurrent ( int  ndim,
const doublereal *  grad_T,
int  ldx,
const doublereal *  grad_X,
int  ldf,
const doublereal *  grad_V,
doublereal *  current 
)
virtual

Compute the electric current density in A/m^2.

The electric current is computed first by computing the species diffusive fluxes using the Stefan Maxwell solution and then the current, \( \vec{i} \) by summing over the charge-weighted fluxes according to

\[ \vec{i} = \sum_{i} z_i F \rho \vec{V_i} / W_i \]

where \( z_i \) is the charge on species i, \( F \) is Faradays constant, \( \rho \) is the density, \( W_i \) is the molecular mass of species i.

Parameters
ndimThe number of spatial dimensions (1, 2, or 3).
grad_TThe temperature gradient (ignored in this model).
ldxLeading dimension of the grad_X array.
grad_XGradients of the mole fraction Flat vector with the m_nsp in the inner loop. length = ldx * ndim
ldfLeading dimension of the grad_V and current vectors.
grad_VThe electrostatic potential gradient.
currentThe electric current in A/m^2.

Reimplemented from Transport.

Definition at line 964 of file LiquidTransport.cpp.

References LiquidTransport::getSpeciesFluxesExt(), LiquidTransport::m_chargeSpecies, LiquidTransport::m_mw, LiquidTransport::m_nDim, Transport::m_nsp, LiquidTransport::set_Grad_T(), LiquidTransport::set_Grad_V(), and LiquidTransport::set_Grad_X().

void getSpeciesVdiff ( size_t  ndim,
const doublereal *  grad_T,
int  ldx,
const doublereal *  grad_X,
int  ldf,
doublereal *  Vdiff 
)
virtual

Get the species diffusive velocities wrt to the averaged velocity, given the gradients in mole fraction and temperature.

The average velocity can be computed on a mole-weighted or mass-weighted basis, or the diffusion velocities may be specified as relative to a specific species (i.e. a solvent) all according to the velocityBasis input parameter.

Units for the returned velocities are m s-1.

Parameters
ndimNumber of dimensions in the flux expressions
grad_TGradient of the temperature (length = ndim)
ldxLeading dimension of the grad_X array (usually equal to m_nsp but not always)
grad_XGradients of the mole fraction Flat vector with the m_nsp in the inner loop. length = ldx * ndim
ldfLeading dimension of the fluxes array (usually equal to m_nsp but not always)
VdiffOutput of the diffusive velocities. Flat vector with the m_nsp in the inner loop. length = ldx * ndim

Reimplemented from Transport.

Definition at line 1016 of file LiquidTransport.cpp.

References LiquidTransport::getSpeciesVdiffExt(), LiquidTransport::set_Grad_T(), and LiquidTransport::set_Grad_X().

void getSpeciesVdiffES ( size_t  ndim,
const doublereal *  grad_T,
int  ldx,
const doublereal *  grad_X,
int  ldf,
const doublereal *  grad_Phi,
doublereal *  Vdiff 
)
virtual

Get the species diffusive velocities wrt to the averaged velocity, given the gradients in mole fraction, temperature and electrostatic potential.

The average velocity can be computed on a mole-weighted or mass-weighted basis, or the diffusion velocities may be specified as relative to a specific species (i.e. a solvent) all according to the velocityBasis input parameter.

Units for the returned velocities are m s-1.

Parameters
ndimNumber of dimensions in the flux expressions
grad_TGradient of the temperature (length = ndim)
ldxLeading dimension of the grad_X array (usually equal to m_nsp but not always)
grad_XGradients of the mole fraction Flat vector with the m_nsp in the inner loop. length = ldx * ndim
ldfLeading dimension of the fluxes array (usually equal to m_nsp but not always)
grad_PhiGradients of the electrostatic potential (length = ndim)
VdiffOutput of the species diffusion velocities Flat vector with the m_nsp in the inner loop. length = ldx * ndim

Reimplemented from Transport.

Definition at line 1036 of file LiquidTransport.cpp.

References LiquidTransport::getSpeciesVdiffExt(), LiquidTransport::set_Grad_T(), LiquidTransport::set_Grad_V(), and LiquidTransport::set_Grad_X().

void getSpeciesFluxes ( size_t  ndim,
const doublereal *const  grad_T,
size_t  ldx,
const doublereal *const  grad_X,
size_t  ldf,
doublereal *const  fluxes 
)
virtual

Return the species diffusive mass fluxes wrt to the averaged velocity in [kmol/m^2/s].

The diffusive mass flux of species k [kmol/m^2/s] is computed using the Stefan-Maxwell equation

\[ X_i \nabla \mu_i = RT \sum_i \frac{X_i X_j}{D_{ij}} ( \vec{V}_j - \vec{V}_i ) \]

to determine the diffusion velocity and

\[ \vec{N}_i = C_T X_i \vec{V}_i \]

to determine the diffusion flux. Here \( C_T \) is the total concentration of the mixture [kmol/m^3], \( D_{ij} \) are the Stefa-Maxwell interaction parameters in [m^2/s], \( \vec{V}_{i} \) is the diffusion velocity of species i, \( \mu_i \) is the electrochemical potential of species i.

Note that for this method, there is no argument for the gradient of the electric potential (voltage). Electric potential gradients can be set with set_Grad_V() or method getSpeciesFluxesES() can be called.x

The diffusion velocity is relative to an average velocity that can be computed on a mole-weighted or mass-weighted basis, or the diffusion velocities may be specified as relative to a specific species (i.e. a solvent) all according to the

<velocityBasis> 

input parameter.

Parameters
ndimThe number of spatial dimensions (1, 2, or 3).
grad_TThe temperature gradient (ignored in this model). (length = ndim)
ldxLeading dimension of the grad_X array. (usually equal to m_nsp but not always)
grad_XGradients of the mole fraction Flat vector with the m_nsp in the inner loop. length = ldx * ndim
ldfLeading dimension of the fluxes array (usually equal to m_nsp but not always)
fluxesOutput of the diffusive mass fluxes Flat vector with the m_nsp in the inner loop. length = ldx * ndim

Reimplemented from Transport.

Definition at line 1099 of file LiquidTransport.cpp.

References LiquidTransport::getSpeciesFluxesExt(), LiquidTransport::set_Grad_T(), and LiquidTransport::set_Grad_X().

void getSpeciesFluxesES ( size_t  ndim,
const doublereal *  grad_T,
int  ldx,
const doublereal *  grad_X,
int  ldf,
const doublereal *  grad_Phi,
doublereal *  fluxes 
)
virtual

Return the species diffusive mass fluxes wrt to the averaged velocity in [kmol/m^2/s].

The diffusive mass flux of species k is computed using the Stefan-Maxwell equation

\[ X_i \nabla \mu_i = RT \sum_i \frac{X_i X_j}{D_{ij}} ( \vec{V}_j - \vec{V}_i ) \]

to determine the diffusion velocity and

\[ \vec{N}_i = C_T X_i \vec{V}_i \]

to determine the diffusion flux. Here \( C_T \) is the total concentration of the mixture [kmol/m^3], \( D_{ij} \) are the Stefa-Maxwell interaction parameters in [m^2/s], \( \vec{V}_{i} \) is the diffusion velocity of species i, \( \mu_i \) is the electrochemical potential of species i.

The diffusion velocity is relative to an average velocity that can be computed on a mole-weighted or mass-weighted basis, or the diffusion velocities may be specified as relative to a specific species (i.e. a solvent) all according to the

<velocityBasis>
* 

input parameter.

Parameters
ndimThe number of spatial dimensions (1, 2, or 3).
grad_TThe temperature gradient (ignored in this model). (length = ndim)
ldxLeading dimension of the grad_X array. (usually equal to m_nsp but not always)
grad_XGradients of the mole fraction Flat vector with the m_nsp in the inner loop. length = ldx * ndim
ldfLeading dimension of the fluxes array (usually equal to m_nsp but not always)
grad_PhiGradients of the electrostatic potential length = ndim
fluxesOutput of the diffusive mass fluxes Flat vector with the m_nsp in the inner loop. length = ldx * ndim

Definition at line 1153 of file LiquidTransport.cpp.

References LiquidTransport::getSpeciesFluxesExt(), LiquidTransport::set_Grad_T(), LiquidTransport::set_Grad_V(), and LiquidTransport::set_Grad_X().

void getSpeciesVdiffExt ( size_t  ldf,
doublereal *  Vdiff 
)
virtual

Return the species diffusive velocities relative to the averaged velocity.

This method acts similarly to getSpeciesVdiffES() but requires all gradients to be preset using methods set_Grad_X(), set_Grad_V(), set_Grad_T(). See the documentation of getSpeciesVdiffES() for details.

Parameters
ldfLeading dimension of the Vdiff array.
VdiffOutput of the diffusive velocities. Flat vector with the m_nsp in the inner loop. length = ldx * ndim

Definition at line 1180 of file LiquidTransport.cpp.

References LiquidTransport::m_nDim, Transport::m_nsp, LiquidTransport::m_Vdiff, and LiquidTransport::stefan_maxwell_solve().

Referenced by LiquidTransport::getSpeciesVdiff(), and LiquidTransport::getSpeciesVdiffES().

void getSpeciesFluxesExt ( size_t  ldf,
doublereal *  fluxes 
)
virtual

Return the species diffusive fluxes relative to the averaged velocity.

This method acts similarly to getSpeciesFluxesES() but requires all gradients to be preset using methods set_Grad_X(), set_Grad_V(), set_Grad_T(). See the documentation of getSpeciesFluxesES() for details.

units = kg/m2/s

Parameters
ldfLeading dimension of the Vdiff array.
fluxesOutput of the diffusive fluxes. Flat vector with the m_nsp in the inner loop. length = ldx * ndim

Definition at line 1206 of file LiquidTransport.cpp.

References LiquidTransport::m_flux, LiquidTransport::m_nDim, Transport::m_nsp, and LiquidTransport::stefan_maxwell_solve().

Referenced by LiquidTransport::getElectricConduct(), LiquidTransport::getElectricCurrent(), LiquidTransport::getSpeciesFluxes(), and LiquidTransport::getSpeciesFluxesES().

bool update_T ( void  )
protectedvirtual

Returns true if temperature has changed, in which case flags are set to recompute transport properties.

This is called whenever a transport property is requested. The first task is to check whether the temperature has changed since the last call to update_T(). If it hasn't then an immediate return is carried out.

Note this should be a lightweight function since it's part of all of the interfaces.

Returns
Returns true if the temperature has changed, and false otherwise

Definition at line 1279 of file LiquidTransport.cpp.

References Cantera::fp2str(), LiquidTransport::m_diff_mix_ok, LiquidTransport::m_diff_temp_ok, LiquidTransport::m_ionCond_conc_ok, LiquidTransport::m_ionCond_mix_ok, LiquidTransport::m_ionCond_temp_ok, LiquidTransport::m_lambda_mix_ok, LiquidTransport::m_lambda_temp_ok, LiquidTransport::m_mobRat_conc_ok, LiquidTransport::m_mobRat_mix_ok, LiquidTransport::m_mobRat_temp_ok, LiquidTransport::m_radi_temp_ok, LiquidTransport::m_selfDiff_conc_ok, LiquidTransport::m_selfDiff_mix_ok, LiquidTransport::m_selfDiff_temp_ok, LiquidTransport::m_temp, Transport::m_thermo, LiquidTransport::m_visc_conc_ok, LiquidTransport::m_visc_mix_ok, LiquidTransport::m_visc_temp_ok, and Phase::temperature().

Referenced by LiquidTransport::getBinaryDiffCoeffs(), LiquidTransport::getSpeciesHydrodynamicRadius(), LiquidTransport::getSpeciesIonConductivity(), LiquidTransport::getSpeciesMobilityRatio(), LiquidTransport::getSpeciesSelfDiffusion(), LiquidTransport::getSpeciesViscosities(), LiquidTransport::ionConductivity(), LiquidTransport::mobilityRatio(), LiquidTransport::selfDiffusion(), LiquidTransport::stefan_maxwell_solve(), LiquidTransport::thermalConductivity(), and LiquidTransport::viscosity().

bool update_C ( )
protectedvirtual

Returns true if mixture composition has changed, in which case flags are set to recompute transport properties.

This is called for every interface call to check whether the concentrations have changed. Concentrations change whenever the pressure or the mole fraction has changed. If it has changed, the recalculations should be done.

Note this should be a lightweight function since it's part of all of the interfaces.

Returns
Returns true if the mixture composition has changed, and false otherwise.

Definition at line 1336 of file LiquidTransport.cpp.

References LiquidTransport::concTot_, LiquidTransport::concTot_tran_, DATA_PTR, LiquidTransport::dens_, Phase::density(), Phase::getConcentrations(), Phase::getMassFractions(), Phase::getMoleFractions(), LiquidTransport::m_concentrations, LiquidTransport::m_diff_mix_ok, LiquidTransport::m_ionCond_conc_ok, LiquidTransport::m_ionCond_mix_ok, LiquidTransport::m_iStateMF, LiquidTransport::m_lambda_mix_ok, LiquidTransport::m_massfracs, LiquidTransport::m_massfracs_tran, LiquidTransport::m_mobRat_conc_ok, LiquidTransport::m_mobRat_mix_ok, LiquidTransport::m_molefracs, LiquidTransport::m_molefracs_tran, Transport::m_nsp, LiquidTransport::m_press, LiquidTransport::m_selfDiff_conc_ok, LiquidTransport::m_selfDiff_mix_ok, Transport::m_thermo, LiquidTransport::m_visc_conc_ok, LiquidTransport::m_visc_mix_ok, ckr::max(), Phase::meanMolecularWeight(), LiquidTransport::meanMolecularWeight_, MIN_X, ThermoPhase::pressure(), and Phase::stateMFNumber().

Referenced by LiquidTransport::ionConductivity(), LiquidTransport::mobilityRatio(), LiquidTransport::selfDiffusion(), LiquidTransport::stefan_maxwell_solve(), LiquidTransport::thermalConductivity(), and LiquidTransport::viscosity().

void update_Grad_lnAC ( )
protectedvirtual

Updates the internal value of the gradient of the logarithm of the activity, which is used in the gradient of the chemical potential.

Evaluate the gradients of the activity as they alter the diffusion coefficient.

The gradient of the chemical potential can be written in terms of gradient of the logarithm of the mole fraction times a correction associated with the gradient of the activity coefficient relative to that of the mole fraction. Specifically, the gradients of the logarithms of each are involved according to the formula

\[ \nabla \mu_k = RT \left[ \nabla ( \ln X_k ) + \nabla ( \ln \gamma_k ) \right] = RT \left[ \nabla ( \ln a_k ) \right] \]

The gradient in the activity coefficient requires the use of thermophase getdlnActCoeff that calculates its change based on a chane in the state (i.e. temperature and composition of each species) which was first implemented in MargulesVPSSTP.cpp (LiquidTransport.h doxygen)

Definition at line 1534 of file LiquidTransport.cpp.

References DATA_PTR, ThermoPhase::getdlnActCoeffds(), LiquidTransport::m_Grad_lnAC, LiquidTransport::m_Grad_T, LiquidTransport::m_Grad_X, LiquidTransport::m_molefracs, LiquidTransport::m_nDim, Transport::m_nsp, and Transport::m_thermo.

Referenced by LiquidTransport::stefan_maxwell_solve().

void stefan_maxwell_solve ( )
protected

Solve the stefan_maxell equations for the diffusive fluxes.

The diffusive mass flux of species k is computed using the Stefan-Maxwell equation

\[ X_i \nabla \mu_i = RT \sum_i \frac{X_i X_j}{D_{ij}} ( \vec{V}_j - \vec{V}_i ) \]

to determine the diffusion velocity and

\[ \vec{N}_i = C_T X_i \vec{V}_i \]

to determine the diffusion flux. Here \( C_T \) is the total concentration of the mixture [kmol/m^3], \( D_{ij} \) are the Stefa-Maxwell interaction parameters in [m^2/s], \( \vec{V}_{i} \) is the diffusion velocity of species i, \( \mu_i \) is the electrochemical potential of species i.

The diffusion velocity is relative to an average velocity that can be computed on a mole-weighted or mass-weighted basis, or the diffusion velocities may be specified as relative to a specific species (i.e. a solvent) all according to the

<velocityBasis>
* 

input para The gradient in the activity coefficient requires the use of thermophase getdlnActCoeff that calculates its change based on a change in the state i.e. temperature and composition of each species. First implemented in MargulesVPSSTP.cppmeter.

One of the Stefan Maxwell equations is replaced by the appropriate definition of the mass-averaged velocity, the mole-averaged velocity or the specification that velocities are relative to that of one species.

Definition at line 1596 of file LiquidTransport.cpp.

References ThermoPhase::activityConvention(), Cantera::cAC_CONVENTION_MOLALITY, LiquidTransport::concTot_, DATA_PTR, Cantera::GasConstant, ThermoPhase::getActivityCoefficients(), LiquidTransport::m_A, LiquidTransport::m_actCoeff, LiquidTransport::m_B, LiquidTransport::m_bdiff, LiquidTransport::m_chargeSpecies, LiquidTransport::m_diff_temp_ok, LiquidTransport::m_flux, LiquidTransport::m_Grad_lnAC, LiquidTransport::m_Grad_mu, LiquidTransport::m_Grad_T, LiquidTransport::m_Grad_V, LiquidTransport::m_massfracs_tran, LiquidTransport::m_molefracs, LiquidTransport::m_molefracs_tran, LiquidTransport::m_nDim, Transport::m_nsp, Transport::m_thermo, LiquidTransport::m_Vdiff, Transport::m_velocityBasis, Phase::molarVolume(), Phase::molecularWeight(), Phase::molecularWeights(), DenseMatrix::resize(), Cantera::solve(), Phase::temperature(), LiquidTransport::update_C(), LiquidTransport::update_Grad_lnAC(), LiquidTransport::update_T(), LiquidTransport::updateDiff_T(), Cantera::VB_MASSAVG, and Cantera::VB_MOLEAVG.

Referenced by LiquidTransport::getMixDiffCoeffs(), LiquidTransport::getSpeciesFluxesExt(), and LiquidTransport::getSpeciesVdiffExt().

void updateViscosity_T ( )
protected

Updates the array of pure species viscosities internally.

The flag m_visc_ok is set to true.

Note that for viscosity, a positive activation energy corresponds to the typical case of a positive argument to the exponential so that the Arrhenius expression is

\[ \mu = A T^n \exp( + E / R T ) \]

Definition at line 1439 of file LiquidTransport.cpp.

References Transport::m_nsp, LiquidTransport::m_visc_mix_ok, LiquidTransport::m_visc_temp_ok, LiquidTransport::m_viscSpecies, and LiquidTransport::m_viscTempDep_Ns.

Referenced by LiquidTransport::getSpeciesViscosities().

void updateIonConductivity_T ( )
protected

Update the temperature-dependent ionic conductivity terms for each species internally.

The flag m_ionCond_temp_ok is set to true.

Definition at line 1461 of file LiquidTransport.cpp.

References LiquidTransport::m_ionCond_mix_ok, LiquidTransport::m_ionCond_temp_ok, LiquidTransport::m_ionCondSpecies, LiquidTransport::m_ionCondTempDep_Ns, and Transport::m_nsp.

Referenced by LiquidTransport::getSpeciesIonConductivity().

void updateMobilityRatio_T ( )
protected

Updates the array of pure species mobility ratios internally.

The flag m_mobRat_ok is set to true.

Definition at line 1482 of file LiquidTransport.cpp.

References LiquidTransport::m_mobRat_mix_ok, LiquidTransport::m_mobRat_temp_ok, LiquidTransport::m_mobRatSpecies, LiquidTransport::m_mobRatTempDep_Ns, Transport::m_nsp, and LiquidTransport::m_nsp2.

Referenced by LiquidTransport::getSpeciesMobilityRatio().

void updateSelfDiffusion_T ( )
protected

Updates the array of pure species self diffusion coeffs internally.

The flag m_selfDiff_ok is set to true.

Definition at line 1506 of file LiquidTransport.cpp.

References Transport::m_nsp, LiquidTransport::m_nsp2, LiquidTransport::m_selfDiff_mix_ok, LiquidTransport::m_selfDiff_temp_ok, LiquidTransport::m_selfDiffSpecies, and LiquidTransport::m_selfDiffTempDep_Ns.

Referenced by LiquidTransport::getSpeciesSelfDiffusion().

void updateHydrodynamicRadius_T ( )
protected

Update the temperature-dependent hydrodynamic radius terms for each species internally.

The flag m_radi_temp_ok is set to true.

Definition at line 1525 of file LiquidTransport.cpp.

References LiquidTransport::m_hydrodynamic_radius, Transport::m_nsp, LiquidTransport::m_radi_mix_ok, LiquidTransport::m_radi_temp_ok, and LiquidTransport::m_radiusTempDep_Ns.

Referenced by LiquidTransport::getSpeciesHydrodynamicRadius().

void updateCond_T ( )
protected

Update the temperature-dependent parts of the mixture-averaged thermal conductivity internally.

Update the temperature-dependent parts of the species thermal conductivity internally using calls to the appropriate LTPspecies subclass.

Definition at line 1399 of file LiquidTransport.cpp.

References LiquidTransport::m_lambda_mix_ok, LiquidTransport::m_lambda_temp_ok, LiquidTransport::m_lambdaSpecies, LiquidTransport::m_lambdaTempDep_Ns, and Transport::m_nsp.

void updateViscosities_C ( )
protected

Update the concentration parts of the viscosities.

Internal routine is run whenever the update_boolean m_visc_conc_ok is false. Currently there is no concentration dependence for the pure species viscosities.

Definition at line 1420 of file LiquidTransport.cpp.

References LiquidTransport::m_visc_conc_ok.

void updateIonConductivity_C ( )
protected

Update the concentration parts of the ionic conductivity.

Internal routine is run whenever the update_boolean m_ionCond_conc_ok is false. Currently there is no concentration dependence for the pure species ionic conductivity.

Definition at line 1450 of file LiquidTransport.cpp.

References LiquidTransport::m_ionCond_conc_ok.

void updateMobilityRatio_C ( )
protected

Update the concentration parts of the mobility ratio.

Internal routine is run whenever the update_boolean m_mobRat_conc_ok is false. Currently there is no concentration dependence for the pure species mobility ratio.

Definition at line 1472 of file LiquidTransport.cpp.

References LiquidTransport::m_mobRat_conc_ok.

void updateSelfDiffusion_C ( )
protected

Update the concentration parts of the self diffusion.

Internal routine is run whenever the update_boolean m_selfDiff_conc_ok is false. Currently there is no concentration dependence for the pure species self diffusion.

Definition at line 1495 of file LiquidTransport.cpp.

References LiquidTransport::m_selfDiff_conc_ok.

void updateHydrodynamicRadius_C ( )
protected

Update the concentration dependence of the hydrodynamic radius.

Internal routine is run whenever the update_boolean m_radi_conc_ok is false. Currently there is no concentration dependence for the hydrodynamic radius.

Definition at line 1517 of file LiquidTransport.cpp.

References LiquidTransport::m_radi_conc_ok.

void updateDiff_T ( )
protected

Update the binary Stefan-Maxwell diffusion coefficients wrt T using calls to the appropriate LTPspecies subclass.

Definition at line 1411 of file LiquidTransport.cpp.

References LiquidTransport::m_bdiff, LiquidTransport::m_diff_mix_ok, LiquidTransport::m_diff_temp_ok, and LiquidTransport::m_diffMixModel.

Referenced by LiquidTransport::getBinaryDiffCoeffs(), and LiquidTransport::stefan_maxwell_solve().

doublereal err ( std::string  msg) const
private

Throw an exception if this method is invoked.

This probably indicates something is not yet implemented.

Parameters
msgIndicates the member function which is not implemented

Definition at line 1844 of file LiquidTransport.cpp.

References Cantera::int2str(), and LiquidTransport::model().

thermo_t& thermo ( )
inlineinherited

Phase object.

Every transport manager is designed to compute properties for a specific phase of a mixture, which might be a liquid solution, a gas mixture, a surface, etc. This method returns a reference to the object representing the phase itself.

Definition at line 239 of file TransportBase.h.

References Transport::m_thermo.

Referenced by Transport::setThermo().

bool ready ( )
inherited

Returns true if the transport manager is ready for use.

Definition at line 75 of file TransportBase.cpp.

References Transport::m_ready.

Referenced by Transport::finalize(), and Transport::setThermo().

void setNDim ( const int  ndim)
inherited

Set the number of dimensions to be expected in flux expressions.

Internal memory will be set with this value.

Parameters
ndimNumber of dimensions in flux expressions

Definition at line 83 of file TransportBase.cpp.

References Transport::m_nDim.

size_t nDim ( ) const
inlineinherited

Return the number of dimensions in flux expressions.

Returns
Returns the number of dimensions

Definition at line 261 of file TransportBase.h.

References Transport::m_nDim.

void checkSpeciesIndex ( size_t  k) const
inherited

Check that the specified species index is in range Throws an exception if k is greater than nSpecies()

Definition at line 88 of file TransportBase.cpp.

References Transport::m_nsp.

void checkSpeciesArraySize ( size_t  kk) const
inherited

Check that an array size is at least nSpecies() Throws an exception if kk is less than nSpecies().

Used before calls which take an array pointer.

Definition at line 95 of file TransportBase.cpp.

References Transport::m_nsp.

virtual doublereal bulkViscosity ( )
inlinevirtualinherited

The bulk viscosity in Pa-s.

The bulk viscosity is only non-zero in rare cases. Most transport managers either overload this method to return zero, or do not implement it, in which case an exception is thrown if called.

Reimplemented in WaterTransport, and FtnTransport.

Definition at line 303 of file TransportBase.h.

References Transport::err().

virtual doublereal electricalConductivity ( )
inlinevirtualinherited

The electrical conductivity (Siemens/m).

Reimplemented in SolidTransport, and FtnTransport.

Definition at line 413 of file TransportBase.h.

References Transport::err().

virtual void getSpeciesFluxesES ( size_t  ndim,
const doublereal *  grad_T,
size_t  ldx,
const doublereal *  grad_X,
size_t  ldf,
const doublereal *  grad_Phi,
doublereal *  fluxes 
)
inlinevirtualinherited

Get the species diffusive mass fluxes wrt to the mass averaged velocity, given the gradients in mole fraction, temperature and electrostatic potential.

Units for the returned fluxes are kg m-2 s-1.

Parameters
ndimNumber of dimensions in the flux expressions
grad_TGradient of the temperature (length = ndim)
ldxLeading dimension of the grad_X array (usually equal to m_nsp but not always)
grad_XGradients of the mole fraction Flat vector with the m_nsp in the inner loop. length = ldx * ndim
ldfLeading dimension of the fluxes array (usually equal to m_nsp but not always)
grad_PhiGradients of the electrostatic potential (length = ndim)
fluxesOutput of the diffusive mass fluxes Flat vector with the m_nsp in the inner loop. length = ldx * ndim

Definition at line 560 of file TransportBase.h.

References Transport::getSpeciesFluxes().

virtual void getMolarFluxes ( const doublereal *const  state1,
const doublereal *const  state2,
const doublereal  delta,
doublereal *const  cfluxes 
)
inlinevirtualinherited

Get the molar fluxes [kmol/m^2/s], given the thermodynamic state at two nearby points.

Parameters
state1Array of temperature, density, and mass fractions for state 1.
state2Array of temperature, density, and mass fractions for state 2.
deltaDistance from state 1 to state 2 (m).
cfluxesOutput array containing the diffusive molar fluxes of species from state1 to state2. This is a flat vector with the m_nsp in the inner loop. length = ldx * ndim. Units are [kmol/m^2/s].

Reimplemented in MultiTransport, and DustyGasTransport.

Definition at line 650 of file TransportBase.h.

References Transport::err().

virtual void getMassFluxes ( const doublereal *  state1,
const doublereal *  state2,
doublereal  delta,
doublereal *  mfluxes 
)
inlinevirtualinherited

Get the mass fluxes [kg/m^2/s], given the thermodynamic state at two nearby points.

Parameters
state1Array of temperature, density, and mass fractions for state 1.
state2Array of temperature, density, and mass fractions for state 2.
deltaDistance from state 1 to state 2 (m).
mfluxesOutput array containing the diffusive mass fluxes of species from state1 to state2. This is a flat vector with the m_nsp in the inner loop. length = ldx * ndim. Units are [kg/m^2/s].

Reimplemented in MultiTransport.

Definition at line 671 of file TransportBase.h.

References Transport::err().

virtual void getMultiDiffCoeffs ( const size_t  ld,
doublereal *const  d 
)
inlinevirtualinherited

Return the Multicomponent diffusion coefficients. Units: [m^2/s].

If the transport manager implements a multicomponent diffusion model, then this method returns the array of multicomponent diffusion coefficients. Otherwise it throws an exception.

Parameters
ldThe dimension of the inner loop of d (usually equal to m_nsp)
dflat vector of diffusion coefficients, fortran ordering. d[ld*j+i] is the D_ij diffusion coefficient (the diffusion coefficient for species i due to species j).

Reimplemented in DustyGasTransport, and MultiTransport.

Definition at line 721 of file TransportBase.h.

References Transport::err().

Referenced by StFlow::updateTransport().

virtual void getMixDiffCoeffsMole ( doublereal *const  d)
inlinevirtualinherited

Returns a vector of mixture averaged diffusion coefficients.

Reimplemented in GasTransport.

Definition at line 744 of file TransportBase.h.

References Transport::err().

virtual void getMixDiffCoeffsMass ( doublereal *const  d)
inlinevirtualinherited

Returns a vector of mixture averaged diffusion coefficients.

Reimplemented in GasTransport.

Definition at line 749 of file TransportBase.h.

References Transport::err().

void setParameters ( const int  type,
const int  k,
const doublereal *const  p 
)
virtualinherited

Set model parameters for derived classes.

This method may be derived in subclasses to set model-specific parameters. The primary use of this class is to set parameters while in the middle of a calculation without actually having to dynamically cast the base Transport pointer.

Parameters
typeSpecifies the type of parameters to set 0 : Diffusion coefficient 1 : Thermal Conductivity The rest are currently unused.
kSpecies index to set the parameters on
pVector of parameters. The length of the vector varies with the parameterization

Reimplemented in DustyGasTransport, and SolidTransport.

Definition at line 105 of file TransportBase.cpp.

References Transport::err().

void setVelocityBasis ( VelocityBasis  ivb)
inlineinherited

Sets the velocity basis.

What the transport object does with this parameter is up to the individual operator. Currently, this is not functional for most transport operators including all of the gas-phase operators.

Parameters
ivbSpecies the velocity basis

Definition at line 777 of file TransportBase.h.

References Transport::m_velocityBasis.

VelocityBasis getVelocityBasis ( ) const
inlineinherited

Gets the velocity basis.

What the transport object does with this parameter is up to the individual operator. Currently, this is not functional for most transport operators including all of the gas-phase operators.

Returns
Returns the velocity basis

Definition at line 789 of file TransportBase.h.

References Transport::m_velocityBasis.

virtual bool initGas ( GasTransportParams tr)
inlineprotectedvirtualinherited

Called by TransportFactory to set parameters.

Called by TransportFactory to set parameters.

This is called by classes that use the gas phase parameter list to initialize themselves.

Parameters
trReference to the parameter list that will be used to initialize the class

Reimplemented in MixTransport, MultiTransport, and GasTransport.

Definition at line 819 of file TransportBase.h.

References Transport::err().

Referenced by TransportFactory::initTransport().

void setThermo ( thermo_t thermo)
protectedinherited

Specifies the ThermPhase object.

Parameters
thermoReference to the ThermoPhase object that the transport object will use

Definition at line 112 of file TransportBase.cpp.

References Transport::m_nsp, Transport::m_thermo, Phase::nSpecies(), Transport::ready(), and Transport::thermo().

Referenced by TransportFactory::newTransport().

void finalize ( )
protectedinherited

Enable the transport object for use.

Once finalize() has been called, the transport manager should be ready to compute any supported transport property, and no further modifications to the model parameters should be made.

Definition at line 136 of file TransportBase.cpp.

References Transport::m_ready, and Transport::ready().

Member Data Documentation

size_t m_nsp2
private
doublereal m_tmin
private

Minimum temperature applicable to the transport property eval.

Definition at line 882 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), and LiquidTransport::operator=().

doublereal m_tmax
private

Maximum temperature applicable to the transport property evaluator.

Definition at line 885 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), and LiquidTransport::operator=().

vector_fp m_mw
private

Local copy of the molecular weights of the species.

Length is equal to the number of species in the phase

Definition at line 891 of file LiquidTransport.h.

Referenced by LiquidTransport::getElectricConduct(), LiquidTransport::getElectricCurrent(), LiquidTransport::initLiquid(), and LiquidTransport::operator=().

std::vector<LTPspecies*> m_viscTempDep_Ns
private

Viscosity for each species expressed as an appropriate subclass of LTPspecies.

These subclasses of LTPspecies evaluate the species-specific transport properties according to the parameters parsed in TransportFactory::getLiquidSpeciesTransportData().

Definition at line 900 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::updateViscosity_T(), LiquidTransport::viscosity(), and LiquidTransport::~LiquidTransport().

LiquidTranInteraction* m_viscMixModel
private

Viscosity of the mixture expressed as a subclass of LiquidTranInteraction.

These subclasses of LiquidTranInteraction evaluate the mixture transport properties according to the parameters parsed in TransportFactory::getLiquidInteractionsTransportData().

Definition at line 909 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::viscosity(), and LiquidTransport::~LiquidTransport().

std::vector<LTPspecies*> m_ionCondTempDep_Ns
private

Ionic conductivity for each species expressed as an appropriate subclass of LTPspecies.

These subclasses of LTPspecies evaluate the species-specific transport properties according to the parameters parsed in TransportFactory::getLiquidSpeciesTransportData().

Definition at line 918 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::ionConductivity(), LiquidTransport::operator=(), LiquidTransport::updateIonConductivity_T(), and LiquidTransport::~LiquidTransport().

LiquidTranInteraction* m_ionCondMixModel
private

Ionic Conductivity of the mixture expressed as a subclass of LiquidTranInteraction.

These subclasses of LiquidTranInteraction evaluate the mixture transport properties according to the parameters parsed in TransportFactory::getLiquidInteractionsTransportData().

Definition at line 927 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::ionConductivity(), LiquidTransport::operator=(), and LiquidTransport::~LiquidTransport().

std::vector<LTPvector> m_mobRatTempDep_Ns
private

Mobility ratio for the binary cominations of each species in each pure phase expressed as an appropriate subclass of LTPspecies.

These subclasses of LTPspecies evaluate the species-specific transport properties according to the parameters parsed in TransportFactory::getLiquidSpeciesTransportData().

Definition at line 939 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::mobilityRatio(), LiquidTransport::operator=(), LiquidTransport::updateMobilityRatio_T(), and LiquidTransport::~LiquidTransport().

std::vector<LiquidTranInteraction*> m_mobRatMixModel
private

Mobility ratio for each binary combination of mobile species in the mixture expressed as a subclass of LiquidTranInteraction.

These subclasses of LiquidTranInteraction evaluate the mixture transport properties according to the parameters parsed in TransportFactory::getLiquidInteractionsTransportData().

Definition at line 948 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::mobilityRatio(), LiquidTransport::operator=(), and LiquidTransport::~LiquidTransport().

std::vector<LTPvector> m_selfDiffTempDep_Ns
private

Self Diffusion for each species in each pure species phase expressed as an appropriate subclass of LTPspecies.

These subclasses of LTPspecies evaluate the species-specific transport properties according to the parameters parsed in TransportFactory::getLiquidSpeciesTransportData().

Definition at line 957 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::selfDiffusion(), LiquidTransport::updateSelfDiffusion_T(), and LiquidTransport::~LiquidTransport().

std::vector<LiquidTranInteraction*> m_selfDiffMixModel
private

Self Diffusion for each species in the mixture expressed as a subclass of LiquidTranInteraction.

These subclasses of LiquidTranInteraction evaluate the mixture transport properties according to the parameters parsed in TransportFactory::getLiquidInteractionsTransportData().

Definition at line 966 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::selfDiffusion(), and LiquidTransport::~LiquidTransport().

std::vector<LTPspecies*> m_lambdaTempDep_Ns
private

Thermal conductivity for each species expressed as an appropriate subclass of LTPspecies.

These subclasses of LTPspecies evaluate the species-specific transport properties according to the parameters parsed in TransportFactory::getLiquidSpeciesTransportData().

Definition at line 975 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::thermalConductivity(), LiquidTransport::updateCond_T(), and LiquidTransport::~LiquidTransport().

LiquidTranInteraction* m_lambdaMixModel
private

Thermal conductivity of the mixture expressed as a subclass of LiquidTranInteraction.

These subclasses of LiquidTranInteraction evaluate the mixture transport properties according to the parameters parsed in TransportFactory::getLiquidInteractionsTransportData().

Definition at line 984 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::thermalConductivity(), and LiquidTransport::~LiquidTransport().

std::vector<LTPspecies*> m_diffTempDep_Ns
private

(NOT USED IN LiquidTransport.) Diffusion coefficient model for each species expressed as an appropriate subclass of LTPspecies

These subclasses of LTPspecies evaluate the species-specific transport properties according to the parameters parsed in TransportFactory::getLiquidSpeciesTransportData().

Since the LiquidTransport class uses the Stefan-Maxwell equation to describe species diffusivity, the species-specific diffusivity is irrelevant.

Definition at line 998 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), and LiquidTransport::~LiquidTransport().

LiquidTranInteraction* m_diffMixModel
private

Species diffusivity of the mixture expressed as a subclass of LiquidTranInteraction.

This will return an array of Stefan-Maxwell interaction parameters for use in the Stefan-Maxwell solution.

These subclasses of LiquidTranInteraction evaluate the mixture transport properties according to the parameters parsed in TransportFactory::getLiquidInteractionsTransportData().

Definition at line 1009 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::updateDiff_T(), and LiquidTransport::~LiquidTransport().

DenseMatrix m_diff_Dij
private

Setfan-Maxwell diffusion coefficients.

Definition at line 1012 of file LiquidTransport.h.

std::vector<LTPspecies*> m_radiusTempDep_Ns
private

Hydrodynamic radius for each species expressed as an appropriate subclass of LTPspecies.

These subclasses of LTPspecies evaluate the species-specific transport properties according to the parameters parsed in TransportFactory::getLiquidSpeciesTransportData(). length = nsp

Definition at line 1022 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::updateHydrodynamicRadius_T(), and LiquidTransport::~LiquidTransport().

LiquidTranInteraction* m_radiusMixModel
private

(Not used in LiquidTransport) Hydrodynamic radius of the mixture expressed as a subclass of LiquidTranInteraction

These subclasses of LiquidTranInteraction evaluate the mixture transport properties according to the parameters parsed in TransportFactory::getLiquidInteractionsTransportData().

Definition at line 1032 of file LiquidTransport.h.

vector_fp m_hydrodynamic_radius
private
vector_fp m_Grad_X
private

Hydrodynamic radius.

Internal value of the gradient of the mole fraction vector

Note, this is the only gradient value that can and perhaps should reflect the true state of the mole fractions in the application solution vector. In other words no cropping or massaging of the values to make sure they are above zero should occur. - developing ....

m_nsp is the number of species in the fluid k is the species index n is the dimensional index (x, y, or z). It has a length equal to m_nDim

m_Grad_X[n*m_nsp + k]

Definition at line 1055 of file LiquidTransport.h.

Referenced by LiquidTransport::getMixDiffCoeffs(), LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::set_Grad_X(), and LiquidTransport::update_Grad_lnAC().

vector_fp m_Grad_lnAC
private

Gradient of the logarithm of the activity.

This quantity appears in the gradient of the chemical potential. It replaces the gradient of the mole fraction, and in this way serves to "modify" the diffusion coefficient.

\[ m\_Grad\_lnAC[k] = \nabla ( \ln X_k ) + \nabla ( \ln \gamma_k ) \]

k is the species index n is the dimensional index (x, y, or z). It has a length equal to m_nDim

m_Grad_X[n*m_nsp + k]

Definition at line 1075 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::stefan_maxwell_solve(), and LiquidTransport::update_Grad_lnAC().

vector_fp m_Grad_T
private

Internal value of the gradient of the Temperature vector.

Generally, if a transport property needs this in its evaluation it will look to this place to get it.

No internal property is precalculated based on gradients. Gradients are assumed to be freshly updated before every property call.

Definition at line 1087 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::set_Grad_T(), LiquidTransport::stefan_maxwell_solve(), and LiquidTransport::update_Grad_lnAC().

vector_fp m_Grad_P
private

Internal value of the gradient of the Pressure vector.

Generally, if a transport property needs this in its evaluation it will look to this place to get it.

No internal property is precalculated based on gradients. Gradients are assumed to be freshly updated before every property call.

Definition at line 1099 of file LiquidTransport.h.

vector_fp m_Grad_V
private

Internal value of the gradient of the Electric Voltage.

Generally, if a transport property needs this in its evaluation it will look to this place to get it.

No internal property is precalculated based on gradients. Gradients are assumed to be freshly updated before every property call.

Definition at line 1111 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::set_Grad_V(), and LiquidTransport::stefan_maxwell_solve().

vector_fp m_Grad_mu
private

Gradient of the electrochemical potential.

m_nsp is the number of species in the fluid k is the species index n is the dimensional index (x, y, or z)

\[ m\_Grad\_mu[n*m_nsp + k] \]

Definition at line 1123 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), and LiquidTransport::stefan_maxwell_solve().

DenseMatrix m_bdiff
private

Array of Binary Diffusivities.

These are evaluated according to the subclass of LiquidTranInteraction stored in m_diffMixModel.

This has a size equal to nsp x nsp It is a symmetric matrix. D_ii is the self diffusion coefficient. D_ii is not needed except for when there is one species in the mixture.

units m2/sec

Definition at line 1139 of file LiquidTransport.h.

Referenced by LiquidTransport::getBinaryDiffCoeffs(), LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::stefan_maxwell_solve(), and LiquidTransport::updateDiff_T().

vector_fp m_viscSpecies
private

Internal value of the species viscosities.

Viscosity of the species evaluated using subclass of LTPspecies held in m_viscTempDep_Ns.

Length = number of species

controlling update boolean -> m_visc_temp_ok

Definition at line 1150 of file LiquidTransport.h.

Referenced by LiquidTransport::getSpeciesViscosities(), LiquidTransport::initLiquid(), LiquidTransport::operator=(), and LiquidTransport::updateViscosity_T().

vector_fp m_ionCondSpecies
private

Internal value of the species ionic conductivities.

Ionic conductivity of the species evaluated using subclass of LTPspecies held in m_ionCondTempDep_Ns.

Length = number of species

controlling update boolean -> m_ionCond_temp_ok

Definition at line 1161 of file LiquidTransport.h.

Referenced by LiquidTransport::getSpeciesIonConductivity(), LiquidTransport::initLiquid(), LiquidTransport::operator=(), and LiquidTransport::updateIonConductivity_T().

DenseMatrix m_mobRatSpecies
private

Internal value of the species mobility ratios.

Mobility ratio of the species evaluated using subclass of LTPspecies held in m_mobRatTempDep_Ns.

Length = number of species

controlling update boolean -> m_mobRat_temp_ok

Definition at line 1172 of file LiquidTransport.h.

Referenced by LiquidTransport::getSpeciesMobilityRatio(), LiquidTransport::initLiquid(), LiquidTransport::operator=(), and LiquidTransport::updateMobilityRatio_T().

DenseMatrix m_selfDiffSpecies
private

Internal value of the species self diffusion coefficients.

Self diffusion of the species evaluated using subclass of LTPspecies held in m_selfDiffTempDep_Ns.

Length = number of species

controlling update boolean -> m_selfDiff_temp_ok

Definition at line 1183 of file LiquidTransport.h.

Referenced by LiquidTransport::getSpeciesSelfDiffusion(), LiquidTransport::initLiquid(), LiquidTransport::operator=(), and LiquidTransport::updateSelfDiffusion_T().

vector_fp m_lambdaSpecies
private

Internal value of the species individual thermal conductivities.

Thermal conductivities of the species evaluated using subclass of LTPspecies held in m_lambdaTempDep_Ns.

Length = number of species

Definition at line 1193 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), and LiquidTransport::updateCond_T().

int m_iStateMF
private

State of the mole fraction vector.

Definition at line 1196 of file LiquidTransport.h.

Referenced by LiquidTransport::operator=(), and LiquidTransport::update_C().

vector_fp m_massfracs
private

Local copy of the mass fractions of the species in the phase.

The mass fraction vector comes from the ThermoPhase object.

length = m_nsp

Definition at line 1204 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), and LiquidTransport::update_C().

vector_fp m_massfracs_tran
private

Local copy of the mass fractions of the species in the phase.

This version of the mass fraction vector is adjusted to a minimum lower bound of MIN_X for use in transport calculations.

Definition at line 1211 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::stefan_maxwell_solve(), and LiquidTransport::update_C().

vector_fp m_molefracs
private

Local copy of the mole fractions of the species in the phase.

The mole fractions here are assumed to be bounded by 0.0 and 1.0 and they are assumed to add up to one exactly. This mole fraction vector comes from the ThermoPhase object. Derivative quantities from this are referred to as bounded.

Update info? length = m_nsp

Definition at line 1223 of file LiquidTransport.h.

Referenced by LiquidTransport::getMixDiffCoeffs(), LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::stefan_maxwell_solve(), LiquidTransport::update_C(), and LiquidTransport::update_Grad_lnAC().

vector_fp m_molefracs_tran
private

Non-zero mole fraction vector used in transport property calculations.

The mole fractions here are assumed to be bounded by MIN_X and 1.0 and they may not be assumed to add up to one. This mole fraction vector is created from the ThermoPhase object. Derivative quantities of this use the _tran suffix.

Update info? length = m_nsp

Definition at line 1235 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::stefan_maxwell_solve(), and LiquidTransport::update_C().

vector_fp m_concentrations
private

Local copy of the concentrations of the species in the phase.

The concentrations are consistent with the m_molefracs vector which is bounded and sums to one.

Update info? length = m_nsp

Definition at line 1245 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), and LiquidTransport::update_C().

doublereal concTot_
private

Local copy of the total concentration.

This is consistent with the m_concentrations[] and m_molefracs[] vector.

Definition at line 1252 of file LiquidTransport.h.

Referenced by LiquidTransport::stefan_maxwell_solve(), and LiquidTransport::update_C().

doublereal concTot_tran_
private

Local copy of the total concentration.

This is consistent with the x_molefracs_tran vector and with the concTot_ number;

Definition at line 1259 of file LiquidTransport.h.

Referenced by LiquidTransport::update_C().

doublereal meanMolecularWeight_
private

Mean molecular mass.

Definition at line 1262 of file LiquidTransport.h.

Referenced by LiquidTransport::update_C().

doublereal dens_
private

Density.

Definition at line 1265 of file LiquidTransport.h.

Referenced by LiquidTransport::update_C().

vector_fp m_chargeSpecies
private

Local copy of the charge of each species.

Contains the charge of each species (length m_nsp)

Definition at line 1271 of file LiquidTransport.h.

Referenced by LiquidTransport::getElectricConduct(), LiquidTransport::getElectricCurrent(), LiquidTransport::initLiquid(), LiquidTransport::operator=(), and LiquidTransport::stefan_maxwell_solve().

vector_fp m_volume_spec
private

Specific volume for each species. Local copy from thermo object.

Definition at line 1274 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid().

vector_fp m_actCoeff
private

Vector of activity coefficients.

Definition at line 1277 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), and LiquidTransport::stefan_maxwell_solve().

DenseMatrix m_B
private

RHS to the stefan-maxwell equation.

Definition at line 1280 of file LiquidTransport.h.

Referenced by LiquidTransport::operator=(), and LiquidTransport::stefan_maxwell_solve().

DenseMatrix m_A
private

Matrix for the stefan maxwell equation.

Definition at line 1283 of file LiquidTransport.h.

Referenced by LiquidTransport::operator=(), and LiquidTransport::stefan_maxwell_solve().

doublereal m_temp
private

Current Temperature -> locally stored.

This is used to test whether new temperature computations should be performed.

Definition at line 1290 of file LiquidTransport.h.

Referenced by LiquidTransport::getFluidMobilities(), LiquidTransport::getMobilities(), LiquidTransport::operator=(), and LiquidTransport::update_T().

doublereal m_press
private

Current value of the pressure.

Definition at line 1293 of file LiquidTransport.h.

Referenced by LiquidTransport::operator=(), and LiquidTransport::update_C().

Array2D m_flux
private

Solution of the Stefan Maxwell equation in terms of flux.

This is the mass flux of species k in units of kg m-3 s-1.

Definition at line 1300 of file LiquidTransport.h.

Referenced by LiquidTransport::getSpeciesFluxesExt(), LiquidTransport::initLiquid(), LiquidTransport::operator=(), and LiquidTransport::stefan_maxwell_solve().

Array2D m_Vdiff
private

Solution of the Stefan Maxwell equation.

This is the diffusion velocity of species k in units of m/s and relative to the mole-averaged velocity.

Definition at line 1307 of file LiquidTransport.h.

Referenced by LiquidTransport::getMixDiffCoeffs(), LiquidTransport::getSpeciesVdiffExt(), LiquidTransport::initLiquid(), LiquidTransport::operator=(), and LiquidTransport::stefan_maxwell_solve().

doublereal m_lambda
private

Saved value of the mixture thermal conductivity.

Definition at line 1310 of file LiquidTransport.h.

Referenced by LiquidTransport::operator=(), and LiquidTransport::thermalConductivity().

doublereal m_viscmix
private

Saved value of the mixture viscosity.

Definition at line 1313 of file LiquidTransport.h.

Referenced by LiquidTransport::operator=(), and LiquidTransport::viscosity().

doublereal m_ionCondmix
private

Saved value of the mixture ionic conductivity.

Definition at line 1316 of file LiquidTransport.h.

Referenced by LiquidTransport::ionConductivity(), and LiquidTransport::operator=().

vector_fp m_mobRatMix
private

Saved values of the mixture mobility ratios.

Definition at line 1319 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::mobilityRatio(), and LiquidTransport::operator=().

vector_fp m_selfDiffMix
private

Saved values of the mixture self diffusion coefficients.

Definition at line 1322 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), and LiquidTransport::selfDiffusion().

vector_fp m_spwork
private
bool m_visc_mix_ok
private

Boolean indicating that the top-level mixture viscosity is current.

This is turned false for every change in T, P, or C.

Definition at line 1337 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::update_C(), LiquidTransport::update_T(), LiquidTransport::updateViscosity_T(), and LiquidTransport::viscosity().

bool m_visc_temp_ok
private

Boolean indicating that weight factors wrt viscosity is current.

Definition at line 1340 of file LiquidTransport.h.

Referenced by LiquidTransport::getSpeciesViscosities(), LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::update_T(), and LiquidTransport::updateViscosity_T().

bool m_visc_conc_ok
private

Flag to indicate that the pure species viscosities are current wrt the concentration.

Definition at line 1344 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::update_C(), LiquidTransport::update_T(), and LiquidTransport::updateViscosities_C().

bool m_ionCond_mix_ok
private

Boolean indicating that the top-level mixture ionic conductivity is current.

This is turned false for every change in T, P, or C.

Definition at line 1350 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::ionConductivity(), LiquidTransport::operator=(), LiquidTransport::update_C(), LiquidTransport::update_T(), and LiquidTransport::updateIonConductivity_T().

bool m_ionCond_temp_ok
private

Boolean indicating that weight factors wrt ionic conductivty is current.

Definition at line 1353 of file LiquidTransport.h.

Referenced by LiquidTransport::getSpeciesIonConductivity(), LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::update_T(), and LiquidTransport::updateIonConductivity_T().

bool m_ionCond_conc_ok
private

Flag to indicate that the pure species ionic conductivities are current wrt the concentration.

Definition at line 1357 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::update_C(), LiquidTransport::update_T(), and LiquidTransport::updateIonConductivity_C().

bool m_cond_mix_ok
private

Flag to indicate that the mixture conductivity is current.

Definition at line 1360 of file LiquidTransport.h.

Referenced by LiquidTransport::thermalConductivity().

bool m_mobRat_mix_ok
private

Boolean indicating that the top-level mixture mobility ratio is current.

This is turned false for every change in T, P, or C.

Definition at line 1366 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::mobilityRatio(), LiquidTransport::operator=(), LiquidTransport::update_C(), LiquidTransport::update_T(), and LiquidTransport::updateMobilityRatio_T().

bool m_mobRat_temp_ok
private

Boolean indicating that weight factors wrt mobility ratio is current.

Definition at line 1369 of file LiquidTransport.h.

Referenced by LiquidTransport::getSpeciesMobilityRatio(), LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::update_T(), and LiquidTransport::updateMobilityRatio_T().

bool m_mobRat_conc_ok
private

Flag to indicate that the pure species mobility ratios are current wrt the concentration.

Definition at line 1373 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::update_C(), LiquidTransport::update_T(), and LiquidTransport::updateMobilityRatio_C().

bool m_selfDiff_mix_ok
private

Boolean indicating that the top-level mixture self diffusion is current.

This is turned false for every change in T, P, or C.

Definition at line 1379 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::selfDiffusion(), LiquidTransport::update_C(), LiquidTransport::update_T(), and LiquidTransport::updateSelfDiffusion_T().

bool m_selfDiff_temp_ok
private

Boolean indicating that weight factors wrt self diffusion is current.

Definition at line 1382 of file LiquidTransport.h.

Referenced by LiquidTransport::getSpeciesSelfDiffusion(), LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::update_T(), and LiquidTransport::updateSelfDiffusion_T().

bool m_selfDiff_conc_ok
private

Flag to indicate that the pure species self diffusion are current wrt the concentration.

Definition at line 1386 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::update_C(), LiquidTransport::update_T(), and LiquidTransport::updateSelfDiffusion_C().

bool m_radi_mix_ok
private

Boolean indicating that mixture diffusion coeffs are current.

Definition at line 1389 of file LiquidTransport.h.

Referenced by LiquidTransport::operator=(), and LiquidTransport::updateHydrodynamicRadius_T().

bool m_radi_temp_ok
private

Boolean indicating that temperature dependence of hydrodynamic radius is current.

Definition at line 1393 of file LiquidTransport.h.

Referenced by LiquidTransport::getSpeciesHydrodynamicRadius(), LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::update_T(), and LiquidTransport::updateHydrodynamicRadius_T().

bool m_radi_conc_ok
private

Flag to indicate that the hydrodynamic radius is current is current wrt the concentration.

Definition at line 1397 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), and LiquidTransport::updateHydrodynamicRadius_C().

bool m_diff_mix_ok
private

Boolean indicating that mixture diffusion coeffs are current.

Definition at line 1400 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::update_C(), LiquidTransport::update_T(), and LiquidTransport::updateDiff_T().

bool m_diff_temp_ok
private
bool m_lambda_temp_ok
private

Flag to indicate that the pure species conductivities are current wrt the temperature.

Definition at line 1407 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), LiquidTransport::operator=(), LiquidTransport::update_T(), and LiquidTransport::updateCond_T().

bool m_lambda_mix_ok
private
int m_mode
private

Mode indicator for transport models – currently unused.

Definition at line 1413 of file LiquidTransport.h.

Referenced by LiquidTransport::initLiquid(), and LiquidTransport::operator=().

bool m_debug
private

Debugging flags.

Turn on to get debugging information

Definition at line 1419 of file LiquidTransport.h.

Referenced by LiquidTransport::operator=().

size_t m_nDim
private
thermo_t* m_thermo
protectedinherited

pointer to the object representing the phase

Definition at line 857 of file TransportBase.h.

Referenced by SolidTransport::electricalConductivity(), GasTransport::getBinaryDiffCoeffs(), AqueousTransport::getBinaryDiffCoeffs(), AqueousTransport::getLiquidTransportData(), MultiTransport::getMassFluxes(), SolidTransport::getMixDiffCoeffs(), GasTransport::getMixDiffCoeffs(), AqueousTransport::getMixDiffCoeffs(), GasTransport::getMixDiffCoeffsMass(), GasTransport::getMixDiffCoeffsMole(), SolidTransport::getMobilities(), DustyGasTransport::getMolarFluxes(), MultiTransport::getMolarFluxes(), MultiTransport::getMultiDiffCoeffs(), MultiTransport::getSpeciesFluxes(), MixTransport::getSpeciesFluxes(), AqueousTransport::getSpeciesFluxesExt(), SimpleTransport::getSpeciesFluxesExt(), SimpleTransport::getSpeciesVdiff(), SimpleTransport::getSpeciesVdiffES(), GasTransport::initGas(), DustyGasTransport::initialize(), LiquidTransport::initLiquid(), SimpleTransport::initLiquid(), AqueousTransport::initLiquid(), WaterTransport::initTP(), Transport::operator=(), MixTransport::pressure_ig(), SolidTransport::setParameters(), Transport::setThermo(), AqueousTransport::stefan_maxwell_solve(), LiquidTransport::stefan_maxwell_solve(), SolidTransport::thermalConductivity(), Transport::thermo(), Transport::Transport(), MixTransport::update_C(), MultiTransport::update_C(), AqueousTransport::update_C(), SimpleTransport::update_C(), LiquidTransport::update_C(), LiquidTransport::update_Grad_lnAC(), MixTransport::update_T(), MultiTransport::update_T(), AqueousTransport::update_T(), SimpleTransport::update_T(), LiquidTransport::update_T(), MultiTransport::updateThermal_T(), DustyGasTransport::updateTransport_C(), and DustyGasTransport::updateTransport_T().

bool m_ready
protectedinherited

true if finalize has been called

Definition at line 860 of file TransportBase.h.

Referenced by Transport::finalize(), Transport::operator=(), Transport::ready(), and Transport::Transport().

size_t m_nsp
protectedinherited

Number of species.

Definition at line 863 of file TransportBase.h.

Referenced by Transport::checkSpeciesArraySize(), Transport::checkSpeciesIndex(), DustyGasTransport::eval_H_matrix(), MultiTransport::eval_L0000(), MultiTransport::eval_L0010(), MultiTransport::eval_L1000(), GasTransport::getBinaryDiffCoeffs(), AqueousTransport::getBinaryDiffCoeffs(), LiquidTransport::getBinaryDiffCoeffs(), SimpleTransport::getBinaryDiffCoeffs(), LiquidTransport::getElectricConduct(), LiquidTransport::getElectricCurrent(), AqueousTransport::getFluidMobilities(), SimpleTransport::getFluidMobilities(), LiquidTransport::getFluidMobilities(), MultiTransport::getMassFluxes(), GasTransport::getMixDiffCoeffs(), AqueousTransport::getMixDiffCoeffs(), SimpleTransport::getMixDiffCoeffs(), LiquidTransport::getMixDiffCoeffs(), GasTransport::getMixDiffCoeffsMass(), GasTransport::getMixDiffCoeffsMole(), MixTransport::getMobilities(), AqueousTransport::getMobilities(), SimpleTransport::getMobilities(), LiquidTransport::getMobilities(), DustyGasTransport::getMolarFluxes(), MultiTransport::getMultiDiffCoeffs(), DustyGasTransport::getMultiDiffCoeffs(), MultiTransport::getSpeciesFluxes(), MixTransport::getSpeciesFluxes(), AqueousTransport::getSpeciesFluxesExt(), SimpleTransport::getSpeciesFluxesExt(), LiquidTransport::getSpeciesFluxesExt(), LiquidTransport::getSpeciesMobilityRatio(), LiquidTransport::getSpeciesSelfDiffusion(), SimpleTransport::getSpeciesVdiff(), SimpleTransport::getSpeciesVdiffES(), LiquidTransport::getSpeciesVdiffExt(), MultiTransport::getThermalDiffCoeffs(), MixTransport::getThermalDiffCoeffs(), AqueousTransport::getThermalDiffCoeffs(), SimpleTransport::getThermalDiffCoeffs(), LiquidTransport::getThermalDiffCoeffs(), GasTransport::initGas(), MultiTransport::initGas(), MixTransport::initGas(), DustyGasTransport::initialize(), LiquidTransport::initLiquid(), SimpleTransport::initLiquid(), AqueousTransport::initLiquid(), LiquidTransport::mobilityRatio(), Transport::operator=(), LiquidTransport::selfDiffusion(), AqueousTransport::set_Grad_X(), SimpleTransport::set_Grad_X(), LiquidTransport::set_Grad_X(), Transport::setThermo(), MultiTransport::solveLMatrixEquation(), AqueousTransport::stefan_maxwell_solve(), LiquidTransport::stefan_maxwell_solve(), MultiTransport::thermalConductivity(), MixTransport::thermalConductivity(), AqueousTransport::thermalConductivity(), SimpleTransport::thermalConductivity(), Transport::Transport(), MixTransport::update_C(), MultiTransport::update_C(), AqueousTransport::update_C(), SimpleTransport::update_C(), LiquidTransport::update_C(), LiquidTransport::update_Grad_lnAC(), DustyGasTransport::updateBinaryDiffCoeffs(), MixTransport::updateCond_T(), SimpleTransport::updateCond_T(), AqueousTransport::updateCond_T(), LiquidTransport::updateCond_T(), GasTransport::updateDiff_T(), SimpleTransport::updateDiff_T(), AqueousTransport::updateDiff_T(), LiquidTransport::updateHydrodynamicRadius_T(), LiquidTransport::updateIonConductivity_T(), DustyGasTransport::updateKnudsenDiffCoeffs(), LiquidTransport::updateMobilityRatio_T(), LiquidTransport::updateSelfDiffusion_T(), GasTransport::updateSpeciesViscosities(), AqueousTransport::updateSpeciesViscosities(), MultiTransport::updateThermal_T(), DustyGasTransport::updateTransport_C(), GasTransport::updateViscosity_T(), SimpleTransport::updateViscosity_T(), AqueousTransport::updateViscosity_T(), LiquidTransport::updateViscosity_T(), GasTransport::viscosity(), AqueousTransport::viscosity(), SimpleTransport::viscosity(), and LiquidTransport::~LiquidTransport().

int m_velocityBasis
protectedinherited

Velocity basis from which diffusion velocities are computed.

Defaults to the mass averaged basis = -2

Definition at line 870 of file TransportBase.h.

Referenced by SimpleTransport::getSpeciesFluxesExt(), Transport::getVelocityBasis(), LiquidTransport::initLiquid(), Transport::operator=(), Transport::setVelocityBasis(), LiquidTransport::stefan_maxwell_solve(), and Transport::Transport().


The documentation for this class was generated from the following files: