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">
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">
* @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>
*
* @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
/**
* 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.
* @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().
*
*/
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,
* 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
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>>>
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())
{