* for this case.
*
* @dealiiConceptRequires{
- * concepts::is_triangulation_or_dof_handler<MeshType<dim, spacedim>>}
+ * concepts::is_triangulation_or_dof_handler<MeshType>}
*/
- template <int dim, template <int, int> class MeshType, int spacedim>
- DEAL_II_CXX20_REQUIRES(
- (concepts::is_triangulation_or_dof_handler<MeshType<dim, spacedim>>))
+ template <class MeshType>
+ DEAL_II_CXX20_REQUIRES((concepts::is_triangulation_or_dof_handler<MeshType>))
#ifndef _MSC_VER
- std::vector<typename MeshType<dim, spacedim>::active_cell_iterator>
+ std::vector<typename MeshType::active_cell_iterator>
#else
std::vector<
- typename dealii::internal::
- ActiveCellIterator<dim, spacedim, MeshType<dim, spacedim>>::type>
+ typename dealii::internal::ActiveCellIterator<MeshType::dimension,
+ MeshType::space_dimension,
+ MeshType>::type>
#endif
- find_cells_adjacent_to_vertex(const MeshType<dim, spacedim> &container,
- const unsigned int vertex_index);
+ find_cells_adjacent_to_vertex(const MeshType & container,
+ const unsigned int vertex_index);
/**
* Find an active non-artificial cell that surrounds a given point @p p. The return type
- template <int dim, template <int, int> class MeshType, int spacedim>
- DEAL_II_CXX20_REQUIRES(
- (concepts::is_triangulation_or_dof_handler<MeshType<dim, spacedim>>))
+ template <class MeshType>
+ DEAL_II_CXX20_REQUIRES((concepts::is_triangulation_or_dof_handler<MeshType>))
#ifndef _MSC_VER
- std::vector<typename MeshType<dim, spacedim>::active_cell_iterator>
+ std::vector<typename MeshType::active_cell_iterator>
#else
std::vector<
- typename dealii::internal::
- ActiveCellIterator<dim, spacedim, MeshType<dim, spacedim>>::type>
+ typename dealii::internal::ActiveCellIterator<MeshType::dimension,
+ MeshType::space_dimension,
+ MeshType>::type>
#endif
- find_cells_adjacent_to_vertex(const MeshType<dim, spacedim> &mesh,
- const unsigned int vertex)
+ find_cells_adjacent_to_vertex(const MeshType & mesh,
+ const unsigned int vertex)
{
+ const int dim = MeshType::dimension;
+ const int spacedim = MeshType::space_dimension;
+
// make sure that the given vertex is
// an active vertex of the underlying
// triangulation
// to ensure that cells are inserted only
// once
std::set<typename dealii::internal::
- ActiveCellIterator<dim, spacedim, MeshType<dim, spacedim>>::type>
+ ActiveCellIterator<dim, spacedim, MeshType>::type>
adjacent_cells;
- typename dealii::internal::
- ActiveCellIterator<dim, spacedim, MeshType<dim, spacedim>>::type
- cell = mesh.begin_active(),
- endc = mesh.end();
+ typename dealii::internal::ActiveCellIterator<dim, spacedim, MeshType>::type
+ cell = mesh.begin_active(),
+ endc = mesh.end();
// go through all active cells and look if the vertex is part of that cell
//
Assert(adjacent_cells.size() > 0, ExcInternalError());
// return the result as a vector, rather than the set we built above
- return std::vector<
- typename dealii::internal::
- ActiveCellIterator<dim, spacedim, MeshType<dim, spacedim>>::type>(
+ return std::vector<typename dealii::internal::
+ ActiveCellIterator<dim, spacedim, MeshType>::type>(
adjacent_cells.begin(), adjacent_cells.end());
}