static void
map_dofs_to_support_points (const Mapping<dim,spacedim> &mapping,
const DoFHandler<dim,spacedim> &dof_handler,
- std::vector<Point<dim> > &support_points);
+ std::vector<Point<spacedim> > &support_points);
/**
* This is the opposite function
static void
map_support_points_to_dofs (const Mapping<DH::dimension, DH::space_dimension> &mapping,
const DH &dof_handler,
- std::map<Point<DH::dimension>, unsigned int, Comp> &point_to_index_map);
+ std::map<Point<DH::space_dimension>, unsigned int, Comp> &point_to_index_map);
/**
* Map a coupling table from the
DoFTools::map_support_points_to_dofs (
const Mapping<DH::dimension,DH::space_dimension> &mapping,
const DH &dof_handler,
- std::map<Point<DH::dimension>, unsigned int, Comp> &point_to_index_map)
+ std::map<Point<DH::space_dimension>, unsigned int, Comp> &point_to_index_map)
{
// let the checking of arguments be
// done by the function first
// called
- std::vector<Point<DH::dimension> > support_points (dof_handler.n_dofs());
+ std::vector<Point<DH::space_dimension> > support_points (dof_handler.n_dofs());
map_dofs_to_support_points (mapping, dof_handler, support_points);
// now copy over the results of the
// previous function into the
void
DoFTools::map_dofs_to_support_points (const Mapping<dim,spacedim> &mapping,
const DoFHandler<dim,spacedim> &dof_handler,
- std::vector<Point<dim> > &support_points)
+ std::vector<Point<spacedim> > &support_points)
{
const unsigned int dofs_per_cell = dof_handler.get_fe().dofs_per_cell;
// rule are set to invalid values
// by the used constructor.
Quadrature<dim> q_dummy(dof_handler.get_fe().get_unit_support_points());
- FEValues<dim> fe_values (mapping, dof_handler.get_fe(),
- q_dummy, update_quadrature_points);
+ FEValues<dim,spacedim> fe_values (mapping, dof_handler.get_fe(),
+ q_dummy, update_quadrature_points);
typename DoFHandler<dim,spacedim>::active_cell_iterator
cell = dof_handler.begin_active(),
endc = dof_handler.end();
{
fe_values.reinit (cell);
cell->get_dof_indices (local_dof_indices);
- const std::vector<Point<dim> > & points
+ const std::vector<Point<spacedim> > & points
= fe_values.get_quadrature_points ();
for (unsigned int i=0; i<dofs_per_cell; ++i)
support_points[local_dof_indices[i]] = points[i];
const DoFHandler<deal_II_dimension>&,
std::vector<Point<deal_II_dimension> >&);
+#if deal_II_dimension != 3
+
+template
+void
+DoFTools::map_dofs_to_support_points<deal_II_dimension,deal_II_dimension+1>
+(const Mapping<deal_II_dimension,deal_II_dimension+1>&,
+ const DoFHandler<deal_II_dimension, deal_II_dimension+1>&,
+ std::vector<Point<deal_II_dimension+1> >&);
+
+#endif
+
template
void
DoFTools::convert_couplings_to_blocks (