Cantera  3.0.0
Loading...
Searching...
No Matches
WaterTransport Class Reference

Transport Parameters for pure water. More...

#include <WaterTransport.h>

Inheritance diagram for WaterTransport:
[legend]

Detailed Description

Transport Parameters for pure water.

Definition at line 19 of file WaterTransport.h.

Public Member Functions

 WaterTransport (ThermoPhase *thermo=0, int ndim=-1)
 default constructor
 
string transportModel () const override
 Identifies the model represented by this Transport object.
 
double viscosity () override
 Returns the viscosity of water at the current conditions (kg/m/s)
 
double bulkViscosity () override
 The bulk viscosity in Pa-s.
 
double thermalConductivity () override
 Returns the thermal conductivity of water at the current conditions (W/m/K)
 
void init (ThermoPhase *thermo, int mode=0, int log_level=0) override
 Initialize a transport manager.
 
- Public Member Functions inherited from Transport
 Transport (ThermoPhase *thermo=0, size_t ndim=npos)
 Constructor.
 
 Transport (const Transport &)=delete
 
Transportoperator= (const Transport &)=delete
 
virtual string transportModel () const
 Identifies the model represented by this Transport object.
 
string transportType () const
 Identifies the Transport object type.
 
ThermoPhasethermo ()
 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.
 
void checkSpeciesArraySize (size_t kk) const
 Check that an array size is at least nSpecies().
 
virtual double getElectricConduct ()
 Compute the mixture electrical conductivity (S m-1) at the current conditions of the phase (Siemens m-1)
 
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 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, given the gradients in mole fraction and temperature.
 
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 fraction, temperature and electrostatic potential.
 
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 fraction and temperature.
 
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 fraction, temperature, and electrostatic potential.
 
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 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 getThermalDiffCoeffs (double *const dt)
 Return a vector of Thermal diffusion coefficients [kg/m/sec].
 
virtual void getBinaryDiffCoeffs (const size_t ld, double *const d)
 Returns the matrix of binary diffusion coefficients [m^2/s].
 
virtual void getMultiDiffCoeffs (const size_t ld, double *const d)
 Return the Multicomponent diffusion coefficients. Units: [m^2/s].
 
virtual void getMixDiffCoeffs (double *const d)
 Returns a vector of mixture averaged diffusion coefficients.
 
virtual void getMixDiffCoeffsMole (double *const d)
 Returns a vector of mixture averaged diffusion coefficients.
 
virtual void getMixDiffCoeffsMass (double *const d)
 Returns a vector of mixture averaged diffusion coefficients.
 
virtual void getViscosityPolynomial (size_t i, double *coeffs) const
 Return the polynomial fits to the viscosity of species i.
 
virtual void getConductivityPolynomial (size_t i, double *coeffs) const
 Return the temperature fits of the heat conductivity of species i.
 
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 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)
 
virtual void setViscosityPolynomial (size_t i, double *coeffs)
 Modify the polynomial fits to the viscosity of species i.
 
virtual void setConductivityPolynomial (size_t i, double *coeffs)
 Modify the temperature fits of the heat conductivity of species i.
 
virtual void setBinDiffusivityPolynomial (size_t i, size_t j, double *coeffs)
 Modify 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)
 
virtual void setParameters (const int type, const int k, const double *const p)
 Set model parameters for derived classes.
 
AnyMap parameters () const
 Return the parameters for a phase definition which are needed to reconstruct an identical object using the newTransport function.
 
void setVelocityBasis (VelocityBasis ivb)
 Sets the velocity basis.
 
VelocityBasis getVelocityBasis () const
 Gets the velocity basis.
 
virtual void getSpeciesViscosities (double *const visc)
 Returns the pure species viscosities.
 
virtual double ionConductivity ()
 The ionic conductivity in 1/ohm/m.
 
virtual void getSpeciesIonConductivity (double *const ionCond)
 Returns the pure species ionic conductivity.
 
