]> https://gitweb.dealii.org/ - dealii.git/commitdiff
more fixup
authorTimo Heister <timo.heister@gmail.com>
Thu, 25 Dec 2014 20:28:50 +0000 (15:28 -0500)
committerMatthias Maier <tamiko@kyomu.43-1.org>
Fri, 26 Dec 2014 12:52:58 +0000 (13:52 +0100)
include/deal.II/dofs/dof_tools.h
include/deal.II/dofs/function_map.h
include/deal.II/fe/fe.h
include/deal.II/grid/grid_in.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/tria_accessor.h
include/deal.II/numerics/fe_field_function.h
include/deal.II/numerics/vector_tools.h

index 15b8b6c5c70b12d15602704672f19f08fdd66e24..e39b71e38c3242b219282e997c38cb98c0e1a21f 100644 (file)
@@ -2018,8 +2018,8 @@ namespace DoFTools
   /**
    * This function is a version of the above map_dofs_to_support_points
    * function that doesn't simply return a vector of support points (see this
-   * @ref GlossSupport "glossary entry") with one entry for each global
-   * degree of freedom, but instead a map that maps from the DoFs index to its
+   * @ref GlossSupport "glossary entry") with one entry for each global degree
+   * of freedom, but instead a map that maps from the DoFs index to its
    * location. The point of this function is that it is also usable in cases
    * where the DoFHandler is based on a parallel::distributed::Triangulation
    * object. In such cases, each processor will not be able to determine the
@@ -2028,8 +2028,7 @@ namespace DoFTools
    * were known. As a consequence, this function constructs a map from those
    * DoFs for which we can know the locations (namely, those DoFs that are
    * locally relevant (see
-   * @ref GlossLocallyRelevantDof "locally relevant DoFs") to their
-   * locations.
+   * @ref GlossLocallyRelevantDof "locally relevant DoFs") to their locations.
    *
    * For non-distributed triangulations, the map returned as @p support_points
    * is of course dense, i.e., every DoF is to be found in it.
index 0e4a27c51d16bdb582f8bc76032b309f2e94858a..e8b489e4c36fe6dbc0c801367063659b06eedb74 100644 (file)
@@ -28,11 +28,11 @@ template <int spacedim, typename Number> class Function;
 /**
  * This class declares a local typedef that denotes a mapping between a
  * boundary indicator (see
- * @ref GlossBoundaryIndicator) that is used to describe what kind of
- * boundary condition holds on a particular piece of the boundary, and the
- * function describing the actual function that provides the boundary values
- * on this part of the boundary. This type is required in many functions in
- * the library where, for example, we need to know about the functions
+ * @ref GlossBoundaryIndicator) that is used to describe what kind of boundary
+ * condition holds on a particular piece of the boundary, and the function
+ * describing the actual function that provides the boundary values on this
+ * part of the boundary. This type is required in many functions in the
+ * library where, for example, we need to know about the functions
  * $h_i(\mathbf x)$ used in boundary conditions @f{align*} \mathbf n \cdot
  * \nabla u = h_i \qquad \qquad \text{on}\ \Gamma_i\subset\partial\Omega. @f}
  * An example is the function KellyErrorEstimator::estimate() that allows us
index a6fd862699a201a56f3fe4fb210c6f27f3085f25..4c6e375dffa24b8d8f6ce3730bb813862028f748 100644 (file)
@@ -1218,8 +1218,7 @@ public:
 
   /**
    * Given a block mask (see
-   * @ref GlossBlockMask "this glossary entry"), produce a component mask
-   * (see
+   * @ref GlossBlockMask "this glossary entry"), produce a component mask (see
    * @ref GlossComponentMask "this glossary entry") that represents the
    * components that correspond to the blocks selected in the input argument.
    * This is essentially a conversion operator from BlockMask to
@@ -1294,8 +1293,7 @@ public:
 
   /**
    * Given a component mask (see
-   * @ref GlossComponentMask "this glossary entry"), produce a block mask
-   * (see
+   * @ref GlossComponentMask "this glossary entry"), produce a block mask (see
    * @ref GlossBlockMask "this glossary entry") that represents the blocks
    * that correspond to the components selected in the input argument. This is
    * essentially a conversion operator from ComponentMask to BlockMask.
index ef0198db806eb30f91bd5d6247ac92700ef5826d..5f56db3c791db37f1f2e436942bccb5874dc0646 100644 (file)
@@ -135,11 +135,11 @@ struct SubCellData;
  * fairly simple to extend it.
  *
  * <li> <tt>Gmsh 1.0 mesh</tt> format: this format is used by the @p GMSH mesh
- * generator (see http://www.geuz.org/gmsh/). The documentation in the @p
- * GMSH manual explains how to generate meshes compatible with the deal.II
- * library (i.e. quads rather than triangles). In order to use this format,
- * Gmsh has to output the file in the old format 1.0. This is done adding the
- * line "Mesh.MshFileVersion = 1" to the input file.
+ * generator (see http://www.geuz.org/gmsh/). The documentation in the @p GMSH
+ * manual explains how to generate meshes compatible with the deal.II library
+ * (i.e. quads rather than triangles). In order to use this format, Gmsh has
+ * to output the file in the old format 1.0. This is done adding the line
+ * "Mesh.MshFileVersion = 1" to the input file.
  *
  * <li> <tt>Gmsh 2.0 mesh</tt> format: this is a variant of the above format.
  * The read_msh() function automatically determines whether an input file is
index 39df08eb6706a3c2087f1507e37ebcfefd475abe..61a306f995ff4b9aaef9832a85c4b9c8d27fcfe4 100644 (file)
@@ -407,8 +407,8 @@ namespace GridTools
    * parallel::distributed::Triangulation object, the cell returned may in
    * fact be a ghost or artificial cell (see
    * @ref GlossArtificialCell and
-   * @ref GlossGhostCell). If so, many of the operations one may want to do
-   * on this cell (e.g., evaluating the solution) may not be possible and you
+   * @ref GlossGhostCell). If so, many of the operations one may want to do on
+   * this cell (e.g., evaluating the solution) may not be possible and you
    * will have to decide what to do in that case.
    */
   template <int dim, template <int,int> class Container, int spacedim>
