#include <deal.II/dofs/dof_handler.h>
#include <deal.II/fe/component_mask.h>
-#include <deal.II/fe/fe_values.h>
#include <deal.II/hp/dof_handler.h>
* function unsuitable for the case that the given DoFHandler object derives
* from a parallel::distributed::Triangulation object. Consequently, this
* function will produce an error if called with such a DoFHandler.
+ *
+ * @param mapping The mapping from the reference cell to the real cell on
+ * which DoFs are defined.
+ * @param dof_handler The object that describes which DoF indices live on
+ * which cell of the triangulation.
+ * @param 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 component_mask An optional component mask that restricts the
+ * components from which the support points are extracted.
+ *
*/
template <int dim, int spacedim>
void
* contains the corresponding location in real space coordinates. Previous
* content of this object is deleted in this function.
* @param component_mask An optional component mask that restricts the
- * components from which the support points are extracted
+ * components from which the support points are extracted.
*/
template <int dim, int spacedim>
void
fe_values.get_quadrature_points();
for (unsigned int i = 0; i < cell->get_fe().dofs_per_cell; ++i)
{
- unsigned int dof_comp =
+ const unsigned int dof_comp =
cell->get_fe().system_to_component_index(i).first;
// insert the values into the map if it is a valid component
#if deal_II_dimension == 3
template void DoFTools::map_dofs_to_support_points<1, 3>(
- const Mapping<1, 3> &, const DoFHandler<1, 3> &, std::vector<Point<3>> &,const ComponentMask &);
+ const Mapping<1, 3> &,
+ const DoFHandler<1, 3> &,
+ std::vector<Point<3>> &,
+ const ComponentMask &);
template void DoFTools::count_dofs_per_block<DoFHandler<1, 3>>(
const DoFHandler<1, 3> &,