]> https://gitweb.dealii.org/ - dealii.git/commitdiff
More grammar fixes. 5541/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Mon, 27 Nov 2017 23:04:49 +0000 (16:04 -0700)
committerWolfgang Bangerth <bangerth@colostate.edu>
Mon, 27 Nov 2017 23:04:49 +0000 (16:04 -0700)
include/deal.II/base/logstream.h
include/deal.II/base/tensor_product_polynomials.h
include/deal.II/fe/fe_enriched.h
include/deal.II/fe/fe_system.h
include/deal.II/fe/fe_tools.h
include/deal.II/grid/tria_boundary.h
include/deal.II/lac/petsc_precondition.h
include/deal.II/lac/trilinos_sparsity_pattern.h
include/deal.II/numerics/vector_tools.h

index 8b3710fec4b646db0429a102454966e9e8e223fc..779b3998bbb8e0a17ff4bd1db8c4632e5c2d616f 100644 (file)
@@ -158,19 +158,20 @@ public:
 
 
   /**
-   * Gives the default stream (<tt>std_out</tt>).
+   * Return the default stream (<tt>std_out</tt>).
    */
   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;
 
index 002e8385f99ec8787e59208f9a5f6e65a68741d4..cc6160b1bb6ecfa31dfabac4eb2036933cc8b2b5 100644 (file)
@@ -91,12 +91,12 @@ public:
   void set_numbering(const std::vector<unsigned int> &renumber);
 
   /**
-   * Gives read access to the renumber vector.
+   * Give read access to the renumber vector.
    */
   const std::vector<unsigned int> &get_numbering() const;
 
   /**
-   * Gives read access to the inverse renumber vector.
+   * Give read access to the inverse renumber vector.
    */
   const std::vector<unsigned int> &get_numbering_inverse() const;
 
index c97f5edc5de12b97ed102ff5a38a8c0e5089b68b..40087821c5144833933ceacdf431400055f4b5be 100644 (file)
@@ -473,14 +473,14 @@ protected:
     InternalData ( std::unique_ptr<typename FESystem<dim,spacedim>::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
      * <code>base_no</code>th base element of FESystem's data.
      */
     typename FiniteElement<dim,spacedim>::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
      * <code>base_no</code>th base element will write its output when calling
      * FiniteElement::fill_fe_values() and similar functions.
      */
index 20b9e116d0aaeec6c597dbd5df11f1865a59b9ca..4f8ae614bf028a7a3efd79fc1bbbf8326a4c0e7e 100644 (file)
@@ -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<dim,spacedim>::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<dim,spacedim>::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
      * <code>base_no</code>th base element will write its output when calling
      * FiniteElement::fill_fe_values() and similar functions.
      */
index 9df12411d83bf90ce8ad472b4f2794ecc0a03726..5dadfb5687868a81bca956f87936f47a50503a14 100644 (file)
@@ -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 <tt>(fe2.dofs_per_cell, fe1.dofs_per_cell)</tt>.
    *
@@ -191,7 +191,7 @@ namespace FETools
                            FullMatrix<number> &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
    * <tt>(fe1.dofs_per_cell, fe1.dofs_per_cell)</tt>.
@@ -208,11 +208,11 @@ namespace FETools
                                 FullMatrix<number> &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 <tt>(fe1.dofs_per_cell,
    * fe1.dofs_per_cell)</tt>.
    *
-   * 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
index d7cd760dbd66d98ef1ef9d88aa2c76a0c47f6305..d13e70246bc7225b65a6980ac89a34ec4238f26a 100644 (file)
@@ -271,7 +271,7 @@ public:
   get_new_point_on_quad (const typename Triangulation<dim,spacedim>::quad_iterator &quad) const;
 
   /**
-   * Gives <tt>n=points.size()</tt> points that splits the StraightBoundary
+   * Return <tt>n=points.size()</tt> 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<Point<spacedim> > &points) const;
 
   /**
-   * Gives <tt>n=points.size()=m*m</tt> points that splits the
+   * Return <tt>n=points.size()=m*m</tt> 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
index 053c54ab75ef0d77ac1cb2344cc82f02242c678d..720bbe168cfd00ff0290f3572001ff579ab6d782 100644 (file)
@@ -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;
 
index 8fa63d911e975042ba69deab002d345f1440a7a4..77557847415ca7091ce23dbac109a393226675eb 100644 (file)
@@ -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;
 
index fdc24fced431ff5231238e7a327210b9aeea62e6..55eb3a43316aa2308c85900e5e344b376a4af869 100644 (file)
@@ -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.
    *

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.