Skip to content

Commit

Permalink
Fix outdated or broken Doxygen \param commands
Browse files Browse the repository at this point in the history
  • Loading branch information
jngrad committed Sep 21, 2018
1 parent 11f5112 commit cd0597f
Show file tree
Hide file tree
Showing 15 changed files with 50 additions and 61 deletions.
22 changes: 9 additions & 13 deletions src/core/accumulators/Correlator.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -155,23 +155,19 @@ class Correlator : public AccumulatorBase {
* correlation class
* has to be fed with correct data from the very beginning.
*
* @param _delta_N: The number of time steps between subsequent updates
* @param _tau_lin: The linear part of the correlation function.
* @param _tau_max: maximal time delay tau to sample
* @param _window_distance: The distance in time domain between update of the
* @param delta_N The number of time steps between subsequent updates
* @param tau_lin The linear part of the correlation function.
* @param tau_max maximal time delay tau to sample
* @param window_distance: The distance in time domain between update of the
* correlation estimate
* @param _dim_A: The dimension of the A vector
* @param _dim_B: The dimension of the B vector
* @param _A: First observable to correlate
* @param _B: Second observable to correlate
* @param _dim_corr: The dimension of the correlation to be calculated
* @param _corr_operation_name: how to correlate the two observables A and B
* @param obs1 First observable to correlate
* @param obs2 Second observable to correlate
* @param corr_operation how to correlate the two observables A and B
* (this has no default)
* @param _compressA_name: how the A values should be compressed (usually
* @param compress1_ how the A values should be compressed (usually
* the linear compression method)
* @param _compressB_name: how the B values should be compressed (usually
* @param compress2_ how the B values should be compressed (usually
* the linear compression method)
* @param _args: the parameters of the observables
*
*/
Correlator(int tau_lin, double tau_max, int delta_N,
Expand Down
13 changes: 5 additions & 8 deletions src/core/bonded_interactions/bonded_interaction_data.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -365,7 +365,6 @@ void make_bond_type_exist(int type);
/** @brief Checks if particle has a pair bond with a given partner
* Note that bonds are stored only on one of the two particles in Espresso
*
* @param P
* @param p particle on which the bond may be stored
* @param partner bond partner
* @param bond_type numerical bond type */
Expand All @@ -390,9 +389,8 @@ inline bool pair_bond_exists_on(const Particle *const p,
/** @brief Checks both particle for a specific bond. Needs GHOSTS_HAVE_BONDS if
* particles are ghosts.
*
* @param P
* @param p1 particle on which the bond may be stored
* @param p2 bond partner
* @param p_bond particle on which the bond may be stored
* @param p_partner bond partner
* @param bond enum bond type */
inline bool pair_bond_enum_exists_on(const Particle *const p_bond,
const Particle *const p_partner,
Expand All @@ -414,10 +412,9 @@ inline bool pair_bond_enum_exists_on(const Particle *const p_bond,
/** @brief Checks both particle for a specific bond. Needs GHOSTS_HAVE_BONDS if
* particles are ghosts.
*
* @param P
* @param p1 particle on which the bond may be stored
* @param p2 particle on which the bond may be stored
* @param bond_type numerical bond type */
* @param p1 particle on which the bond may be stored
* @param p2 particle on which the bond may be stored
* @param bond numerical bond type */
inline bool pair_bond_enum_exists_between(const Particle *const p1,
const Particle *const p2,
BondedInteraction bond) {
Expand Down
2 changes: 0 additions & 2 deletions src/core/bonded_interactions/bonded_tab.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -43,7 +43,6 @@
@param part_type_a particle type for which the interaction is defined
@param part_type_b particle type for which the interaction is defined
@param filename from which file to fetch the data
@return <ul>
<li> 0 on success
Expand All @@ -66,7 +65,6 @@ int tabulated_set_params(int part_type_a, int part_type_b, double min,
@param bond_type bond type for which the interaction is defined
@param tab_type table type, TAB_BOND_LENGTH, TAB_BOND_ANGLE,
TAB_BOND_DIHEDRAL
@param filename from which file to fetch the data
@return <ul>
<li> 0 on success
Expand Down
1 change: 0 additions & 1 deletion src/core/communication.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -370,7 +370,6 @@ void mpi_remove_particle(int node, int id);
and exclusions are left over.
\param part the particle.
\param node the node it is attached to.
\param part_data where to store the received data.
\note Gets a copy of the particle data not a pointer to the actual particle
used in integration
*/
Expand Down
22 changes: 10 additions & 12 deletions src/core/grid_based_algorithms/lbgpu_cuda.cu
Original file line number Diff line number Diff line change
Expand Up @@ -273,7 +273,6 @@ template <typename T> __device__ void index_to_xyz(T index, T *xyz) {

/**transformation from xyz to 1d array-index
* @param xyz Pointer xyz array (Input)
* @param index Calculated node index / thread index (Output)
*/
template <typename T> __device__ T xyz_to_index(T *xyz) {
T x = (xyz[0] + para.dim_x) % para.dim_x;
Expand Down Expand Up @@ -1930,15 +1929,14 @@ __device__ void calc_mode(float *mode, LB_nodes_gpu n_a,
/** \name interpolation_three_point_coupling */
/*********************************************************/
/**(Eq. (12) Ahlrichs and Duenweg, JCP 111(17):8225 (1999))
* @param n_a Pointer to local node residing in array a (Input)
* @param *delta Pointer for the weighting of particle position
* (Output)
* @param *particle_data Pointer to the particle position and velocity (Input)
* @param *particle_force Pointer to the particle force (Input)
* @param part_index particle id / thread id (Input)
* @param node_index node index around (8) particle (Output)
* @param *d_v Pointer to local device values
* @param *interpolated_u Pointer to the interpolated velocity (Output)
* @param[in] n_a Local node residing in array a
* @param[out] delta Weighting of particle position
* @param[in] particle_position Particle position and velocity
* @param[in] particle_force Particle force
* @param[in] part_index Particle id / thread id
* @param[out] node_index Node index around (8) particle
* @param d_v Local device values
* @param[out] interpolated_u Interpolated velocity
*/
__device__ __inline__ void
interpolation_three_point_coupling(LB_nodes_gpu n_a, float *particle_position,
Expand Down Expand Up @@ -4694,7 +4692,7 @@ __global__ void lb_lbfluid_set_population_kernel(LB_nodes_gpu n_a,

/**interface to set the populations of a specific node for the GPU
* @param xyz coordinates of node (Input)
* @param population Pointer to population (Input)
* @param population_host Pointer to population (Input)
* @param c LB component (for SHANCHEN) (Input)
*/
void lb_lbfluid_set_population(int xyz[3], float population_host[LBQ], int c) {
Expand Down Expand Up @@ -4731,7 +4729,7 @@ __global__ void lb_lbfluid_get_population_kernel(LB_nodes_gpu n_a,

/**interface to get the populations of a specific node for the GPU
* @param xyz coordinates of node (Input)
* @param population Pointer to population (Output)
* @param population_host Pointer to population (Output)
* @param c LB component (for SHANCHEN) (Input)
*/
void lb_lbfluid_get_population(int xyz[3], float population_host[LBQ], int c) {
Expand Down
4 changes: 2 additions & 2 deletions src/core/io/mpiio/mpiio.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -298,7 +298,7 @@ static void mpiio_read_array(const std::string &fn, T *arr, size_t len,
*
* \param fn Filename of the head file
* \param rank The rank of the current process in MPI_COMM_WORLD
* \param file Pointer to store the fields to
* \param fields Pointer to store the fields to
*/
static void read_head(const std::string &fn, int rank, unsigned *fields) {
FILE *f = nullptr;
Expand All @@ -325,7 +325,7 @@ static void read_head(const std::string &fn, int rank, unsigned *fields) {
* \param rank The rank of the current process in MPI_COMM_WORLD
* \param size The size of MPI_COMM_WORLD
* \param nglobalpart The global amount of particles
* \param prefs Pointer to store the prefix to
* \param pref Pointer to store the prefix to
* \param nlocalpart Pointer to store the amount of local particles to
*/
static void read_prefs(const std::string &fn, int rank, int size,
Expand Down
12 changes: 6 additions & 6 deletions src/core/io/reader/readpdb.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -34,12 +34,12 @@ struct PdbLJInteraction {

/** Call only on the master node: Parse pdb file and add contained particles.
@param pdb_file Filename of the pdb file.
@first_id Id of the first particle to add.
@type Type for the particles.
@lennard_jones Should lj interactions be added from the itp file.
@fit Should the box be rescaled to hold the particles.
@lj_internal Should LJ interactions within the molecule be added.
@lj_diagonal Just the diagonal interaction terms oh lj_internal.
@param first_id Id of the first particle to add.
@param type Type for the particles.
@param lennard_jones Should lj interactions be added from the itp file.
@param fit Should the box be rescaled to hold the particles.
@param lj_internal Should LJ interactions within the molecule be added.
@param lj_diagonal Just the diagonal interaction terms of lj_internal.
@return Number of particles that were added.
*/

Expand Down
7 changes: 4 additions & 3 deletions src/core/io/writer/h5md_core.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -55,7 +55,7 @@ class File {
public:
/**
* Constructor/destructor without arguments (due to script_interface).
* @brief Constructor of the "File" class.
* @brief Constructor of the File class.
*/
File();
~File();
Expand All @@ -80,13 +80,14 @@ class File {
/**
* @brief General method to write to the datasets which calls more specific
* write methods.
* @param Boolean values for position, velocity, force and mass.
* Boolean values for position, velocity, force and mass.
*/
void Write(int write_dat, PartCfg &partCfg);

/**
* @brief Method to write the energy contributions to the H5MD file.
* @param Boolean values for total, kinetic.
* @param total Boolean values for total energy
* @param kinetic Boolean values for kinetic energy
* \todo Implement this method.
*/
void WriteEnergy(bool total = true, bool kinetic = true);
Expand Down
4 changes: 2 additions & 2 deletions src/core/particle_data.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -514,7 +514,7 @@ Particle *got_particle(ParticleList *plist, int id);
/** Append a particle at the end of a particle List.
reallocates particles if necessary!
This procedure does not care for \ref local_particles.
\param plist List to append the particle to.
\param l List to append the particle to.
\param part Particle to append. */
void append_unindexed_particle(ParticleList *l, Particle &&part);

Expand Down Expand Up @@ -699,7 +699,7 @@ void get_particle_mu_E(int part, double (&mu_E)[3]);
#endif

/** Call only on the master node: set particle type.
@param part the particle.
@param p_id the particle.
@param type its new type.
@return ES_OK if particle existed
*/
Expand Down
2 changes: 1 addition & 1 deletion src/core/statistics.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -216,7 +216,7 @@ void predict_momentum_particles(double *result) {
/** Calculate total momentum of the system (particles & LB fluid)
* inputs are bools to include particles and fluid in the linear momentum
* calculation
* @param momentum Result for this processor (Output)
* @return Result for this processor (Output)
*/
std::vector<double> calc_linear_momentum(int include_particles,
int include_lbfluid) {
Expand Down
5 changes: 2 additions & 3 deletions src/core/statistics.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -355,8 +355,7 @@ double min_distance(T1 const pos1, T2 const pos2) {
}

/** calculate the center of mass of a special type of the current configuration
* \param type type of the particle
* \param com center of mass position
* \param part_type type of the particle
*/
std::vector<double> centerofmass(PartCfg &, int part_type);

Expand All @@ -374,7 +373,7 @@ void angularmomentum(PartCfg &, int type, double *com);

/** calculate the center of mass of a special type of a saved configuration
* \param k number of the saved configuration
* \param type_1 type of the particle, -1 for all
* \param type type of the particle, -1 for all
* \param com center of mass position
*/

Expand Down
7 changes: 4 additions & 3 deletions src/core/utils/Histogram.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -53,9 +53,10 @@ inline size_t ravel_index(std::vector<size_t> unravelled_indices,
* \brief Returns the unraveled index of the provided flat index.
* Therefore is the inversion of flattening an ndims dimensional index.
* \param len_dims an int array of length ndims containing the lengths of the
* dimensions. (Input) \param ndims int denoting the number of dimensions.
* (Input) \flattened_index an int denoting the flat index. (Input)
* \unravelled_index_out an int array with length ndims where the unflat indices
* dimensions. (Input)
* \param ndims int denoting the number of dimensions. (Input)
* \param flattened_index an int denoting the flat index. (Input)
* \param unravelled_index_out an int array with length ndims where the unflat indices
* are written to. (Output)
*/
inline void unravel_index(const int *const len_dims, const int ndims,
Expand Down
4 changes: 2 additions & 2 deletions src/core/utils/mpi/gather_buffer.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -48,7 +48,7 @@ namespace Mpi {
large enough to hold all elements and has the local
part in the beginning. On the slaves the local buffer.
* @param n_elem The number of elements in the local buffer.
* @param The rank where the data should be gathered.
* @param root The rank where the data should be gathered.
* @return On rank root, the total number of elements in the buffer,
* on the other ranks 0.
*/
Expand Down Expand Up @@ -87,7 +87,7 @@ int gather_buffer(T *buffer, int n_elem, boost::mpi::communicator comm,
*
* @param buffer On the master the target buffer that has the local
part in the beginning. On the slaves the local buffer.
* @param The rank where the data should be gathered.
* @param root The rank where the data should be gathered.
* @return On rank root, the total number of elements in the buffer,
* on the other ranks 0.
*/
Expand Down
2 changes: 1 addition & 1 deletion src/script_interface/Parameter.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -25,7 +25,7 @@
namespace ScriptInterface {

/**
* Possible parameter type. Corresponds to the template parameters of @type
* Possible parameter type. Corresponds to the template parameters of type
* Variant.
*/
using ParameterType = VariantType;
Expand Down
4 changes: 2 additions & 2 deletions src/script_interface/ScriptInterfaceBase.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -141,7 +141,7 @@ class ScriptInterfaceBase : public Utils::AutoObjectId<ScriptInterfaceBase> {
* @brief Get single parameter.
*
* @param name Name of the parameter
* @return Value of parameter @param name.
* @return Value of parameter @p name
*/
virtual Variant get_parameter(const std::string &name) const {
return get_parameters().at(name);
Expand All @@ -161,7 +161,7 @@ class ScriptInterfaceBase : public Utils::AutoObjectId<ScriptInterfaceBase> {
* every
* element of the map.
*
* @param Parameters Parameters to set.
* @param parameters Parameters to set.
*/
virtual void set_parameters(const VariantMap &parameters) {
for (auto const &it : parameters) {
Expand Down

0 comments on commit cd0597f

Please sign in to comment.