]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Use the infinitive form of verbs in the first sentence of doc strings. 7343/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Fri, 12 Oct 2018 19:34:33 +0000 (13:34 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Fri, 12 Oct 2018 19:34:33 +0000 (13:34 -0600)
include/deal.II/differentiation/ad/ad_drivers.h
include/deal.II/differentiation/ad/ad_helpers.h
include/deal.II/hp/mapping_collection.h
include/deal.II/hp/q_collection.h
include/deal.II/multigrid/mg_transfer.h
include/deal.II/multigrid/mg_transfer_component.h
include/deal.II/multigrid/mg_transfer_internal.h
include/deal.II/multigrid/mg_transfer_matrix_free.h
include/deal.II/non_matching/immersed_surface_quadrature.h
include/deal.II/sundials/arkode.h

index 13106f2cb9cd0b0a400224b80248bd1cd9db8880..45a8015d4ffebc65497fa433f654ef907af2b86d 100644 (file)
@@ -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<ADNumberType>::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<ADNumberType>::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<ScalarType> &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<ScalarType> &           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<ScalarType> &           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<ADNumberType> &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<ScalarType> &             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<ScalarType> &             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.
index 0ebbb47e957b573628c108b193c8e37964240ae6..e3c0b8d7178af431b30ed70d28a75050f5febcd9 100644 (file)
@@ -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<ad_type>::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<dealii::types::global_dof_index> &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<scalar_type> &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<scalar_type> &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<scalar_type> &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.
index 68b21bc7d7cee9286cc48a991c41d5b688e35fcb..7742f6628afd12c96edfd8105c4e461c777c16e2 100644 (file)
@@ -77,7 +77,7 @@ namespace hp
       const MappingCollection<dim, spacedim> &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()
index 7d0b05ebbddb7cbb3559036a1706cad64a303e74..3534cb42385667ddd3a5fe9701a0f05eeb8ec036 100644 (file)
@@ -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
index 0faa248c39f90d4a1b618ac26c803c3093c9c3f6..a88bf028846b9a7f9d3abcfd047a3dbf9e945a59 100644 (file)
@@ -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;
 
index 0a6353d49f0b31f655b8c46d4a7d6875d2774e3e..8d7e2ed7faa8afa6a420bc460874d745a51dd547 100644 (file)
@@ -144,8 +144,8 @@ protected:
   std::vector<std::shared_ptr<BlockSparseMatrix<double>>> prolongation_matrices;
 
   /**
-   * Holds the mapping for the <tt>copy_to/from_mg</tt>-functions. The data is
-   * first the global index, then the level index.
+   * This variable holds the mapping for the <tt>copy_to/from_mg</tt>-functions.
+   * The data is first the global index, then the level index.
    */
   std::vector<std::vector<std::pair<types::global_dof_index, unsigned int>>>
     copy_to_and_from_indices;
index 1cc1c60287b2d23bc5198111dce6a1682b0ae1cc..804348ccf1458e7b4860ba3e984ac814ce796a69 100644 (file)
@@ -108,8 +108,8 @@ namespace internal
       std::vector<unsigned int> 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<Number> prolongation_matrix_1d;
     };
index 859514a4a36f71066c1601590786ad21eb9c5d84..a12554fcbc2ef002565acf1ad8120cc200132608 100644 (file)
@@ -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<unsigned int> 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<VectorizedArray<Number>> prolongation_matrix_1d;
 
   /**
-   * Holds the temporary values for the tensor evaluation
+   * This variable holds the temporary values for the tensor evaluation
    */
   mutable AlignedVector<VectorizedArray<Number>> evaluation_data;
 
index 396b62153e4be3ba3de9ffe9fd37810907ea638d..6a0a8fd4fc0e3bca387bfbcaa3d8901750183770 100644 (file)
@@ -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
index b792e5c7ece995ce8fcecd09b09fae3e04c4c6e0..9ac077932d7e169206e0206f15217b7f7792cb15 100644 (file)
@@ -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;

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.