Skip to content

Commit

Permalink
[docs] Replace additional instances of /*!
Browse files Browse the repository at this point in the history
  • Loading branch information
ischoegl committed Aug 3, 2023
1 parent b4cde19 commit dc06d7e
Show file tree
Hide file tree
Showing 39 changed files with 85 additions and 81 deletions.
2 changes: 1 addition & 1 deletion include/cantera/base/ct_defs.h
Expand Up @@ -46,7 +46,7 @@ using std::set;
using std::function;
using std::pair;

/*!
/**
* @defgroup physConstants Physical Constants
* @brief Physical constants used by %Cantera.
*
Expand Down
2 changes: 1 addition & 1 deletion include/cantera/base/ctexceptions.h
Expand Up @@ -22,7 +22,7 @@ namespace Cantera
* @defgroup debugGroup Errors and Diagnostics
*/

/*!
/**
* @defgroup errGroup Errors
*
* @brief Handling of errors and unknown events within %Cantera.
Expand Down
4 changes: 2 additions & 2 deletions include/cantera/base/global.h
Expand Up @@ -27,7 +27,7 @@ class AnyMap;
//! @defgroup ioGroup File Input/Output
//! @details Classes and functions used for reading and writing of %Cantera input files.

/*!
/**
* @defgroup inputGroup Input File Handling
* @brief Handling of %Cantera input files.
*
Expand Down Expand Up @@ -136,7 +136,7 @@ bool usesHDF5();

//! @}

/*!
/**
* @defgroup logGroup Logging
* @brief Logging and generation of diagnostic output.
*
Expand Down
7 changes: 3 additions & 4 deletions include/cantera/base/utilities.h
Expand Up @@ -24,9 +24,8 @@

namespace Cantera
{
/** @addtogroup mathTemplates
* @{
*/
//! @addtogroup mathTemplates
//! @{

//! Templated Inner product of two vectors of length 4.
/*!
Expand Down Expand Up @@ -169,7 +168,7 @@ R poly3(D x, R* c)
return (((c[3]*x + c[2])*x + c[1])*x + c[0]);
}

/** @}*/
//! @}

//! Check to see that a number is finite (not NaN, +Inf or -Inf)
void checkFinite(const double tmp);
Expand Down
10 changes: 5 additions & 5 deletions include/cantera/equil/ChemEquil.h
Expand Up @@ -91,7 +91,7 @@ class ChemEquil

virtual ~ChemEquil() = default;

/*!
/**
* Equilibrate a phase, holding the elemental composition fixed at the
* initial value found within the ThermoPhase object *s*.
*
Expand All @@ -101,7 +101,7 @@ class ChemEquil
*/
int equilibrate(ThermoPhase& s, const char* XY, int loglevel = 0);

/*!
/**
* Compute the equilibrium composition for two specified properties and the
* specified element moles.
*
Expand Down Expand Up @@ -140,13 +140,13 @@ class ChemEquil
return m_comp[k*m_mm + m];
}

/*!
/**
* Prepare for equilibrium calculations.
* @param s object representing the solution phase.
*/
void initialize(ThermoPhase& s);

/*!
/**
* Set mixture to an equilibrium state consistent with specified element
* potentials and temperature.
*
Expand All @@ -166,7 +166,7 @@ class ChemEquil
int estimateElementPotentials(ThermoPhase& s, vector_fp& lambda,
vector_fp& elMolesGoal, int loglevel = 0);

/*!
/**
* Do a calculation of the element potentials using the Brinkley method,
* p. 129 Smith and Missen.
*
Expand Down
10 changes: 5 additions & 5 deletions include/cantera/equil/vcs_solve.h
Expand Up @@ -94,7 +94,7 @@ class VCS_SOLVE
*/
int vcs_solve_TP(int print_lvl, int printDetails, int maxit);

