From: Wolfgang Bangerth Date: Mon, 27 Nov 2017 23:04:49 +0000 (-0700) Subject: More grammar fixes. X-Git-Tag: v9.0.0-rc1~720^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=88b1ac64c28de390787a9332349c88c1f8660368;p=dealii.git More grammar fixes. --- diff --git a/include/deal.II/base/logstream.h b/include/deal.II/base/logstream.h index 8b3710fec4..779b3998bb 100644 --- a/include/deal.II/base/logstream.h +++ b/include/deal.II/base/logstream.h @@ -158,19 +158,20 @@ public: /** - * Gives the default stream (std_out). + * Return the default stream (std_out). */ std::ostream &get_console (); /** - * Gives the file stream. + * Return the file stream. */ std::ostream &get_file_stream (); /** - * @return true, if file stream has already been attached. + * Return @p true if file stream has already been attached, + * @p false otherwise. */ bool has_file () const; diff --git a/include/deal.II/base/tensor_product_polynomials.h b/include/deal.II/base/tensor_product_polynomials.h index 002e8385f9..cc6160b1bb 100644 --- a/include/deal.II/base/tensor_product_polynomials.h +++ b/include/deal.II/base/tensor_product_polynomials.h @@ -91,12 +91,12 @@ public: void set_numbering(const std::vector &renumber); /** - * Gives read access to the renumber vector. + * Give read access to the renumber vector. */ const std::vector &get_numbering() const; /** - * Gives read access to the inverse renumber vector. + * Give read access to the inverse renumber vector. */ const std::vector &get_numbering_inverse() const; diff --git a/include/deal.II/fe/fe_enriched.h b/include/deal.II/fe/fe_enriched.h index c97f5edc5d..40087821c5 100644 --- a/include/deal.II/fe/fe_enriched.h +++ b/include/deal.II/fe/fe_enriched.h @@ -473,14 +473,14 @@ protected: InternalData ( std::unique_ptr::InternalData> fesystem_data); /** - * Gives read-access to the pointer to a @p InternalData of the @p + * Give read-access to the pointer to a @p InternalData of the @p * base_noth base element of FESystem's data. */ typename FiniteElement::InternalDataBase & get_fe_data (const unsigned int base_no) const; /** - * Gives read-access to the pointer to an object into which the + * Give read-access to the pointer to an object into which the * base_noth base element will write its output when calling * FiniteElement::fill_fe_values() and similar functions. */ diff --git a/include/deal.II/fe/fe_system.h b/include/deal.II/fe/fe_system.h index 20b9e116d0..4f8ae614bf 100644 --- a/include/deal.II/fe/fe_system.h +++ b/include/deal.II/fe/fe_system.h @@ -1112,21 +1112,21 @@ private: ~InternalData(); /** - * Gives write-access to the pointer to a @p InternalData of the @p + * Give write-access to the pointer to a @p InternalData of the @p * base_noth base element. */ void set_fe_data(const unsigned int base_no, typename FiniteElement::InternalDataBase *); /** - * Gives read-access to the pointer to a @p InternalData of the @p + * Give read-access to the pointer to a @p InternalData of the @p * base_noth base element. */ typename FiniteElement::InternalDataBase & get_fe_data (const unsigned int base_no) const; /** - * Gives read-access to the pointer to an object to which into which the + * Give read-access to the pointer to an object to which into which the * base_noth base element will write its output when calling * FiniteElement::fill_fe_values() and similar functions. */ diff --git a/include/deal.II/fe/fe_tools.h b/include/deal.II/fe/fe_tools.h index 9df12411d8..5dadfb5687 100644 --- a/include/deal.II/fe/fe_tools.h +++ b/include/deal.II/fe/fe_tools.h @@ -176,7 +176,7 @@ namespace FETools * @{ */ /** - * Gives the interpolation matrix that interpolates a @p fe1- function to a + * Compute the interpolation matrix that interpolates a @p fe1-function to a * @p fe2-function on each cell. The interpolation_matrix needs to be of * size (fe2.dofs_per_cell, fe1.dofs_per_cell). * @@ -191,7 +191,7 @@ namespace FETools FullMatrix &interpolation_matrix); /** - * Gives the interpolation matrix that interpolates a @p fe1- function to a + * Compute the interpolation matrix that interpolates a @p fe1-function to a * @p fe2-function, and interpolates this to a second @p fe1-function on * each cell. The interpolation_matrix needs to be of size * (fe1.dofs_per_cell, fe1.dofs_per_cell). @@ -208,11 +208,11 @@ namespace FETools FullMatrix &interpolation_matrix); /** - * Gives the unit matrix minus the back interpolation matrix. The @p + * Compute the identity matrix minus the back interpolation matrix. The @p * difference_matrix needs to be of size (fe1.dofs_per_cell, * fe1.dofs_per_cell). * - * This function gives the matrix that transforms a @p fe1 function $z$ to + * This function computes the matrix that transforms a @p fe1 function $z$ to * $z-I_hz$ where $I_h$ denotes the interpolation operator from the @p fe1 * space to the @p fe2 space. This matrix hence is useful to evaluate error- * representations where $z$ denotes the dual solution. @@ -596,7 +596,7 @@ namespace FETools */ //@{ /** - * Gives the interpolation of a the @p dof1-function @p u1 to a @p + * Compute the interpolation of a the @p dof1-function @p u1 to a @p * dof2-function @p u2. @p dof1 and @p dof2 need to be DoFHandlers based on * the same triangulation. * @@ -634,7 +634,7 @@ namespace FETools OutVector &u2); /** - * Gives the interpolation of a the @p dof1-function @p u1 to a @p + * Compute the interpolation of a the @p dof1-function @p u1 to a @p * dof2-function @p u2. @p dof1 and @p dof2 need to be DoFHandlers (or * hp::DoFHandlers) based on the same triangulation. @p constraints is a * hanging node constraints object corresponding to @p dof2. This object is @@ -660,7 +660,7 @@ namespace FETools OutVector &u2); /** - * Gives the interpolation of the @p fe1-function @p u1 to a @p + * Compute the interpolation of the @p fe1-function @p u1 to a @p * fe2-function, and interpolates this to a second @p fe1-function named @p * u1_interpolated. * @@ -683,7 +683,7 @@ namespace FETools OutVector &u1_interpolated); /** - * Gives the interpolation of the @p dof1-function @p u1 to a @p + * Compute the interpolation of the @p dof1-function @p u1 to a @p * dof2-function, and interpolates this to a second @p dof1-function named * @p u1_interpolated. @p constraints1 and @p constraints2 are the hanging * node constraints corresponding to @p dof1 and @p dof2, respectively. @@ -703,7 +703,7 @@ namespace FETools OutVector &u1_interpolated); /** - * Gives $(Id-I_h)z_1$ for a given @p dof1-function $z_1$, where $I_h$ is + * Compute $(Id-I_h)z_1$ for a given @p dof1-function $z_1$, where $I_h$ is * the interpolation from @p fe1 to @p fe2. The result $(Id-I_h)z_1$ is * written into @p z1_difference. * @@ -718,7 +718,7 @@ namespace FETools OutVector &z1_difference); /** - * Gives $(Id-I_h)z_1$ for a given @p dof1-function $z_1$, where $I_h$ is + * Compute $(Id-I_h)z_1$ for a given @p dof1-function $z_1$, where $I_h$ is * the interpolation from @p fe1 to @p fe2. The result $(Id-I_h)z_1$ is * written into @p z1_difference. @p constraints1 and @p constraints2 are * the hanging node constraints corresponding to @p dof1 and @p dof2, @@ -754,7 +754,7 @@ namespace FETools OutVector &u2); /** - * Gives the patchwise extrapolation of a @p dof1 function @p z1 to a @p + * Compute the patchwise extrapolation of a @p dof1 function @p z1 to a @p * dof2 function @p z2. @p dof1 and @p dof2 need to be DoFHandler objects * based on the same triangulation. This function is used, for example, for * extrapolating patchwise a piecewise linear solution to a piecewise @@ -819,7 +819,7 @@ namespace FETools OutVector &z2); /** - * Gives the patchwise extrapolation of a @p dof1 function @p z1 to a @p + * Compute the patchwise extrapolation of a @p dof1 function @p z1 to a @p * dof2 function @p z2. @p dof1 and @p dof2 need to be DoFHandler objects * based on the same triangulation. @p constraints is a hanging node * constraints object corresponding to @p dof2. This object is necessary diff --git a/include/deal.II/grid/tria_boundary.h b/include/deal.II/grid/tria_boundary.h index d7cd760dbd..d13e70246b 100644 --- a/include/deal.II/grid/tria_boundary.h +++ b/include/deal.II/grid/tria_boundary.h @@ -271,7 +271,7 @@ public: get_new_point_on_quad (const typename Triangulation::quad_iterator &quad) const; /** - * Gives n=points.size() points that splits the StraightBoundary + * Return n=points.size() points that split the StraightBoundary * line into $n+1$ partitions of equal lengths. * * Refer to the general documentation of this class and the documentation of @@ -283,7 +283,7 @@ public: std::vector > &points) const; /** - * Gives n=points.size()=m*m points that splits the + * Return n=points.size()=m*m points that splits the * StraightBoundary quad into $(m+1)(m+1)$ subquads of equal size. * * Refer to the general documentation of this class and the documentation of diff --git a/include/deal.II/lac/petsc_precondition.h b/include/deal.II/lac/petsc_precondition.h index 053c54ab75..720bbe168c 100644 --- a/include/deal.II/lac/petsc_precondition.h +++ b/include/deal.II/lac/petsc_precondition.h @@ -79,7 +79,7 @@ namespace PETScWrappers /** - * Gives access to the underlying PETSc object. + * Give access to the underlying PETSc object. */ const PC &get_pc () const; diff --git a/include/deal.II/lac/trilinos_sparsity_pattern.h b/include/deal.II/lac/trilinos_sparsity_pattern.h index 8fa63d911e..7755784741 100644 --- a/include/deal.II/lac/trilinos_sparsity_pattern.h +++ b/include/deal.II/lac/trilinos_sparsity_pattern.h @@ -840,7 +840,7 @@ namespace TrilinosWrappers bool is_compressed () const; /** - * Gives the maximum number of entries per row on the current processor. + * Return the maximum number of entries per row on the current processor. */ unsigned int max_entries_per_row () const; diff --git a/include/deal.II/numerics/vector_tools.h b/include/deal.II/numerics/vector_tools.h index fdc24fced4..55eb3a4331 100644 --- a/include/deal.II/numerics/vector_tools.h +++ b/include/deal.II/numerics/vector_tools.h @@ -689,7 +689,7 @@ namespace VectorTools const ComponentMask &component_mask = ComponentMask()); /** - * Gives the interpolation of a @p dof1-function @p u1 to a @p dof2-function + * Compute the interpolation of a @p dof1-function @p u1 to a @p dof2-function * @p u2, where @p dof1 and @p dof2 represent different triangulations with * a common coarse grid. * @@ -721,7 +721,7 @@ namespace VectorTools VectorType &u2); /** - * Gives the interpolation of a @p dof1-function @p u1 to a @p dof2-function + * Compute the interpolation of a @p dof1-function @p u1 to a @p dof2-function * @p u2, where @p dof1 and @p dof2 represent different triangulations with * a common coarse grid. *