index 51019d9dd6031eaafc56ed71af357c0bc5dbb7af..3c6a265a1c01d9e6b3ff83ea93269b3b03044beb 100644 (file)
@@ -669,16 +669,15 @@ public:
    * parallel::distributed::Triangulation object. There, refining a mesh
    * always involves a re-partitioning. In other words, vertices of locally
    * owned cells (see
-   * @ref GlossLocallyOwnedCell "this glossary entry") that you may have
-   * moved to a different location on one processor may be moved to a
-   * different processor upon mesh refinement (even if these particular cells
-   * were not refined) which will re-create their position based on the
-   * position of the coarse cells they previously had, not based on the
-   * position these vertices had on the processor that previously owned them.
-   * In other words, in parallel computations, you will probably have to move
-   * nodes explicitly after every mesh refinement because vertex positions may
-   * or may not be preserved across the re-partitioning that accompanies mesh
-   * refinement.
+   * @ref GlossLocallyOwnedCell "this glossary entry") that you may have moved
+   * to a different location on one processor may be moved to a different
+   * processor upon mesh refinement (even if these particular cells were not
+   * refined) which will re-create their position based on the position of the
+   * coarse cells they previously had, not based on the position these
+   * vertices had on the processor that previously owned them. In other words,
+   * in parallel computations, you will probably have to move nodes explicitly
+   * after every mesh refinement because vertex positions may or may not be
+   * preserved across the re-partitioning that accompanies mesh refinement.
    */
   Point<spacedim> &vertex (const unsigned int i) const;
 
index 273b34570b827d81e2b298d9d679dae81a63c86e..8ee9f68940a6d13d0b07d9e8b428440a5306390e 100644 (file)
@@ -112,9 +112,9 @@ namespace Functions
    * that the cell in which this point is found is in fact a ghost or
    * artificial cell (see
    * @ref GlossArtificialCell and
-   * @ref GlossGhostCell). If the cell is artificial, we have no access to
-   * the solution there and functions that evaluate the solution at such a
-   * point will trigger an exception of type
+   * @ref GlossGhostCell). If the cell is artificial, we have no access to the
+   * solution there and functions that evaluate the solution at such a point
+   * will trigger an exception of type
    * FEFieldFunction::ExcPointNotAvailableHere. The same kind of exception
    * will also be produced if the cell is a ghost cell: On such cells, one
    * could in principle evaluate the solution, but it becomes easier if we do
index 1e92508e3430178c19843479ab26c28a14711187..c14a4d1ed6d06be9d8fe6a73f2d92418d3cbfda0 100644 (file)
@@ -906,9 +906,9 @@ namespace VectorTools
    * @param boundary_functions A map from boundary indicators to pointers to
    * functions that describe the desired values on those parts of the boundary
    * marked with this boundary indicator (see
-   * @ref GlossBoundaryIndicator "Boundary indicator"). The projection
-   * happens on only those parts of the boundary whose indicators are
-   * represented in this map.
+   * @ref GlossBoundaryIndicator "Boundary indicator"). The projection happens
+   * on only those parts of the boundary whose indicators are represented in
+   * this map.
    * @param q The face quadrature used in the integration necessary to compute
    * the mass matrix and right hand side of the projection.
    * @param boundary_values The result of this function. It is a map

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.