/*!
/**
* We make decisions on the initial mole number, and major-minor status
* here. We also fix up the total moles in a phase.
*
Expand Down Expand Up @@ -467,7 +467,7 @@ class VCS_SOLVE
*/
int vcs_TP(int ipr, int ip1, int maxit, double T, double pres);

/*!
/**
* Evaluate the standard state free energies at the current temperature
* and pressure. Ideal gas pressure contribution is added in here.
*
Expand Down Expand Up @@ -628,7 +628,7 @@ class VCS_SOLVE
*/
void vcs_elab();

/*!
/**
* Checks to see if the element abundances are in compliance. If they are,
* then TRUE is returned. If not, FALSE is returned. Note the number of
* constraints checked is usually equal to the number of components in the
Expand All @@ -651,15 +651,15 @@ class VCS_SOLVE
*/
bool vcs_elabcheck(int ibound);

/*!
/**
* Computes the elemental abundances vector for a single phase,
* elemAbundPhase[], and returns it through the argument list. The mole
* numbers of species are taken from the current value in
* m_molNumSpecies_old[].
*/
void vcs_elabPhase(size_t iphase, double* const elemAbundPhase);

/*!
/**
* This subroutine corrects for element abundances. At the end of the
* subroutine, the total moles in all phases are recalculated again,
* because we have changed the number of moles in this routine.
Expand Down
2 changes: 1 addition & 1 deletion include/cantera/equil/vcs_species_thermo.h
Expand Up @@ -24,7 +24,7 @@ class vcs_VolPhase;
#define VCS_SSSTAR_CONSTANT 0
#define VCS_SSSTAR_IDEAL_GAS 1

/*!
/**
* Identifies the thermo model for the species. This structure is shared by
* volumetric and surface species. However, each will have its own types of
* thermodynamic models. These quantities all have appropriate units.
Expand Down
12 changes: 6 additions & 6 deletions include/cantera/kinetics/ImplicitSurfChem.h
Expand Up @@ -79,28 +79,28 @@ class ImplicitSurfChem : public FuncEval

virtual ~ImplicitSurfChem() = default;

/*!
/**
* Must be called before calling method 'advance'
*/
virtual void initialize(doublereal t0 = 0.0);

/*!
/**
* Set the maximum integration step-size. Note, setting this value to zero
* disables this option
*/
virtual void setMaxStepSize(double maxstep = 0.0);

/*!
/**
* Set the relative and absolute integration tolerances.
*/
virtual void setTolerances(double rtol=1.e-7, double atol=1.e-14);

/*!
/**
* Set the maximum number of CVODES integration steps.
*/
virtual void setMaxSteps(size_t maxsteps = 20000);

/*!
/**
* Set the maximum number of CVODES error test failures
*/
virtual void setMaxErrTestFails(size_t maxErrTestFails = 7);
Expand Down Expand Up @@ -172,7 +172,7 @@ class ImplicitSurfChem : public FuncEval
*/
virtual void getState(doublereal* y);

/*!
/**
* Get the specifications for the problem from the values
* in the ThermoPhase objects for all phases.
*
Expand Down
2 changes: 1 addition & 1 deletion include/cantera/kinetics/Kinetics.h
Expand Up @@ -1382,7 +1382,7 @@ class Kinetics
*/
virtual std::pair<size_t, size_t> checkDuplicates(bool throw_err=true) const;

/*!
/**
* Takes as input an array of properties for all species in the mechanism
* and copies those values belonging to a particular phase to the output
* array.
Expand Down
2 changes: 1 addition & 1 deletion include/cantera/kinetics/StoichManager.h
Expand Up @@ -550,7 +550,7 @@ inline static void _scale(InputIter begin, InputIter end,
}
}

/*!
/**
* This class handles operations involving the stoichiometric coefficients on
* one side of a reaction (reactant or product) for a set of reactions
* comprising a reaction mechanism. This class is used by class Kinetics, which
Expand Down
12 changes: 8 additions & 4 deletions include/cantera/numerics/FuncEval.h
Expand Up @@ -86,7 +86,8 @@ class FuncEval
*/
int evalDaeNoThrow(double t, double* y, double* ydot, double* residual);

