 Application | Class to hold global data |
 Application::Messages | Class to carry out messages |
 Application::ThreadMessages | Class that stores thread messages for each thread, and retrieves them based on the thread id |
 Array2D | A class for 2D arrays stored in column-major (Fortran-compatible) form |
  DenseMatrix | A class for full (non-sparse) matrices with Fortran-compatible data storage, which adds matrix operations to class Array2D |
   SquareMatrix | A class for full (non-sparse) matrices with Fortran-compatible data storage |
 Arrhenius | Arrhenius reaction rate type depends only on temperature |
 awData | |
 C1 | Handles one species in a reaction |
 C2 | Handles two species in a single reaction |
 C3 | Handles three species in a reaction |
 C_AnyN | Handles any number of species in a reaction, including fractional stoichiometric coefficients, and arbitrary reaction orders |
 CachedValue< T > | |
 ChebyshevRate | Pressure-dependent rate expression where the rate coefficient is expressed as a bivariate Chebyshev polynomial in temperature and pressure |
 ChemEquil | Class ChemEquil implements a chemical equilibrium solver for single-phase solutions |
 clockWC | The class provides the wall clock timer in seconds |
 CoverageDependency | Modifications to an InterfaceReaction rate based on a surface species coverage |
 DAE_Solver | Wrapper for DAE solvers |
 Domain1D | Base class for one-dimensional domains |
  Bdry1D | The base class for boundaries between one-dimensional spatial domains |
   Inlet1D | An inlet |
   Outlet1D | An outlet |
   OutletRes1D | An outlet with specified composition |
   ReactingSurf1D | A reacting surface |
   Surf1D | A non-reacting surface |
   Symm1D | A symmetry plane |
  Empty1D | A terminator that does nothing |
  StFlow | This class represents 1D flow domains that satisfy the one-dimensional similarity solution for chemically-reacting, axisymmetric, flows |
   AxiStagnFlow | A class for axisymmetric stagnation flows |
   FreeFlame | A class for freely-propagating premixed flames |
 Elements | Object containing the elements that make up species in a phase |
 Enhanced3BConc | Computes enhanced third-body concentrations |
 EquilOpt | Chemical equilibrium options |
 ExchangeCurrent | Arrhenius reaction rate type depends only on temperature |
 ExtraGlobalRxn | Class describing an extra global reaction, which is defined as a linear combination of actuals reactions, global or mass-action, creating a global stoichiometric result |
 FactoryBase | Base class for factories |
  FalloffFactory | Factory class to construct falloff function calculators |
  KineticsFactory | Factory for kinetics managers |
  SpeciesThermoFactory | Factory to build instances of classes that manage the standard-state thermodynamic properties of a set of species |
  ThermoFactory | Factory class for thermodynamic property managers |
  TransportFactory | Factory class for creating new instances of classes derived from Transport |
  VPSSMgrFactory | Factory to build instances of classes that manage the standard-state thermodynamic properties of a set of species |
 Falloff | Base class for falloff function calculators |
  SRI | The SRI falloff function |
  Troe | The 3- or 4-parameter Troe falloff parameterization |
 FalloffMgr | A falloff manager that implements any set of falloff functions |
 FlowDevice | Base class for 'flow devices' (valves, pressure regulators, etc.) connecting reactors |
  MassFlowController | A class for mass flow controllers |
  PressureController | A class for flow controllers where the flow rate is equal to the flow rate of a "master" mass flow controller plus a correction proportional to the pressure difference between the inlet and outlet |
  Valve | Supply a mass flow rate that is a function of the pressure drop across the valve |
 Func1 | Base class for 'functor' classes that evaluate a function of one variable |
  Arrhenius1 | Sum of Arrhenius terms |
  Composite1 | Composite function |
  Const1 | Constant |
  Cos1 | Cos |
  Diff1 | Difference of two functions |
  Exp1 | Exp |
  Fourier1 | Fourier cosine/sine series |
  Gaussian | A Gaussian |
  Periodic1 | Periodic function |
  PlusConstant1 | A function plus a constant |
  Poly1 | Polynomial of degree n |
  Pow1 | Pow |
  Product1 | Product of two functions |
  Ratio1 | Ratio of two functions |
  Sin1 | Implements the sin() function |
  Sum1 | Sum of two functions |
  TimesConstant1 | Product of two functions |
 FuncEval | Virtual base class for ODE right-hand-side function evaluators |
  ImplicitSurfChem | Advances the surface coverages of the associated set of SurfacePhase objects in time |
  ReactorNet | A class representing a network of connected reactors |
 GeneralMatrix | Generic matrix |
  BandMatrix | A class for banded matrices, involving matrix inversion processes |
   MultiJac | Class MultiJac evaluates the Jacobian of a system of equations defined by a residual function supplied by an instance of class OneDim |
  SquareMatrix | A class for full (non-sparse) matrices with Fortran-compatible data storage |
 Group | Class Group is an internal class used by class ReactionPath |
 Integrator | Abstract base class for ODE system integrators |
  BEulerInt | |
  CVodeInt | Wrapper class for 'CVODE' integrator from LLNL |
  CVodesIntegrator | Wrapper class for 'cvodes' integrator from LLNL |
 Kinetics | Public interface for kinetics managers |
  BulkKinetics | Partial specialization of Kinetics for chemistry in a single bulk phase |
   AqueousKinetics | Kinetics manager for elementary aqueous-phase chemistry |
   GasKinetics | Kinetics manager for elementary gas-phase chemistry |
    IdealGasMix | Convenience class which inherits from both IdealGasPhase and GasKinetics |
  InterfaceKinetics | A kinetics manager for heterogeneous reaction mechanisms |
   EdgeKinetics | Heterogeneous reactions at one-dimensional interfaces between multiple adjacent two-dimensional surfaces |
    Edge | Convenience class which inherits from both EdgePhase and EdgeKinetics |
   ElectrodeKinetics | A kinetics manager for heterogeneous reaction mechanisms |
   Interface | An interface between multiple bulk phases |
 LiquidTranInteraction | Base class to handle transport property evaluation in a mixture |
  LTI_Log_MoleFracs | Mixing rule using logarithms of the mole fractions |
  LTI_MassFracs | Simple mass fraction weighting of transport properties |
  LTI_MoleFracs | Simple mole fraction weighting of transport properties |
  LTI_MoleFracs_ExpT | Simple mole fraction weighting of transport properties |
  LTI_Pairwise_Interaction | Transport properties that act like pairwise interactions as in binary diffusion coefficients |
  LTI_StefanMaxwell_PPN | Stefan Maxwell Diffusion Coefficients can be solved for given ion conductivity, mobility ratios, and self diffusion coeffs |
 LiquidTransportData | Class LiquidTransportData holds transport parameters for a specific liquid-phase species |
 Logger | Base class for 'loggers' that write text messages to log files |
 LTPspecies | Class LTPspecies holds transport parameterizations for a specific liquid-phase species |
  LTPspecies_Arrhenius | Class LTPspecies_Arrhenius holds transport parameters for a specific liquid-phase species (LTPspecies) when the transport property is expressed in Arrhenius form |
  LTPspecies_Const | Class LTPspecies_Const holds transport parameters for a specific liquid-phase species (LTPspecies) when the transport property is just a constant value |
  LTPspecies_ExpT | Class LTPspecies_ExpT holds transport parameters for a specific liquid- phase species (LTPspecies) when the transport property is expressed as an exponential in temperature |
  LTPspecies_Poly | Class LTPspecies_Poly holds transport parameters for a specific liquid-phase species (LTPspecies) when the transport property is expressed as a polynomial in temperature |
 MMCollisionInt | Calculation of Collision integrals |
 MultiNewton | Newton iterator for multi-domain, one-dimensional problems |
 MultiPhase | A class for multiphase mixtures |
 MultiPhaseEquil | |
 NonlinearSolver | Class that calculates the solution to a nonlinear system |
 OneDim | Container class for multiple-domain 1D problems |
  Sim1D | One-dimensional simulations |
 PDSS | Virtual base class for a species with a pressure dependent standard state |
  PDSS_Molar | Base class for PDSS classes which compute molar properties directly |
   PDSS_HKFT | Class for pressure dependent standard states corresponding to ionic solutes in electrolyte water |
   PDSS_Water | Class for the liquid water pressure dependent standard state |
  PDSS_Nondimensional | Base class for PDSS classes which compute nondimensional properties directly |
   PDSS_ConstVol | Class for pressure dependent standard states that use a constant volume model |
   PDSS_IdealGas | Derived class for pressure dependent standard states of an ideal gas species |
   PDSS_IonsFromNeutral | Derived class for pressure dependent standard states of an ideal gas species |
   PDSS_SSVol | Class for pressure dependent standard states that uses a standard state volume model of some sort |
 Phase | Class Phase is the base class for phases of matter, managing the species and elements in a phase, as well as the independent variables of temperature, mass density, species mass/mole fraction, and other generalized forces and intrinsic properties (such as electric potential) that define the thermodynamic state |
  ThermoPhase | Base class for a phase with thermodynamic properties |
   ConstDensityThermo | Overloads the virtual methods of class ThermoPhase to implement the incompressible equation of state |
    IncompressibleSolid | Wrapper for ConstDensityThermo with constructor from file |
   IdealGasPhase | Class IdealGasPhase represents low-density gases that obey the ideal gas equation of state |
    IdealGasMix | Convenience class which inherits from both IdealGasPhase and GasKinetics |
   IdealSolidSolnPhase | Class IdealSolidSolnPhase represents a condensed phase ideal solution compound |
   LatticePhase | A simple thermodynamic model for a bulk phase, assuming a lattice of solid atoms |
   LatticeSolidPhase | A phase that is comprised of a fixed additive combination of other lattice phases |
   MetalPhase | Class MetalPhase represents electrons in a metal |
    Metal | Wrapper for MetalPhase with constructor from file |
   MixtureFugacityTP | This is a filter class for ThermoPhase that implements some preparatory steps for efficiently handling mixture of gases that whose standard states are defined as ideal gases, but which describe also non-ideal solutions |
    RedlichKwongMFTP | This class can handle either an ideal solution or an ideal gas approximation of a phase |
   PureFluidPhase | This phase object consists of a single component that can be a gas, a liquid, a mixed gas-liquid fluid, or a fluid beyond its critical point |
    PureFluid | Wrapper for PureFluidPhase with constructor from file |
   SemiconductorPhase | Class SemiconductorPhase represents electrons and holes in a semiconductor |
   SingleSpeciesTP | Filter class for ThermoPhase |
    FixedChemPotSSTP | Class FixedChemPotSSTP represents a stoichiometric (fixed composition) incompressible substance |
    MetalSHEelectrons | Class MetalSHEelectrons represents electrons within a metal, adjacent to an aqueous electrolyte, that are consistent with the SHE reference electrode |
    StoichSubstanceSSTP | Class StoichSubstanceSSTP represents a stoichiometric (fixed composition) incompressible substance |
     electrodeElectron | Class electrodeElectron represents an electron in a metal using the Standard hydrogen reference electrode |
     MineralEQ3 | Class MineralEQ3 represents a stoichiometric (fixed composition) incompressible substance based on EQ3's parameterization |
    WaterSSTP | Class for single-component water |
   StoichSubstance | Class StoichSubstance represents a stoichiometric (fixed composition) incompressible substance |
   SurfPhase | A simple thermodynamic model for a surface phase, assuming an ideal solution model |
    EdgePhase | A thermodynamic phase representing a one dimensional edge between two surfaces |
     Edge | Convenience class which inherits from both EdgePhase and EdgeKinetics |
    Interface | An interface between multiple bulk phases |
   VPStandardStateTP | This is a filter class for ThermoPhase that implements some prepatory steps for efficiently handling a variable pressure standard state for species |
    GibbsExcessVPSSTP | |
     IonsFromNeutralVPSSTP | |
     MargulesVPSSTP | MargulesVPSSTP is a derived class of GibbsExcessVPSSTP that employs the Margules approximation for the excess Gibbs free energy |
     MolarityIonicVPSSTP | |
      MixedSolventElectrolyte | MixedSolventElectrolyte is a derived class of GibbsExcessVPSSTP that employs the DH and local Marguless approximations for the excess Gibbs free energy |
     PhaseCombo_Interaction | PhaseCombo_Interaction is a derived class of GibbsExcessVPSSTP that employs the Margules approximation for the excess Gibbs free energy while eliminating the entropy of mixing term |
     PseudoBinaryVPSSTP | |
     RedlichKisterVPSSTP | RedlichKisterVPSSTP is a derived class of GibbsExcessVPSSTP that employs the Redlich-Kister approximation for the excess Gibbs free energy |
    IdealSolnGasVPSS | An ideal solution or an ideal gas approximation of a phase |
    MaskellSolidSolnPhase | Class MaskellSolidSolnPhase represents a condensed phase non-ideal solution with 2 species following the thermodynamic model described in Maskell, Shaw, and Tye, Manganese Dioxide Electrode – IX, Electrochimica Acta 28(2) pp 231-235, 1983 |
    MolalityVPSSTP | |
     DebyeHuckel | Class DebyeHuckel represents a dilute liquid electrolyte phase which obeys the Debye Huckel formulation for nonideality |
     HMWSoln | Class HMWSoln represents a dilute or concentrated liquid electrolyte phase which obeys the Pitzer formulation for nonideality |
     IdealMolalSoln | This phase is based upon the mixing-rule assumption that all molality-based activity coefficients are equal to one |
 Plog | Pressure-dependent reaction rate expressed by logarithmically interpolating between Arrhenius rate expressions at various pressures |
 PropertyCalculator< M > | Classes used by ChemEquil |
 Rate1< R > | This rate coefficient manager supports one parameterization of the rate constant of any type |
 Reaction | Intermediate class which stores data about a reaction and its rate parameterization so that it can be added to a Kinetics object |
  ChebyshevReaction | A pressure-dependent reaction parameterized by a bi-variate Chebyshev polynomial in temperature and pressure |
  ElementaryReaction | A reaction which follows mass-action kinetics with a modified Arrhenius reaction rate |
   InterfaceReaction | A reaction occurring on an interface (i.e. a SurfPhase or an EdgePhase) |
    ElectrochemicalReaction | An interface reaction which involves charged species |
   ThreeBodyReaction | A reaction with a non-reacting third body "M" that acts to add or remove energy from the reacting species |
  FalloffReaction | A reaction that is first-order in [M] at low pressure, like a third-body reaction, but zeroth-order in [M] as pressure increases |
   ChemicallyActivatedReaction | A reaction where the rate decreases as pressure increases due to collisional stabilization of a reaction intermediate |
  PlogReaction | A pressure-dependent reaction parameterized by logarithmically interpolating between Arrhenius rate expressions at various pressures |
 ReactionData | Intermediate class which stores data about a reaction and its rate parameterization before adding the reaction to a Kinetics object |
 ReactionPathDiagram | Reaction path diagrams (graphs) |
 ReactionRules | Rules for parsing and installing reactions |
 ReactionStoichMgr | Reaction mechanism stoichiometry manager |
 ReactorBase | Base class for stirred reactors |
  Reactor | Class Reactor is a general-purpose class for stirred reactors |
   ConstPressureReactor | Class ConstPressureReactor is a class for constant-pressure reactors |
    IdealGasConstPressureReactor | Class ConstPressureReactor is a class for constant-pressure reactors |
   FlowReactor | Adiabatic flow in a constant-area duct |
   IdealGasReactor | Class IdealGasReactor is a class for stirred reactors that is specifically optimized for ideal gases |
 Refiner | Refine Domain1D grids so that profiles satisfy adaptation tolerances |
 ResidData | A simple class to hold an array of parameter values and a pointer to an instance of a subclass of ResidEval |
 ResidEval | Virtual base class for DAE residual function evaluators |
  ResidJacEval | Wrappers for the function evaluators for Nonlinear solvers and Time steppers |
 RootFind | Root finder for 1D problems |
 RootFind::rfTable | Structure containing the iteration history |
 RxnMolChange | Class that includes some bookeeping entries for a reaction or a global reaction defined on a surface |
 RxnOrders | Forward orders |
 solveProb | Method to solve a pseudo steady state of a nonlinear problem |
 solveSP | Method to solve a pseudo steady state surface problem |
 Species | Contains data about a single chemical species |
 SpeciesNode | Nodes in reaction path graphs |
 SpeciesThermo | Pure Virtual base class for the species thermo manager classes |
  GeneralSpeciesThermo | A species thermodynamic property manager for a phase |
  NasaThermo | A species thermodynamic property manager for the NASA polynomial parameterization with two temperature ranges |
  ShomateThermo | A species thermodynamic property manager for the Shomate polynomial parameterization |
  SimpleThermo | |
  SpeciesThermoDuo< T1, T2 > | This species thermo manager requires that all species have one of two parameterizations |
 SpeciesThermoInterpType | Pure Virtual Base class for the thermodynamic manager for an individual species' reference state |
  Adsorbate | An adsorbed surface species |
  ConstCpPoly | A constant-heat capacity species thermodynamic property manager class |
  Mu0Poly | Implements an interpolation of the Gibbs free energy based on a piecewise constant heat capacity approximation |
  Nasa9Poly1 | The NASA 9 polynomial parameterization for one temperature range |
  Nasa9PolyMultiTempRegion | The NASA 9 polynomial parameterization for a single species encompassing multiple temperature regions |
  NasaPoly1 | The NASA polynomial parameterization for one temperature range |
  NasaPoly2 | The NASA polynomial parameterization for two temperature ranges |
  ShomatePoly | The Shomate polynomial parameterization for one temperature range for one species |
  ShomatePoly2 | The Shomate polynomial parameterization for two temperature ranges for one species |
  StatMech | Statistical mechanics |
  STITbyPDSS | Class for the thermodynamic manager for an individual species' reference state which uses the PDSS base class to satisfy the requests |
 SurfaceArrhenius | An Arrhenius rate with coverage-dependent terms |
 ThirdBody | A class for managing third-body efficiencies, including default values |
 ThirdBodyCalc | Calculate and apply third-body effects on reaction rates, including non- unity third-body efficiencies |
 ThirdBodyMgr< _E > | |
 timesConstant< T > | Unary operator to multiply the argument by a constant |
 Tortuosity | Specific Class to handle tortuosity corrections for diffusive transport in porous media using the Bruggeman exponent |
  TortuosityMaxwell | This class implements transport coefficient corrections appropriate for porous media with a dispersed phase |
  TortuosityPercolation | This class implements transport coefficient corrections appropriate for porous media where percolation theory applies |
 Transport | Base class for transport property managers |
  AqueousTransport | Class AqueousTransport implements mixture-averaged transport properties for brine phases |
  DustyGasTransport | Class DustyGasTransport implements the Dusty Gas model for transport in porous media |
  GasTransport | Class GasTransport implements some functions and properties that are shared by the MixTransport and MultiTransport classes |
   MixTransport | Class MixTransport implements mixture-averaged transport properties for ideal gas mixtures |
   MultiTransport | Class MultiTransport implements multicomponent transport properties for ideal gas mixtures |
    HighPressureGasTransport | Class MultiTransport implements transport properties for high pressure gas mixtures |
  LiquidTransport | Class LiquidTransport implements models for transport properties for liquid phases |
  PecosTransport | Class PecosTransport implements mixture-averaged transport properties for ideal gas mixtures |
  SimpleTransport | Class SimpleTransport implements mixture-averaged transport properties for liquid phases |
  SolidTransport | Class SolidTransport implements transport properties for solids |
  WaterTransport | Transport Parameters for pure water |
 TransportData | Base class for transport data for a single species |
  GasTransportData | Transport data for a single gas-phase species which can be used in mixture-averaged or multicomponent transport models |
 TransportParams | Base structure to hold transport model parameters |
  GasTransportParams | This structure holds transport model parameters relevant to transport in ideal gases with a kinetic theory of gases derived transport model |
  LiquidTransportParams | Class LiquidTransportParams holds transport model parameters relevant to transport in mixtures |
  SolidTransportData | Class SolidTransportData holds transport parameters for a specific solid-phase species |
 Unit | Unit conversion utility |
 ValueCache | |
 VCS_COUNTERS | Class to keep track of time and iterations |
 vcs_MultiPhaseEquil | Cantera's Interface to the Multiphase chemical equilibrium solver |
 VCS_PROB | Interface class for the vcs thermo equilibrium solver package, which generally describes the problem to be solved |
 VCS_SOLVE | This is the main structure used to hold the internal data used in vcs_solve_TP(), and to solve TP systems |
 VCS_SPECIES_THERMO | |
 vcs_SpeciesProperties | Properties of a single species |
 vcs_VolPhase | Phase information and Phase calculations for vcs |
 VPSSMgr | Virtual base class for the classes that manage the calculation of standard state properties for all the species in a phase |
  VPSSMgr_ConstVol | Constant Molar Volume e VPSS species thermo manager class |
  VPSSMgr_General | Class that handles the calculation of standard state thermo properties for a set of species belonging to a single phase in a completely general but slow way |
  VPSSMgr_IdealGas | A VPSSMgr where all species in the phase obey an ideal gas equation of state |
  VPSSMgr_Water_ConstVol | Handles the calculation of standard state thermo properties for real water and a set of species which have a constant molar volume pressure dependence |
  VPSSMgr_Water_HKFT | Manages standard state thermo properties for real water and a set of species which have the HKFT equation of state |
 Wall | Represents a wall between between two ReactorBase objects |
 WaterProps | Used to house several approximation routines for properties of water |
 WaterPropsIAPWS | Class for calculating the equation of state of water |
 WaterPropsIAPWSphi | Low level class for the real description of water |
 XML_Node | Class XML_Node is a tree-based representation of the contents of an XML file |
 XML_Reader | Class XML_Reader reads an XML file into an XML_Node object |
 Rate1< Cantera::Arrhenius > | |
 Rate1< Cantera::ChebyshevRate > | |
 Rate1< Cantera::Plog > | |
 Rate1< Cantera::SurfaceArrhenius > | |
 exception | STL class |
  CanteraError | Base class for exceptions thrown by Cantera classes |
   ArraySizeError | Array size error |
   BEulerErr | Exception class thrown when a BEuler error is encountered |
   CELapackError | Exception thrown when an LAPACK error is encountered associated with inverting or solving a matrix |
   CVodeErr | Exception thrown when a CVODE error is encountered |
   CVodesErr | Exception thrown when a CVODES error is encountered |
   ElementsFrozen | Exception class to indicate a fixed set of elements |
   IDA_Err | Exception thrown when a IDA error is encountered |
   IndexError | An array index is out of range |
   LTPError | Exception thrown if an error is encountered while reading the transport database |
   LTPError | Exception thrown if an error is encountered while reading the transport database |
   LTPmodelError | Exception thrown if an error is encountered while reading the transport database |
   LTPmodelError | Exception thrown if an error is encountered while reading the transport database |
   NotImplementedError | An error indicating that an unimplemented function has been called |
   TransportDBError | Exception thrown if an error is encountered while reading the transport database |
   UnknownSpeciesThermo | Unknown species thermo manager string error |
   UnknownSpeciesThermoModel | Throw a named error for an unknown or missing species thermo model |
   UnknownThermoPhaseModel | Specific error to be thrown if the type of Thermo manager is unrecognized |
   UnknownVPSSMgrModel | Throw a named error for an unknown or missing vpss species thermo model |
   XML_Error | Classs representing a generic XML error condition |
    XML_NoChild | Class representing a specific type of XML file formatting error |
    XML_TagMismatch | Class representing a specific type of XML file formatting error |
 Substance | |
  CarbonDioxide | Pure species representation of carbon dioxide |
  Heptane | Pure species representation of heptane |
  HFC134a | Equation of state for HFC-134a |
  hydrogen | Pure species representation of hydrogen |
  methane | Pure species representation of methane |
  nitrogen | Pure species representation of nitrogen |
  oxygen | Pure species representation of oxygen |
  water | Pure species representation of water |