37const int CK_Mode = 10;
182 "To be removed after Cantera 3.0. Replaced by transportModel().");
416 const double* grad_T,
418 const double* grad_X,
420 const double* grad_V,
446 size_t ldx,
const double*
const grad_X,
447 size_t ldf,
double*
const fluxes) {
473 const double* grad_T,
475 const double* grad_X,
477 const double* grad_Phi,
500 const double* grad_T,
502 const double* grad_X,
530 const double* grad_T,
532 const double* grad_X,
534 const double* grad_Phi,
553 const double*
const state2,
const double delta,
554 double*
const cfluxes) {
573 const double* state2,
double delta,
676 double* astar_coeffs,
677 double* bstar_coeffs,
678 double* cstar_coeffs)
const{
703 double* astar_coeffs,
704 double* bstar_coeffs,
705 double* cstar_coeffs,
bool flag){
726 virtual void setParameters(
const int type,
const int k,
const double*
const p) {
799 virtual void setRoot(shared_ptr<Solution> root);
A map of string keys to values whose type can vary at runtime.
An error indicating that an unimplemented function has been called.
Base class for a phase with thermodynamic properties.
Base class for transport property managers.
virtual void setThermo(ThermoPhase &thermo)
Specifies the ThermoPhase object.
ThermoPhase * m_thermo
pointer to the object representing the phase
void setNDim(const int ndim)
Set the number of dimensions to be expected in flux expressions.
virtual void init(ThermoPhase *thermo, int mode=0, int log_level=0)
Initialize a transport manager.
virtual void getBinDiffusivityPolynomial(size_t i, size_t j, double *coeffs) const
Return the polynomial fits to the binary diffusivity of species pair (i, j)
virtual void setCollisionIntegralPolynomial(size_t i, size_t j, double *astar_coeffs, double *bstar_coeffs, double *cstar_coeffs, bool flag)
Modify the polynomial fits to the collision integral of species pair (i, j)
size_t m_nDim
Number of dimensions used in flux expressions.
void checkSpeciesIndex(size_t k) const
Check that the specified species index is in range.
virtual void setParameters(const int type, const int k, const double *const p)
Set model parameters for derived classes.
bool m_ready
true if finalize has been called
virtual double bulkViscosity()
The bulk viscosity in Pa-s.
virtual double electricalConductivity()
The electrical conductivity (Siemens/m).
void finalize()
Enable the transport object for use.
virtual void getSpeciesFluxes(size_t ndim, const double *const grad_T, size_t ldx, const double *const grad_X, size_t ldf, double *const fluxes)
Get the species diffusive mass fluxes wrt to the specified solution averaged velocity,...
virtual void getViscosityPolynomial(size_t i, double *coeffs) const
Return the polynomial fits to the viscosity of species i.
virtual void getThermalDiffCoeffs(double *const dt)
Return a vector of Thermal diffusion coefficients [kg/m/sec].
virtual void getSpeciesVdiff(size_t ndim, const double *grad_T, int ldx, const double *grad_X, int ldf, double *Vdiff)
Get the species diffusive velocities wrt to the mass averaged velocity, given the gradients in mole f...
size_t nDim() const
Return the number of dimensions in flux expressions.
virtual void getMixDiffCoeffsMole(double *const d)
Returns a vector of mixture averaged diffusion coefficients.
virtual void getMolarFluxes(const double *const state1, const double *const state2, const double delta, double *const cfluxes)
Get the molar fluxes [kmol/m^2/s], given the thermodynamic state at two nearby points.
virtual void getConductivityPolynomial(size_t i, double *coeffs) const
Return the temperature fits of the heat conductivity of species i.
virtual void getSpeciesFluxesES(size_t ndim, const double *grad_T, size_t ldx, const double *grad_X, size_t ldf, const double *grad_Phi, double *fluxes)
Get the species diffusive mass fluxes wrt to the mass averaged velocity, given the gradients in mole ...
virtual string transportModel() const
Identifies the model represented by this Transport object.
AnyMap parameters() const
Return the parameters for a phase definition which are needed to reconstruct an identical object usin...
virtual void getMobilities(double *const mobil_e)
Get the Electrical mobilities (m^2/V/s).
virtual void setViscosityPolynomial(size_t i, double *coeffs)
Modify the polynomial fits to the viscosity of species i.
virtual void getMixDiffCoeffs(double *const d)
Returns a vector of mixture averaged diffusion coefficients.
virtual void getElectricCurrent(int ndim, const double *grad_T, int ldx, const double *grad_X, int ldf, const double *grad_V, double *current)
Compute the electric current density in A/m^2.
virtual void getSpeciesViscosities(double *const visc)
Returns the pure species viscosities.
virtual void getMassFluxes(const double *state1, const double *state2, double delta, double *mfluxes)
Get the mass fluxes [kg/m^2/s], given the thermodynamic state at two nearby points.
virtual void getSpeciesMobilityRatio(double **mobRat)
Returns the pure species limit of the mobility ratios.
virtual void mobilityRatio(double *mobRat)
Returns the pointer to the mobility ratios of the species in the phase.
virtual void setConductivityPolynomial(size_t i, double *coeffs)
Modify the temperature fits of the heat conductivity of species i.
virtual void getSpeciesIonConductivity(double *const ionCond)
Returns the pure species ionic conductivity.
virtual void getBinaryDiffCoeffs(const size_t ld, double *const d)
Returns the matrix of binary diffusion coefficients [m^2/s].
virtual double thermalConductivity()
Returns the mixture thermal conductivity in W/m/K.
virtual bool CKMode() const
Boolean indicating the form of the transport properties polynomial fits.
std::weak_ptr< Solution > m_root
reference to Solution
virtual void setRoot(shared_ptr< Solution > root)
Set root Solution holding all phase information.
size_t m_nsp
Number of species.
virtual double getElectricConduct()
Compute the mixture electrical conductivity (S m-1) at the current conditions of the phase (Siemens m...
void setVelocityBasis(VelocityBasis ivb)
Sets the velocity basis.
virtual void getMixDiffCoeffsMass(double *const d)
Returns a vector of mixture averaged diffusion coefficients.
ThermoPhase & thermo()
Phase object.
void checkSpeciesArraySize(size_t kk) const
Check that an array size is at least nSpecies().
virtual void getFluidMobilities(double *const mobil_f)
Get the fluid mobilities (s kmol/kg).
int m_velocityBasis
Velocity basis from which diffusion velocities are computed.
virtual double ionConductivity()
The ionic conductivity in 1/ohm/m.
virtual double viscosity()
The viscosity in Pa-s.
string transportType() const
Identifies the Transport object type.
virtual void getMultiDiffCoeffs(const size_t ld, double *const d)
Return the Multicomponent diffusion coefficients. Units: [m^2/s].
bool ready()
Returns true if the transport manager is ready for use.
virtual void getSpeciesVdiffES(size_t ndim, const double *grad_T, int ldx, const double *grad_X, int ldf, const double *grad_Phi, double *Vdiff)
Get the species diffusive velocities wrt to the mass averaged velocity, given the gradients in mole f...
virtual void setBinDiffusivityPolynomial(size_t i, size_t j, double *coeffs)
Modify the polynomial fits to the binary diffusivity of species pair (i, j)
VelocityBasis getVelocityBasis() const
Gets the velocity basis.
virtual void getCollisionIntegralPolynomial(size_t i, size_t j, double *astar_coeffs, double *bstar_coeffs, double *cstar_coeffs) const
Return the polynomial fits to the collision integral of species pair (i, j)
This file contains definitions of constants, types and terms that are used in internal routines and a...
Definitions for the classes that are thrown when Cantera experiences an error condition (also contain...
This file contains definitions for utility functions and text for modules, inputfiles and logging,...
const VelocityBasis VB_SPECIES_1
Diffusion velocities are based on the relative motion wrt species 1.
int VelocityBasis
The diffusion fluxes must be referenced to a particular reference fluid velocity.
const VelocityBasis VB_MASSAVG
const VelocityBasis VB_SPECIES_2
Diffusion velocities are based on the relative motion wrt species 2.
const VelocityBasis VB_MOLEAVG
Diffusion velocities are based on the mole averaged velocities.
const VelocityBasis VB_SPECIES_3
Diffusion velocities are based on the relative motion wrt species 3.
const VelocityBasis VB_SPECIES_0
Diffusion velocities are based on the relative motion wrt species 0.
Namespace for the Cantera kernel.
const size_t npos
index returned by functions to indicate "no position"
void warn_deprecated(const string &source, const AnyBase &node, const string &message)
A deprecation warning for syntax in an input file.