]> https://gitweb.dealii.org/ - dealii.git/commitdiff
doxygen documentation fixes 9464/head
authorTimo Heister <timo.heister@gmail.com>
Sun, 2 Feb 2020 16:01:17 +0000 (11:01 -0500)
committerTimo Heister <timo.heister@gmail.com>
Sun, 2 Feb 2020 16:01:17 +0000 (11:01 -0500)
examples/step-46/doc/results.dox
include/deal.II/dofs/dof_tools.h
include/deal.II/grid/grid_generator.h
include/deal.II/particles/data_out.h
include/deal.II/particles/generators.h
include/deal.II/particles/particle_handler.h
source/particles/generators.cc

index 7b3e46c0fe359a7f36fc663629a022de54bdacef..ed867b0e792225a6715b4c729fb7ba9b1ab45a6e 100644 (file)
@@ -59,7 +59,6 @@ The results are easily visualized:
         Magnitude and vectors for the fluid velocity.
       </p>
     </td>
-
     <td valign="top" align="center">
       <img src="https://www.dealii.org/images/steps/developer/step-46.9.2.pressure-2d.png" alt="">
       <p align="center">
@@ -69,7 +68,6 @@ The results are easily visualized:
         into the fluid domain.
       </p>
     </td>
-
     <td valign="top" align="center">
       <img src="https://www.dealii.org/images/steps/developer/step-46.9.2.displacement-2d.png" alt="">
       <p align="center">
index 9fb8a00b788ca2216963135ebbfda614697882bb..e579caa8745885a03675bcaef11db3f259397607 100644 (file)
@@ -2475,7 +2475,7 @@ namespace DoFTools
    * @param[in,out] support_points A vector that stores the corresponding
    * location of the dofs in real space coordinates. Previous content of this
    * object is deleted in this function.
-   * @param[in] component_mask An optional component mask that restricts the
+   * @param[in] mask An optional component mask that restricts the
    * components from which the support points are extracted.
    */
   template <int dim, int spacedim>
index e1501fa74a0e6f802095a8ef48992ffbc0431c99..a9cf8ac42ca9eab0f49df6a93724d65d0da70850 100644 (file)
@@ -533,8 +533,8 @@ namespace GridGenerator
    *
    * @param corners Second and third vertices of the parallelogram.
    *
-   * @param colorize Assign different boundary ids if true. (see @ref
-   * GlossColorization "the glossary entry on colorization").
+   * @param colorize Assign different boundary ids if true. (see
+   * @ref GlossColorization "the glossary entry on colorization").
    */
   template <int dim>
   void
index c760c88e1a75cc1bfedcad0ace24be13afe9c759..fc1fb78bcf38b27ffbb8ce2cee6994e8141432fc 100644 (file)
@@ -58,7 +58,7 @@ namespace Particles
     /**
      * Build the patches for a given particle handler.
      *
-     * @param [in] particle_handler A particle handler for which the patches will be built.
+     * @param [in] particles A particle handler for which the patches will be built.
      * A dim=0 patch is built for each particle. The position of the particle is
      * used to build the node position and the ID of the particle is added as a
      * single data element.
index e6b10d0c217063bca22f04eda6119c68205e080c..7f0275797aaea1120ad6d0460f3dde92025a6b5c 100644 (file)
@@ -179,8 +179,8 @@ namespace Particles
      * @param[in] dof_handler A DOF handler that may live on another
      * triangulation that is used to establsh the positions of the particles.
      *
-     * @param[in] A vector that contains all the bounding boxes for all
-     * processors. This vector can be established by first using
+     * @param[in] global_bounding_boxes A vector that contains all the bounding
+     * boxes for all processors. This vector can be established by first using
      * 'GridTools::compute_mesh_predicate_bounding_box()' and gathering all the
      * bounding boxes using 'Utilities::MPI::all_gather().
      *
@@ -239,7 +239,7 @@ namespace Particles
      */
     template <int dim, int spacedim = dim>
     void
-    quadrature_points(const Triangulation<dim, spacedim> &particle_tria,
+    quadrature_points(const Triangulation<dim, spacedim> &triangulation,
                       const Quadrature<dim> &             quadrature,
                       const std::vector<std::vector<BoundingBox<spacedim>>>
                         &                             global_bounding_boxes,
index 655566f9acbf12f768b5c3dcce6ccdf534fe9a9f..9d8225c20f1846ca14e7bc726cdbd59fb37ae045 100644 (file)
@@ -252,21 +252,21 @@ namespace Particles
      * function on the calling mpi process, and that falls within the part of
      * triangulation owned by this mpi process.
      *
-     * @param[in] A vector of points that do not need to be on the local
-     * processor, but have to be in the triangulation that is associated with
-     * this ParticleHandler object.
-     *
-     * @param[in] A vector of vectors of bounding boxes. The bounding boxes
-     * `global_bboxes[rk]` describe which part of the mesh is locally owned by
-     * the mpi process with rank `rk`. The local description can be obtained
-     * from GridTools::compute_mesh_predicate_bounding_box(), and the global one
-     * can be obtained by passing the local ones to
+     * @param[in] position A vector of points that do not need to be on the
+     * local processor, but have to be in the triangulation that is associated
+     * with this ParticleHandler object.
+     *
+     * @param[in] global_bounding_boxes A vector of vectors of bounding boxes.
+     * The bounding boxes `global_bboxes[rk]` describe which part of the mesh is
+     * locally owned by the mpi process with rank `rk`. The local description
+     * can be obtained from GridTools::compute_mesh_predicate_bounding_box(),
+     * and the global one can be obtained by passing the local ones to
      * Utilities::MPI::all_gather().
      *
-     * @param[in] (Optional) A vector of vector of properties associated with
-     * each local point. The size of the vector should be either zero (no
-     * properties will be transfered nor attached to the generated particles)
-     * or it should be a vector of `positions.size()` vectors of size
+     * @param[in] properties (Optional) A vector of vector of properties
+     * associated with each local point. The size of the vector should be either
+     * zero (no properties will be transfered nor attached to the generated
+     * particles) or it should be a vector of `positions.size()` vectors of size
      * `n_properties_per_particle()`. Notice that this function call will
      * transfer the properties from the local mpi process to the final mpi
      * process that will own each of the particles, and it may therefore be
index 1ccc31fc712a33a570efed15194526b1fc7f6c36..7bcff62eb102a2b6233d2a9edf514b3f5445a9f0 100644 (file)
@@ -440,7 +440,7 @@ namespace Particles
     template <int dim, int spacedim>
     void
     quadrature_points(
-      const Triangulation<dim, spacedim> &particle_tria,
+      const Triangulation<dim, spacedim> &triangulation,
       const Quadrature<dim> &             quadrature,
       // const std::vector<Point<dim>> &     particle_reference_locations,
       const std::vector<std::vector<BoundingBox<spacedim>>>
@@ -453,7 +453,7 @@ namespace Particles
       std::vector<Point<spacedim>> points_to_generate;
 
       //       Loop through cells and gather gauss points
-      for (const auto &cell : particle_tria.active_cell_iterators())
+      for (const auto &cell : triangulation.active_cell_iterators())
         {
           if (cell->is_locally_owned())
             {

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.