virtual void mobilityRatio (double *mobRat)
 Returns the pointer to the mobility ratios of the species in the phase.
 
virtual void getSpeciesMobilityRatio (double **mobRat)
 Returns the pure species limit of the mobility ratios.
 
virtual double electricalConductivity ()
 The electrical conductivity (Siemens/m).
 
virtual void getMobilities (double *const mobil_e)
 Get the Electrical mobilities (m^2/V/s).
 
virtual void getFluidMobilities (double *const mobil_f)
 Get the fluid mobilities (s kmol/kg).
 
virtual void setThermo (ThermoPhase &thermo)
 Specifies the ThermoPhase object.
 
virtual void setRoot (shared_ptr< Solution > root)
 Set root Solution holding all phase information.
 
virtual bool CKMode () const
 Boolean indicating the form of the transport properties polynomial fits.
 

Additional Inherited Members

- Protected Member Functions inherited from Transport
void finalize ()
 Enable the transport object for use.
 
- Protected Attributes inherited from Transport
ThermoPhasem_thermo
 pointer to the object representing the phase
 
bool m_ready = false
 true if finalize has been called
 
size_t m_nsp = 0
 Number of species.
 
size_t m_nDim
 Number of dimensions used in flux expressions.
 
int m_velocityBasis = VB_MASSAVG
 Velocity basis from which diffusion velocities are computed.
 
std::weak_ptr< Solutionm_root
 reference to Solution
 

Constructor & Destructor Documentation

◆ WaterTransport()

WaterTransport ( ThermoPhase thermo = 0,
int  ndim = -1 
)

default constructor

Parameters
thermoThermoPhase object that represents the phase. Defaults to zero
ndimNumber of dimensions of the flux expressions. Defaults to a value of one.
Deprecated:
The thermo and ndim parameters will be removed after Cantera 3.0. The ThermoPhase object should be specifed when calling the init method.

Definition at line 33 of file WaterTransport.cpp.

Member Function Documentation

◆ transportModel()

string transportModel ( ) const
inlineoverridevirtual

Identifies the model represented by this Transport object.

Each derived class should override this method to return a meaningful identifier.

Since
New in Cantera 3.0. The name returned by this method corresponds to the canonical name used in the YAML input format.

Reimplemented from Transport.

Definition at line 34 of file WaterTransport.h.

◆ viscosity()

double viscosity ( )
overridevirtual

Returns the viscosity of water at the current conditions (kg/m/s)

This function calculates the value of the viscosity of pure water at the current T and P.

The formulas used are from Sengers and Watson [38].

The formulation is accurate for all temperatures and pressures, for steam and for water, even near the critical point. Pressures above 500 MPa and temperature above 900 C are suspect.

Reimplemented from Transport.

Definition at line 46 of file WaterTransport.cpp.

◆ bulkViscosity()

double bulkViscosity ( )
inlineoverridevirtual

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 from Transport.

Definition at line 51 of file WaterTransport.h.

◆ thermalConductivity()

double thermalConductivity ( )
overridevirtual

Returns the thermal conductivity of water at the current conditions (W/m/K)

This function calculates the value of the thermal conductivity of water at the current T and P.

The formulas used are from Sengers and Watson [38].

The formulation is accurate for all temperatures and pressures, for steam and for water, even near the critical point. Pressures above 500 MPa and temperature above 900 C are suspect.

Reimplemented from Transport.

Definition at line 94 of file WaterTransport.cpp.

◆ init()

void init ( ThermoPhase thermo,
int  mode = 0,
int  log_level = 0 
)
overridevirtual

Initialize a transport manager.

This routine sets up a transport manager. It calculates the collision integrals and populates species-dependent data structures.

Parameters
thermoPointer to the ThermoPhase object
modeChemkin compatible mode or not. This alters the specification of the collision integrals. defaults to no.
log_levelDefaults to zero, no logging

Reimplemented from Transport.

Definition at line 41 of file WaterTransport.cpp.


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