From d3d5ab4a09d4117df3f0c40fc7c06a7713504d4d Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Fri, 12 Oct 2018 13:34:33 -0600 Subject: [PATCH] Use the infinitive form of verbs in the first sentence of doc strings. --- .../deal.II/differentiation/ad/ad_drivers.h | 30 +++++++++---------- .../deal.II/differentiation/ad/ad_helpers.h | 28 ++++++++--------- include/deal.II/hp/mapping_collection.h | 2 +- include/deal.II/hp/q_collection.h | 2 +- include/deal.II/multigrid/mg_transfer.h | 24 +++++++-------- .../deal.II/multigrid/mg_transfer_component.h | 4 +-- .../deal.II/multigrid/mg_transfer_internal.h | 4 +-- .../multigrid/mg_transfer_matrix_free.h | 14 ++++----- .../immersed_surface_quadrature.h | 11 +++---- include/deal.II/sundials/arkode.h | 4 +-- 10 files changed, 62 insertions(+), 61 deletions(-) diff --git a/include/deal.II/differentiation/ad/ad_drivers.h b/include/deal.II/differentiation/ad/ad_drivers.h index 13106f2cb9..45a8015d4f 100644 --- a/include/deal.II/differentiation/ad/ad_drivers.h +++ b/include/deal.II/differentiation/ad/ad_drivers.h @@ -165,21 +165,21 @@ namespace Differentiation //@{ /** - * Returns whether or not this class is tracking calculations performed + * Return whether or not this class is tracking calculations performed * with its marked independent variables. */ bool is_recording() const; /** - * Returns the tape number which is currently activated for recording or + * Return the tape number which is currently activated for recording or * reading. */ typename Types::tape_index active_tape_index() const; /** - * Returns whether or not a tape number has already been used + * Return whether or not a tape number has already been used * or registered. */ bool @@ -187,7 +187,7 @@ namespace Differentiation const typename Types::tape_index tape_index) const; /** - * Returns whether or not the numerical values of all independent + * Return whether or not the numerical values of all independent * variables are recorded in the tape buffer. */ bool @@ -285,7 +285,7 @@ namespace Differentiation reset(const bool clear_registered_tapes); /** - * Prints the status of all queriable data. Exactly what is printed and + * Print the status of all queriable data. Exactly what is printed and * its format depends on the @p ad_type, as is determined by the * @p ADNumberTypeCode template parameter. * @@ -315,7 +315,7 @@ namespace Differentiation //@{ /** - * Computes the value of the scalar field. + * Compute the value of the scalar field. * * @param[in] active_tape_index The index of the tape on which the * dependent function is recorded. @@ -329,7 +329,7 @@ namespace Differentiation const std::vector &independent_variables); /** - * Computes the gradient of the scalar field with respect to all + * Compute the gradient of the scalar field with respect to all * independent variables. * * @param[in] active_tape_index The index of the tape on which the @@ -347,7 +347,7 @@ namespace Differentiation Vector & gradient); /** - * Computes the Hessian of the scalar field with respect to all + * Compute the Hessian of the scalar field with respect to all * independent variables. * * @param[in] active_tape_index The index of the tape on which the @@ -372,7 +372,7 @@ namespace Differentiation //@{ /** - * Computes the values of the vector field. + * Compute the values of the vector field. * * @param[in] active_tape_index The index of the tape on which the * dependent function is recorded. @@ -390,7 +390,7 @@ namespace Differentiation Vector & values); /** - * Computes the Jacobian of the vector field. + * Compute the Jacobian of the vector field. * * The Jacobian of a vector field is in essence the gradient of each * dependent variable with respect to all independent variables. @@ -503,7 +503,7 @@ namespace Differentiation //@{ /** - * Computes the value of the scalar field. + * Compute the value of the scalar field. * * @param[in] dependent_variables The dependent variables whose values are * to be extracted. @@ -514,7 +514,7 @@ namespace Differentiation value(const std::vector &dependent_variables); /** - * Computes the gradient of the scalar field with respect to all + * Compute the gradient of the scalar field with respect to all * independent variables. * * @param[in] independent_variables The independent variables whose @@ -532,7 +532,7 @@ namespace Differentiation Vector & gradient); /** - * Computes the Hessian of the scalar field with respect to all + * Compute the Hessian of the scalar field with respect to all * independent variables. * * @param[in] independent_variables The independent variables whose @@ -557,7 +557,7 @@ namespace Differentiation //@{ /** - * Computes the values of the vector field. + * Compute the values of the vector field. * * @param[in] dependent_variables The dependent variables whose Hessians * are to be extracted. @@ -570,7 +570,7 @@ namespace Differentiation Vector & values); /** - * Computes the Jacobian of the vector field. + * Compute the Jacobian of the vector field. * * The Jacobian of a vector field is in essence the gradient of each * dependent variable with respect to all independent variables. diff --git a/include/deal.II/differentiation/ad/ad_helpers.h b/include/deal.II/differentiation/ad/ad_helpers.h index 0ebbb47e95..e3c0b8d717 100644 --- a/include/deal.II/differentiation/ad/ad_helpers.h +++ b/include/deal.II/differentiation/ad/ad_helpers.h @@ -217,21 +217,21 @@ namespace Differentiation //@{ /** - * Returns the number of independent variables that this object expects to + * Return the number of independent variables that this object expects to * work with. This is the dimension of the domain space. */ std::size_t n_independent_variables() const; /** - * Returns the number of dependent variables that this object expects to + * Return the number of dependent variables that this object expects to * operate on. This is the dimension of the image space. */ std::size_t n_dependent_variables() const; /** - * Prints the status of all queryable data. Exactly what is printed and + * Print the status of all queryable data. Exactly what is printed and * its format depends on the @p ad_type, as is determined by the * @p ADNumberTypeCode template parameter. * @@ -242,7 +242,7 @@ namespace Differentiation print(std::ostream &stream) const; /** - * Prints the values currently assigned to the independent variables. + * Print the values currently assigned to the independent variables. * * @param[in] stream The output stream to which the values are to be * written. @@ -251,7 +251,7 @@ namespace Differentiation print_values(std::ostream &stream) const; /** - * Prints the statistics regarding the usage of the tapes. + * Print the statistics regarding the usage of the tapes. * * @param[in] tape_index The index of the tape to get the statistics of. * @param[out] stream The output stream to which the values are to be @@ -340,21 +340,21 @@ namespace Differentiation const bool clear_registered_tapes = true); /** - * Returns whether or not this class is tracking calculations performed + * Return whether or not this class is tracking calculations performed * with its marked independent variables. */ bool is_recording() const; /** - * Returns the tape index which is currently activated for recording or + * Return the tape index which is currently activated for recording or * reading. */ typename Types::tape_index active_tape_index() const; /** - * Returns whether or not a tape number has already been used + * Return whether or not a tape number has already been used * or registered. */ bool @@ -832,7 +832,7 @@ namespace Differentiation const std::vector &local_dof_indices); /** - * Returns the complete set of degree of freedom values as represented by + * Return the complete set of degree of freedom values as represented by * auto-differentiable numbers. These are the independent * variables $\mathbf{X}$ about which the solution is linearized. * @@ -861,7 +861,7 @@ namespace Differentiation //@{ /* - * Returns the complete set of degree of freedom values of + * Return the complete set of degree of freedom values of * auto-differentiable number type. These store the same scalar values as * the independent variables $\mathbf{X}$ about which the solution is * linearized. @@ -943,7 +943,7 @@ namespace Differentiation //@{ /** - * Computes the value of the residual vector field + * Compute the value of the residual vector field * $\mathbf{r}(\mathbf{X})$. * * @param[out] residual A Vector object with the value for each component @@ -960,7 +960,7 @@ namespace Differentiation compute_residual(Vector &residual) const = 0; /** - * Computes the gradient (first derivative) of the residual vector field + * Compute the gradient (first derivative) of the residual vector field * with respect to all independent variables, i.e. * @f[ * \frac{\partial\mathbf{r}(\mathbf{X})}{\partial\mathbf{X}} @@ -1256,7 +1256,7 @@ namespace Differentiation compute_residual(Vector &residual) const override; /** - * Computes the linearization of the residual vector around a chosen set + * Compute the linearization of the residual vector around a chosen set * of degree of freedom values. Underlying this is the computation of the * Hessian (second derivative) of the scalar function $\Psi$ with respect * to all independent variables, i.e. @@ -1553,7 +1553,7 @@ namespace Differentiation compute_residual(Vector &residual) const override; /** - * Computes the linearization of the residual vector around a chosen set + * Compute the linearization of the residual vector around a chosen set * of degree of freedom values. Underlying this is the computation of the * gradient (first derivative) of the residual vector $\mathbf{r}$ with * respect to all independent variables, i.e. diff --git a/include/deal.II/hp/mapping_collection.h b/include/deal.II/hp/mapping_collection.h index 68b21bc7d7..7742f6628a 100644 --- a/include/deal.II/hp/mapping_collection.h +++ b/include/deal.II/hp/mapping_collection.h @@ -77,7 +77,7 @@ namespace hp const MappingCollection &mapping_collection); /** - * Adds a new mapping to the MappingCollection. Generally, you will + * Add a new mapping to the MappingCollection. Generally, you will * want to use the same order for mappings as for the elements of * the hp::FECollection object you use. However, the same * considerations as discussed with the hp::QCollection::push_back() diff --git a/include/deal.II/hp/q_collection.h b/include/deal.II/hp/q_collection.h index 7d0b05ebbd..3534cb4238 100644 --- a/include/deal.II/hp/q_collection.h +++ b/include/deal.II/hp/q_collection.h @@ -72,7 +72,7 @@ namespace hp explicit QCollection(const QTypes &... quadrature_objects); /** - * Adds a new quadrature rule to the QCollection. In most cases, you will + * Add a new quadrature rule to the QCollection. In most cases, you will * want to add quadrature rules in the same order as the elements were * added to the hp::FECollection for which this quadrature rule collection * is meant. If done this way, the hp::FEValues objects with which you will diff --git a/include/deal.II/multigrid/mg_transfer.h b/include/deal.II/multigrid/mg_transfer.h index 0faa248c39..a88bf02884 100644 --- a/include/deal.II/multigrid/mg_transfer.h +++ b/include/deal.II/multigrid/mg_transfer.h @@ -367,10 +367,10 @@ protected: copy_indices_level_mine; /** - * Stores whether the copy operation from the global to the level vector is - * actually a plain copy to the finest level. This means that the grid has - * no adaptive refinement and the numbering on the finest multigrid level is - * the same as in the global case. + * This variable stores whether the copy operation from the global to the + * level vector is actually a plain copy to the finest level. This means that + * the grid has no adaptive refinement and the numbering on the finest + * multigrid level is the same as in the global case. */ bool perform_plain_copy; @@ -552,18 +552,18 @@ protected: solution_copy_indices_level_mine; /** - * Stores whether the copy operation from the global to the level vector is - * actually a plain copy to the finest level. This means that the grid has - * no adaptive refinement and the numbering on the finest multigrid level is - * the same as in the global case. + * This variable stores whether the copy operation from the global to the + * level vector is actually a plain copy to the finest level. This means that + * the grid has no adaptive refinement and the numbering on the finest + * multigrid level is the same as in the global case. */ bool perform_plain_copy; /** - * Stores whether the copy operation from the global to the level vector is - * actually a plain copy to the finest level except for a renumbering within - * the finest level of the degrees of freedom. This means that the grid has - * no adaptive refinement. + * This variable stores whether the copy operation from the global to the + * level vector is actually a plain copy to the finest level except for a + * renumbering within the finest level of the degrees of freedom. This means + * that the grid has no adaptive refinement. */ bool perform_renumbered_plain_copy; diff --git a/include/deal.II/multigrid/mg_transfer_component.h b/include/deal.II/multigrid/mg_transfer_component.h index 0a6353d49f..8d7e2ed7fa 100644 --- a/include/deal.II/multigrid/mg_transfer_component.h +++ b/include/deal.II/multigrid/mg_transfer_component.h @@ -144,8 +144,8 @@ protected: std::vector>> prolongation_matrices; /** - * Holds the mapping for the copy_to/from_mg-functions. The data is - * first the global index, then the level index. + * This variable holds the mapping for the copy_to/from_mg-functions. + * The data is first the global index, then the level index. */ std::vector>> copy_to_and_from_indices; diff --git a/include/deal.II/multigrid/mg_transfer_internal.h b/include/deal.II/multigrid/mg_transfer_internal.h index 1cc1c60287..804348ccf1 100644 --- a/include/deal.II/multigrid/mg_transfer_internal.h +++ b/include/deal.II/multigrid/mg_transfer_internal.h @@ -108,8 +108,8 @@ namespace internal std::vector lexicographic_numbering; /** - * Holds the one-dimensional embedding (prolongation) matrix from mother - * element to all the children. + * This variable holds the one-dimensional embedding (prolongation) matrix + * from mother element to all the children. */ std::vector prolongation_matrix_1d; }; diff --git a/include/deal.II/multigrid/mg_transfer_matrix_free.h b/include/deal.II/multigrid/mg_transfer_matrix_free.h index 859514a4a3..a12554fcbc 100644 --- a/include/deal.II/multigrid/mg_transfer_matrix_free.h +++ b/include/deal.II/multigrid/mg_transfer_matrix_free.h @@ -190,10 +190,10 @@ private: unsigned int n_child_cell_dofs; /** - * Holds the indices for cells on a given level, extracted from DoFHandler - * for fast access. All DoF indices on a given level are stored as a plain - * array (since this class assumes constant DoFs per cell). To index into - * this array, use the cell number times dofs_per_cell. + * This variable holds the indices for cells on a given level, extracted from + * DoFHandler for fast access. All DoF indices on a given level are stored as + * a plain array (since this class assumes constant DoFs per cell). To index + * into this array, use the cell number times dofs_per_cell. * * This array first is arranged such that all locally owned level cells come * first (found in the variable n_owned_level_cells) and then other cells @@ -215,13 +215,13 @@ private: std::vector n_owned_level_cells; /** - * Holds the one-dimensional embedding (prolongation) matrix from mother - * element to all the children. + * This variable holds the one-dimensional embedding (prolongation) matrix + * from mother element to all the children. */ AlignedVector> prolongation_matrix_1d; /** - * Holds the temporary values for the tensor evaluation + * This variable holds the temporary values for the tensor evaluation */ mutable AlignedVector> evaluation_data; diff --git a/include/deal.II/non_matching/immersed_surface_quadrature.h b/include/deal.II/non_matching/immersed_surface_quadrature.h index 396b62153e..6a0a8fd4fc 100644 --- a/include/deal.II/non_matching/immersed_surface_quadrature.h +++ b/include/deal.II/non_matching/immersed_surface_quadrature.h @@ -29,11 +29,12 @@ DEAL_II_NAMESPACE_OPEN namespace NonMatching { /** - * Defines a quadrature formula for integration over an oriented surface, - * $\hat{S}$, immersed in the unit cell. By immersed it is meant that the - * surface may intersect the unit cell in an arbitrary way. The quadrature - * formula is described by a set of quadrature points, $\hat{x}_q$, weights, - * $w_q$, and normalized surface normals, $\hat{n}_q$. + * This class defines a quadrature formula for integration over an + * oriented surface, $\hat{S}$, immersed in the unit cell. By + * immersed it is meant that the surface may intersect the unit cell + * in an arbitrary way. The quadrature formula is described by a set + * of quadrature points, $\hat{x}_q$, weights, $w_q$, and normalized + * surface normals, $\hat{n}_q$. * * We typically want to compute surface integrals in real space. * A surface $S$ intersecting a cell $K$ in real space, can be mapped onto a diff --git a/include/deal.II/sundials/arkode.h b/include/deal.II/sundials/arkode.h index b792e5c7ec..9ac077932d 100644 --- a/include/deal.II/sundials/arkode.h +++ b/include/deal.II/sundials/arkode.h @@ -489,12 +489,12 @@ namespace SUNDIALS unsigned int maximum_non_linear_iterations; /** - * Specifies that the implicit portion of the problem is linear. + * Specify whether the implicit portion of the problem is linear. */ bool implicit_function_is_linear; /** - * Specifies that the implicit portion of the problem is linear and time + * Specify whether the implicit portion of the problem is linear and time * independent. */ bool implicit_function_is_time_independent; -- 2.39.5