From 27333a4a260457e2ec4cad09c5c52102b15179b2 Mon Sep 17 00:00:00 2001 From: Timo Heister Date: Sun, 2 Feb 2020 11:01:17 -0500 Subject: [PATCH] doxygen documentation fixes --- examples/step-46/doc/results.dox | 2 -- include/deal.II/dofs/dof_tools.h | 2 +- include/deal.II/grid/grid_generator.h | 4 +-- include/deal.II/particles/data_out.h | 2 +- include/deal.II/particles/generators.h | 6 ++--- include/deal.II/particles/particle_handler.h | 26 ++++++++++---------- source/particles/generators.cc | 4 +-- 7 files changed, 22 insertions(+), 24 deletions(-) diff --git a/examples/step-46/doc/results.dox b/examples/step-46/doc/results.dox index 7b3e46c0fe..ed867b0e79 100644 --- a/examples/step-46/doc/results.dox +++ b/examples/step-46/doc/results.dox @@ -59,7 +59,6 @@ The results are easily visualized: Magnitude and vectors for the fluid velocity.

-

@@ -69,7 +68,6 @@ The results are easily visualized: into the fluid domain.

-

diff --git a/include/deal.II/dofs/dof_tools.h b/include/deal.II/dofs/dof_tools.h index 9fb8a00b78..e579caa874 100644 --- a/include/deal.II/dofs/dof_tools.h +++ b/include/deal.II/dofs/dof_tools.h @@ -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 diff --git a/include/deal.II/grid/grid_generator.h b/include/deal.II/grid/grid_generator.h index e1501fa74a..a9cf8ac42c 100644 --- a/include/deal.II/grid/grid_generator.h +++ b/include/deal.II/grid/grid_generator.h @@ -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 void diff --git a/include/deal.II/particles/data_out.h b/include/deal.II/particles/data_out.h index c760c88e1a..fc1fb78bcf 100644 --- a/include/deal.II/particles/data_out.h +++ b/include/deal.II/particles/data_out.h @@ -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. diff --git a/include/deal.II/particles/generators.h b/include/deal.II/particles/generators.h index e6b10d0c21..7f0275797a 100644 --- a/include/deal.II/particles/generators.h +++ b/include/deal.II/particles/generators.h @@ -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 void - quadrature_points(const Triangulation &particle_tria, + quadrature_points(const Triangulation &triangulation, const Quadrature & quadrature, const std::vector>> & global_bounding_boxes, diff --git a/include/deal.II/particles/particle_handler.h b/include/deal.II/particles/particle_handler.h index 655566f9ac..9d8225c20f 100644 --- a/include/deal.II/particles/particle_handler.h +++ b/include/deal.II/particles/particle_handler.h @@ -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 diff --git a/source/particles/generators.cc b/source/particles/generators.cc index 1ccc31fc71..7bcff62eb1 100644 --- a/source/particles/generators.cc +++ b/source/particles/generators.cc @@ -440,7 +440,7 @@ namespace Particles template void quadrature_points( - const Triangulation &particle_tria, + const Triangulation &triangulation, const Quadrature & quadrature, // const std::vector> & particle_reference_locations, const std::vector>> @@ -453,7 +453,7 @@ namespace Particles std::vector> 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()) { -- 2.39.5