/** Evaluate the setup processes for the Jacobian preconditioner.
/**
* Evaluate the setup processes for the Jacobian preconditioner.
* @param[in] t time.
* @param[in] y solution vector, length neq()
* @param gamma the gamma in M=I-gamma*J
Expand All @@ -97,7 +98,8 @@ class FuncEval
throw NotImplementedError("FuncEval::preconditionerSetup");
}

/** Evaluate the linear system Ax=b where A is the preconditioner.
/**
* Evaluate the linear system Ax=b where A is the preconditioner.
* @param[in] rhs right hand side vector used in linear system
* @param[out] output output vector for solution
* @warning This function is an experimental part of the %Cantera API and may be
Expand All @@ -112,7 +114,8 @@ class FuncEval
throw NotImplementedError("FuncEval::updatePreconditioner");
}

/** Preconditioner setup that doesn't throw an error but returns a
/**
* Preconditioner setup that doesn't throw an error but returns a
* CVODES flag. It also helps as a first level of polymorphism
* which identifies the specific FuncEval, e.g., ReactorNet.
* @param[in] t time.
Expand All @@ -123,7 +126,8 @@ class FuncEval
*/
int preconditioner_setup_nothrow(double t, double* y, double gamma);

/** Preconditioner solve that doesn't throw an error but returns a
/**
* Preconditioner solve that doesn't throw an error but returns a
* CVODES flag. It also helps as a first level of polymorphism
* which identifies the specific FuncEval, e.g., ReactorNet.
* @param[in] rhs right hand side vector used in linear system
Expand Down
2 changes: 1 addition & 1 deletion include/cantera/numerics/ctlapack.h
Expand Up @@ -400,7 +400,7 @@ inline void ct_dtrtrs(ctlapack::upperlower_t uplot, ctlapack::transpose_t trans,
info = f_info;
}

/*!
/**
* - `work` must be dimensioned equal to greater than 3N
* - `iwork` must be dimensioned equal to or greater than N
*/
Expand Down
7 changes: 3 additions & 4 deletions include/cantera/numerics/eigen_dense.h
Expand Up @@ -18,9 +18,8 @@
namespace Cantera
{

/** @addtogroup matrices
* @{
*/
//! @addtogroup matrices
//! @{

typedef Eigen::Map<Eigen::MatrixXd> MappedMatrix;
typedef Eigen::Map<const Eigen::MatrixXd> ConstMappedMatrix;
Expand All @@ -29,7 +28,7 @@ typedef Eigen::Map<const Eigen::VectorXd> ConstMappedVector;
typedef Eigen::Map<Eigen::RowVectorXd> MappedRowVector;
typedef Eigen::Map<const Eigen::RowVectorXd> ConstMappedRowVector;

/** @}*/
//! @}

}

Expand Down
8 changes: 4 additions & 4 deletions include/cantera/oneD/Domain1D.h
Expand Up @@ -127,7 +127,7 @@ class Domain1D
return m_bw;
}

/*!
/**
* Initialize. This method is called by OneDim::init() for each domain once
* at the beginning of a simulation. Base class method does nothing, but may
* be overloaded.
Expand All @@ -137,14 +137,14 @@ class Domain1D
virtual void setInitialState(doublereal* xlocal = 0) {}
virtual void setState(size_t point, const doublereal* state, doublereal* x) {}

/*!
/**
* When called, this function should reset "bad" values in the state vector
* such as negative species concentrations. This function may be called
* after a failed solution attempt.
*/
virtual void resetBadValues(double* xg) {}

