mirror of
https://github.com/Cantera/cantera.git
synced 2025-02-25 18:55:29 -06:00
[Doc] Fix typos
This commit is contained in:
parent
7806fdfca9
commit
754ea74e7c
@ -60,7 +60,7 @@ public:
|
||||
* machines clock() returns type unsigned long (HP) and on others (SUN)
|
||||
* it returns type long. An attempt to recover the actual time for clocks
|
||||
* which have rolled over is made also. However, it only works if this
|
||||
* function is called fairly regularily during the solution procedure.
|
||||
* function is called fairly regularly during the solution procedure.
|
||||
*/
|
||||
double secondsWC();
|
||||
|
||||
|
@ -299,7 +299,7 @@ public:
|
||||
//! Gets the interface current for the ith phase
|
||||
/*!
|
||||
* @param iphase Phase Id
|
||||
* @return The double specifying the interface current. The interface Current
|
||||
* @return The double specifying the interface current. The interface current
|
||||
* is useful when charge transfer reactions occur at an interface. It
|
||||
* is defined here as the net positive charge entering the phase
|
||||
* specified by the Phase Id. (Units: A/m^2 for a surface reaction,
|
||||
|
@ -21,7 +21,7 @@ namespace Cantera
|
||||
//! AdaptivePreconditioner a preconditioner designed for use with large
|
||||
//! mechanisms that leverages sparse solvers. It does this by pruning
|
||||
//! the preconditioner by a threshold value. It also neglects pressure
|
||||
//! dependence and thirdbody contributions in its formation and has a
|
||||
//! dependence and third body contributions in its formation and has a
|
||||
//! finite difference approximation for temperature.
|
||||
class AdaptivePreconditioner : public PreconditionerBase
|
||||
{
|
||||
@ -64,10 +64,10 @@ public:
|
||||
//! Get the threshold value for setting elements
|
||||
double threshold() { return m_threshold; }
|
||||
|
||||
//! Get ilut fill factor
|
||||
//! Get ILUT fill factor
|
||||
double ilutFillFactor() { return m_fill_factor; }
|
||||
|
||||
//! Get ilut drop tolerance
|
||||
//! Get ILUT drop tolerance
|
||||
double ilutDropTol() { return m_drop_tol; }
|
||||
|
||||
//! Set the threshold value to compare elements against
|
||||
@ -98,10 +98,10 @@ public:
|
||||
void printJacobian();
|
||||
|
||||
protected:
|
||||
//! ilut fill factor
|
||||
//! ILUT fill factor
|
||||
double m_fill_factor = 0;
|
||||
|
||||
//! ilut drop tolerance
|
||||
//! ILUT drop tolerance
|
||||
double m_drop_tol = 0;
|
||||
|
||||
//! Vector of triples representing the jacobian used in preconditioning
|
||||
|
@ -32,7 +32,7 @@ doublereal linearInterp(doublereal x, const vector_fp& xpts,
|
||||
|
||||
//! Numerical integration of a function using the trapezoidal rule.
|
||||
/*!
|
||||
* Vector x contanins a monotonic sequence of grid points, and
|
||||
* Vector x contains a monotonic sequence of grid points, and
|
||||
* Vector f contains function values defined at these points.
|
||||
* The size of x and f must be the same.
|
||||
*
|
||||
@ -46,7 +46,7 @@ double trapezoidal(const Eigen::ArrayXd& f, const Eigen::ArrayXd& x);
|
||||
//! For even number, Simpson's rule is used for the first
|
||||
//! N-2 intervals with a trapezoidal rule on the last interval.
|
||||
/*!
|
||||
* Vector x contanins a monotonic sequence of grid points, and
|
||||
* Vector x contains a monotonic sequence of grid points, and
|
||||
* Vector f contains function values defined at these points.
|
||||
* The size of x and f must be the same.
|
||||
*
|
||||
@ -57,7 +57,7 @@ double simpson(const Eigen::ArrayXd& f, const Eigen::ArrayXd& x);
|
||||
|
||||
//! Numerical integration of a function.
|
||||
/*!
|
||||
* Vector x contanins a monotonic sequence of grid points, and
|
||||
* Vector x contains a monotonic sequence of grid points, and
|
||||
* Vector f contains function values defined at these points.
|
||||
* The size of x and f must be the same.
|
||||
*
|
||||
|
@ -66,8 +66,8 @@ public:
|
||||
* "Calculation and analysis of the mobility and diffusion coefficient
|
||||
* of thermal electrons in methane/air premixed flames."
|
||||
* Combustion and flame 159.12 (2012): 3518-3521.
|
||||
* If in the future the class GasTranport is improved, this method may
|
||||
* be discard. This method specifies this profile.
|
||||
* If in the future the class GasTransport is improved, this method may
|
||||
* be discarded. This method specifies this profile.
|
||||
*/
|
||||
void setElectronTransport(vector_fp& tfix,
|
||||
vector_fp& diff_e,
|
||||
|
@ -106,7 +106,7 @@ protected:
|
||||
double m_t0 = 0.0;
|
||||
//! Dimensionless value of the heat capacity
|
||||
double m_cp0_R = 0.0;
|
||||
//! dimensionless value of the enthaply at t0
|
||||
//! dimensionless value of the enthalpy at t0
|
||||
double m_h0_R = 0.0;
|
||||
//! Dimensionless value of the entropy at t0
|
||||
double m_s0_R = 0.0;
|
||||
|
@ -172,12 +172,12 @@ public:
|
||||
//! index of a species whose coverage affects enthalpy and entropy of
|
||||
//! a target species
|
||||
size_t j;
|
||||
//! array of polynomial coefficients describing coverage-depdendent enthalpy
|
||||
//! array of polynomial coefficients describing coverage-dependent enthalpy
|
||||
//! [J/kmol] in order of 1st-order, 2nd-order, 3rd-order, and 4th-order
|
||||
//! coefficients (\f$ c^{(1)}, c^{(2)}, c^{(3)}, \text{ and } c^{(4)} \f$
|
||||
//! in the linear or the polynomial dependency model)
|
||||
vector_fp enthalpy_coeffs;
|
||||
//! array of polynomial coefficients describing coverage-depdendent entropy
|
||||
//! array of polynomial coefficients describing coverage-dependent entropy
|
||||
//! [J/kmol/K] in order of 1st-order, 2nd-order, 3rd-order, and 4th-order
|
||||
//! coefficients (\f$ c^{(1)}, c^{(2)}, c^{(3)}, \text{ and } c^{(4)} \f$
|
||||
//! in the linear or the polynomial dependency model)
|
||||
|
@ -94,7 +94,7 @@ namespace Cantera
|
||||
*
|
||||
* where k is a species in the ith sublattice.
|
||||
*
|
||||
* The mole fraction vector is redefined witin the the LatticeSolidPhase object.
|
||||
* The mole fraction vector is redefined within the the LatticeSolidPhase object.
|
||||
* Each of the mole fractions sum to one on each of the sublattices. The
|
||||
* routine getMoleFraction() and setMoleFraction() have been redefined to use
|
||||
* this convention.
|
||||
@ -456,7 +456,7 @@ protected:
|
||||
//! Current value of the molar density
|
||||
double m_molar_density = 0.0;
|
||||
|
||||
//! Vector of sublattic ThermoPhase objects
|
||||
//! Vector of sublattice ThermoPhase objects
|
||||
std::vector<shared_ptr<ThermoPhase>> m_lattice;
|
||||
|
||||
//! Vector of mole fractions
|
||||
|
@ -104,7 +104,7 @@ namespace Cantera
|
||||
* The PDSS objects may or may not utilize a SpeciesThermoInterpType reference
|
||||
* state manager class to calculate the reference state thermodynamics functions
|
||||
* in their own calculation. There are some classes, such as PDSS_IdealGas and
|
||||
* PDSS+_ConstVol, which utilize the SpeciesThermoInterpType object because the
|
||||
* PDSS_ConstVol, which utilize the SpeciesThermoInterpType object because the
|
||||
* calculation is very similar to the reference state calculation, while there
|
||||
* are other classes, PDSS_Water and PDSS_HKFT, which don't utilize the
|
||||
* reference state calculation at all, because it wouldn't make sense to. For
|
||||
|
@ -57,7 +57,7 @@ public:
|
||||
* \f]
|
||||
*
|
||||
* *m* is the neutral molecule species index. \f$ \alpha_{m , k} \f$ is the
|
||||
* stoiciometric coefficient for the neutral molecule, *m*, that creates the
|
||||
* stoichiometric coefficient for the neutral molecule, *m*, that creates the
|
||||
* thermodynamics for the ionic species *k*. A factor \f$ 2.0 \ln{2.0} \f$
|
||||
* is added to all ions except for the species ionic species, which in this
|
||||
* case is the single anion species, with species index *sp*.
|
||||
|
@ -2,7 +2,7 @@
|
||||
* @file PureFluidPhase.h
|
||||
*
|
||||
* Header for a ThermoPhase class for a pure fluid phase consisting of
|
||||
* gas, liquid, mixed-gas-liquid and supercrit fluid (see \ref thermoprops
|
||||
* gas, liquid, mixed-gas-liquid and supercritical fluid (see \ref thermoprops
|
||||
* and class \link Cantera::PureFluidPhase PureFluidPhase\endlink).
|
||||
*
|
||||
* It inherits from ThermoPhase, but is built on top of the tpx package.
|
||||
|
@ -153,7 +153,7 @@ public:
|
||||
|
||||
virtual double Pp()=0;
|
||||
|
||||
//! Enthaply of a single-phase state
|
||||
//! Enthalpy of a single-phase state
|
||||
double hp() {
|
||||
return up() + Pp()/Rho;
|
||||
}
|
||||
|
@ -46,7 +46,7 @@ public:
|
||||
}
|
||||
|
||||
//! Update the mass flow rate at time 'time'. This must be overloaded in
|
||||
//! subclassess to update m_mdot.
|
||||
//! subclasses to update m_mdot.
|
||||
virtual void updateMassFlowRate(double time) {}
|
||||
|
||||
//! Mass flow rate (kg/s) of outlet species k. Returns zero if this species
|
||||
|
@ -56,14 +56,14 @@ __sundials_version__ = '.'.join(str(get_sundials_version()))
|
||||
__version__ = pystr(CxxVersion())
|
||||
|
||||
if __version__ != pystr(get_cantera_version_py()):
|
||||
raise ImportError("Mismatch betweeen Cantera Python module version "
|
||||
raise ImportError("Mismatch between Cantera Python module version "
|
||||
f"({pystr(get_cantera_version_py())}) and Cantera shared library "
|
||||
f"version ({__version__})")
|
||||
|
||||
__git_commit__ = pystr(CxxGitCommit())
|
||||
|
||||
if __git_commit__ != pystr(get_cantera_git_commit_py()):
|
||||
raise ImportError("Mismatch betweeen Cantera Python module Git commit "
|
||||
raise ImportError("Mismatch between Cantera Python module Git commit "
|
||||
f"({pystr(get_cantera_git_commit_py())}) and Cantera shared library "
|
||||
f"git commit ({__git_commit__})")
|
||||
|
||||
|
@ -1874,7 +1874,7 @@ cdef class ThermoPhase(_SolutionBase):
|
||||
self.plasma.setQuadratureMethod(stringify(method))
|
||||
|
||||
property normalize_electron_energy_distribution_enabled:
|
||||
""" Automatically normalize electron energy distribuion """
|
||||
""" Automatically normalize electron energy distribution """
|
||||
def __get__(self):
|
||||
if not self._enable_plasma:
|
||||
raise ThermoModelMethodError(self.thermo_model)
|
||||
|
@ -40,7 +40,7 @@ namespace Cantera {
|
||||
* inadvertently nothing happens, and if an attempt is made to reference the object by
|
||||
* its index number, a standard exception is thrown.
|
||||
*
|
||||
* The SharedCabinet<M> class is implemented as a singlet. The constructor is never
|
||||
* The SharedCabinet<M> class is implemented as a singleton. The constructor is never
|
||||
* explicitly called; instead, static function SharedCabinet<M>::SharedCabinet() is
|
||||
* called to obtain a pointer to the instance. This function calls the constructor on
|
||||
* the first call and stores the pointer to this instance. Subsequent calls simply
|
||||
|
@ -50,7 +50,7 @@ double trapezoidal(const Eigen::ArrayXd& f, const Eigen::ArrayXd& x)
|
||||
//! Only for odd number of points. This function is used only
|
||||
//! by calling simpson.
|
||||
/*!
|
||||
* Vector x contanins a monotonic sequence of grid points, and
|
||||
* Vector x contains a monotonic sequence of grid points, and
|
||||
* Vector f contains function values defined at these points.
|
||||
* The size of x and f must be the same.
|
||||
*
|
||||
|
Loading…
Reference in New Issue
Block a user