/*!
/**
* Resize the domain to have nv components and np grid points. This method
* is virtual so that subclasses can perform other actions required to
* resize the domain.
Expand Down Expand Up @@ -302,7 +302,7 @@ class Domain1D
return (m_rdt != 0.0);
}

/*!
/**
* Set this if something has changed in the governing
* equations (for example, the value of a constant has been changed,
* so that the last-computed Jacobian is no longer valid.
Expand Down
2 changes: 1 addition & 1 deletion include/cantera/oneD/StFlow.h
Expand Up @@ -147,7 +147,7 @@ class StFlow : public Domain1D
m_tfix = tfixed;
}

/*!
/**
* Set the temperature fixed point at grid point j, and disable the energy
* equation so that the solution will be held to this value.
*/
Expand Down
2 changes: 1 addition & 1 deletion include/cantera/onedim.h
@@ -1,6 +1,6 @@
//! @file onedim.h

/*!
/**
* @defgroup onedGroup One-Dimensional Reacting Flows
*
* @details These classes comprise %Cantera's ability to solve steady-state
Expand Down
4 changes: 2 additions & 2 deletions include/cantera/thermo/ConstCpPoly.h
Expand Up @@ -61,7 +61,7 @@ class ConstCpPoly: public SpeciesThermoInterpType
*/
ConstCpPoly(double tlow, double thigh, double pref, const double* coeffs);

/*!
/**
* @param t0 @f$ T_0 @f$ [K]
* @param h0 @f$ h_k^o(T_0, p_{ref}) @f$ [J/kmol]
* @param s0 @f$ s_k^o(T_0, p_{ref}) @f$ [J/kmol/K]
Expand All @@ -73,7 +73,7 @@ class ConstCpPoly: public SpeciesThermoInterpType
return CONSTANT_CP;
}

/*!
/**
* @copydoc SpeciesThermoInterpType::updateProperties
*
* Form and Length of the temperature polynomial:
Expand Down
2 changes: 1 addition & 1 deletion include/cantera/thermo/GibbsExcessVPSSTP.h
Expand Up @@ -18,7 +18,7 @@
namespace Cantera
{

/*!
/**
* GibbsExcessVPSSTP is a derived class of ThermoPhase that handles variable
* pressure standard state methods for calculating thermodynamic properties that
* are further based on expressing the Excess Gibbs free energy as a function of
Expand Down
6 changes: 3 additions & 3 deletions include/cantera/thermo/IdealMolalSoln.h
Expand Up @@ -226,7 +226,7 @@ class IdealMolalSoln : public MolalityVPSSTP
virtual void getActivityConcentrations(doublereal* c) const;
virtual doublereal standardConcentration(size_t k=0) const;

/*!
/**
* Get the array of non-dimensional activities at the current solution
* temperature, pressure, and solution concentration.
*
Expand All @@ -236,7 +236,7 @@ class IdealMolalSoln : public MolalityVPSSTP
*/
virtual void getActivities(doublereal* ac) const;

/*!
/**
* Get the array of non-dimensional molality-based activity coefficients at
* the current solution temperature, pressure, and solution concentration.
*
Expand Down Expand Up @@ -400,7 +400,7 @@ class IdealMolalSoln : public MolalityVPSSTP
*/
double speciesMolarVolume(int k) const;

/*!
/**
* Fill in a return vector containing the species molar volumes
* units - @f$ m^3 kmol^{-1} @f$
*
Expand Down
2 changes: 1 addition & 1 deletion include/cantera/thermo/IonsFromNeutralVPSSTP.h
Expand Up @@ -29,7 +29,7 @@ enum IonSolnType_enumType {
cIonSolnType_MULTICATIONANION
};

/*!
/**
* The IonsFromNeutralVPSSTP is a derived class of ThermoPhase that handles the
* specification of the chemical potentials for ionic species, given a
* specification of the chemical potentials for the same phase expressed in
Expand Down

0 comments on commit dc06d7e

Please sign in to comment.