20template <
int dim,
int spacedim>
28 Assert(dim == spacedim, ExcNotImplemented(
"Not available with codim > 0"));
29 Assert(dim == 2 || dim == 3, ExcImpossibleInDim(1));
35 "The triangulation must not be empty upon calling this function."));
44template <
int dim,
int spacedim>
49 Assert(cells.size() > 0, ExcMessage(
"No cells to be agglomerated."));
51 if (cells.size() == 1)
57 cells[0]->global_active_cell_index();
63 cells[0]->as_dof_handler_iterator(
agglo_dh);
67 std::vector<typename Triangulation<dim, spacedim>::active_cell_iterator>
69 slaves.reserve(cells.size() - 1);
71 for (
auto it = ++cells.begin(); it != cells.end(); ++it)
73 slaves.push_back(*it);
80 (*it)->as_dof_handler_iterator(
agglo_dh);
85 Assert(((*it)->subdomain_id() ==
tria->locally_owned_subdomain() ||
103 return {cells[0],
this};
108template <
int dim,
int spacedim>
113 Assert(cells.size() > 0, ExcMessage(
"No cells to be agglomerated."));
120 std::vector<std::vector<types::global_cell_index>> connected_components;
125 if (connected_components.size() > 1)
126 std::cout <<
"Disconnected elements. Connected components will be "
127 "computed and agglomerated together."
132 std::vector<typename Triangulation<dim>::active_cell_iterator> agglomerate;
133 for (
const auto &comp : connected_components)
135 agglomerate.reserve(comp.size());
137 agglomerate.push_back(cells[local_idx]);
146template <
int dim,
int spacedim>
161 std::make_unique<FEValues<dim>>(*
mapping,
176template <
int dim,
int spacedim>
181 unsigned int n_neighbors = 0;
182 for (
const auto &f : cell->face_indices())
184 const auto &neighboring_cell = cell->neighbor(f);
185 if ((cell->face(f)->at_boundary()) ||
186 (neighboring_cell->is_active() &&
197template <
int dim,
int spacedim>
202 tria = &cache_tria->get_triangulation();
203 mapping = &cache_tria->get_mapping();
207 if (
const auto parallel_tria =
dynamic_cast<
208 const dealii::parallel::TriangulationBase<dim, spacedim> *
>(&*
tria))
210 const std::weak_ptr<const Utilities::MPI::Partitioner> cells_partitioner =
211 parallel_tria->global_active_cell_index_partitioner();
213 cells_partitioner.lock()->locally_owned_range(),
communicator);
224 cached_tria = std::make_unique<GridTools::Cache<dim, spacedim>>(
225 cache_tria->get_triangulation(), cache_tria->get_mapping());
233template <
int dim,
int spacedim>
239 fe = std::make_unique<FE_DGQ<dim>>(fe_space.
degree);
241 fe = std::make_unique<FE_AggloDGP<dim>>(fe_space.
degree);
243 fe = std::make_unique<FE_SimplexDGP<dim>>(fe_space.
degree);
248 "Currently, this interface supports only DGQ and DGP bases."));
261 std::make_unique<ScratchData>(*
mapping,
268 fe_collection.push_back(*fe);
269 fe_collection.push_back(
276 const bool needs_ghost_info =
279 if (needs_ghost_info)
284 if (needs_ghost_info)
290template <
int dim,
int spacedim>
296 ExcMessage(
"No agglomeration has been performed."));
297 Assert(dim > 1, ExcNotImplemented());
299 std::vector<Point<spacedim>> pts;
300 for (
const auto &cell : polytope)
301 for (
const auto i : cell->vertex_indices())
302 pts.push_back(cell->vertex(i));
309template <
int dim,
int spacedim>
314 ExcMessage(
"No agglomeration has been performed."));
318 "The DoFHandler associated to the agglomeration has not been initialized."
319 "It's likely that you forgot to distribute the DoFs. You may want"
320 "to check if a call to `initialize_hp_structure()` has been done."));
345template <
int dim,
int spacedim>
349 const unsigned int dofs_per_cell =
fe->dofs_per_cell;
352 if (polytope->is_locally_owned())
354 const unsigned int n_faces = polytope->n_faces();
355 for (
unsigned int f = 0; f < n_faces; ++f)
357 if (!polytope->at_boundary(f))
359 const auto &neigh_polytope = polytope->neighbor(f);
360 if (!neigh_polytope->is_locally_owned())
365 const auto ¤t_fe =
reinit(polytope, f);
367 std::vector<Point<spacedim>> qpoints_to_send =
368 current_fe.get_quadrature_points();
370 const std::vector<double> &jxws_to_send =
371 current_fe.get_JxW_values();
373 const std::vector<Tensor<1, spacedim>> &normals_to_send =
374 current_fe.get_normal_vectors();
378 neigh_polytope->subdomain_id();
380 std::pair<CellId, unsigned int> cell_and_face{
393 const unsigned int n_qpoints = qpoints_to_send.size();
397 std::vector<std::vector<double>> values_per_qpoints(
400 std::vector<std::vector<Tensor<1, spacedim>>>
401 gradients_per_qpoints(dofs_per_cell);
403 for (
unsigned int i = 0; i < dofs_per_cell; ++i)
405 values_per_qpoints[i].resize(n_qpoints);
406 gradients_per_qpoints[i].resize(n_qpoints);
407 for (
unsigned int q = 0; q < n_qpoints; ++q)
409 values_per_qpoints[i][q] =
410 current_fe.shape_value(i, q);
411 gradients_per_qpoints[i][q] =
412 current_fe.shape_grad(i, q);
419 cell_and_face, gradients_per_qpoints);
436template <
int dim,
int spacedim>
445 ExcMessage(
"This must be a master cell."));
447 std::vector<Point<dim>> vec_pts;
448 std::vector<double> vec_JxWs;
449 for (
const auto &dummy_cell : cells)
452 auto q_points =
no_values->get_quadrature_points();
453 const auto &JxWs =
no_values->get_JxW_values();
455 std::transform(q_points.begin(),
457 std::back_inserter(vec_pts),
459 std::transform(JxWs.begin(),
461 std::back_inserter(vec_JxWs),
462 [&](
const double w) { return w; });
467 std::vector<Point<dim>> unit_points(vec_pts.size());
470 unit_points.reserve(vec_pts.size());
472 for (
unsigned int i = 0; i < vec_pts.size(); i++)
473 unit_points[i] = bbox.real_to_unit(vec_pts[i]);
480template <
int dim,
int spacedim>
486 "Triangulation must not be empty upon calling this function."));
488 ExcMessage(
"No agglomeration has been performed."));
498template <
int dim,
int spacedim>
528template <
int dim,
int spacedim>
532 const unsigned int face_index,
534 &agglo_isv_ptr)
const
542template <
int dim,
int spacedim>
546 const unsigned int face_index)
const
562template <
int dim,
int spacedim>
563std::pair<const FEValuesBase<dim, spacedim> &,
568 const unsigned int local_in,
569 const unsigned int local_neigh)
const
577 const auto &neigh_cell =
586 std::pair<const FEValuesBase<dim, spacedim> &,
602 const unsigned int neigh_rank = neigh_polytope->
subdomain_id();
603 const CellId &neigh_id = neigh_polytope->
id();
607 std::vector<Point<spacedim>> &real_qpoints =
608 recv_qpoints.at(neigh_rank).at({neigh_id, local_neigh});
610 const auto &JxWs = recv_jxws.at(neigh_rank).at({neigh_id, local_neigh});
612 std::vector<Tensor<1, spacedim>> &normals =
613 recv_normals.at(neigh_rank).at({neigh_id, local_neigh});
616 std::vector<Point<spacedim>> final_unit_q_points;
617 std::transform(real_qpoints.begin(),
619 std::back_inserter(final_unit_q_points),
621 return bbox.real_to_unit(p);
643 for (
unsigned int q = 0; q < final_unit_q_points.size(); ++q)
648 final_unit_q_points, JxWs, normals);
651 std::make_unique<NonMatching::FEImmersedSurfaceValues<spacedim>>(
657 std::pair<const FEValuesBase<dim, spacedim> &,
667template <
int dim,
int spacedim>
668template <
typename SparsityPatternType,
typename Number>
671 SparsityPatternType &dsp,
673 const bool keep_constrained_dofs,
677 ExcMessage(
"The agglomeration has not been set up correctly."));
680 "The Sparsity pattern must be empty upon calling this function."));
683 const IndexSet locally_relevant_dofs =
686 if constexpr (std::is_same_v<SparsityPatternType, DynamicSparsityPattern>)
687 dsp.reinit(locally_owned_dofs.
size(),
688 locally_owned_dofs.
size(),
689 locally_relevant_dofs);
690 else if constexpr (std::is_same_v<SparsityPatternType,
699 agglo_dh, dsp, constraints, keep_constrained_dofs, subdomain_id);
702 const unsigned int dofs_per_cell =
agglo_dh.get_fe(0).n_dofs_per_cell();
703 std::vector<types::global_dof_index> current_dof_indices(dofs_per_cell);
704 std::vector<types::global_dof_index> neighbor_dof_indices(dofs_per_cell);
710 if (polytope->is_locally_owned())
712 const unsigned int n_current_faces = polytope->n_faces();
713 polytope->get_dof_indices(current_dof_indices);
714 for (
unsigned int f = 0; f < n_current_faces; ++f)
716 const auto &neigh_polytope = polytope->
neighbor(f);
721 neighbor_dof_indices,
723 keep_constrained_dofs,
732 if constexpr (std::is_same_v<SparsityPatternType,
739template <
int dim,
int spacedim>
743 [[maybe_unused]]
const auto parallel_triangulation =
745 Assert(parallel_triangulation !=
nullptr, ExcInternalError());
748 std::vector<types::global_dof_index> global_dof_indices(
n_dofs_per_cell);
750 if (polytope->is_locally_owned())
752 const CellId &master_cell_id = polytope->id();
754 const auto polytope_dh = polytope->as_dof_handler_iterator(
agglo_dh);
755 polytope_dh->get_dof_indices(global_dof_indices);
758 const auto &agglomerate = polytope->get_agglomerate();
760 for (
const auto &cell : agglomerate)
763 for (
const auto &f : cell->face_indices())
765 if (!cell->at_boundary(f))
767 const auto &neighbor = cell->neighbor(f);
768 if (neighbor->is_ghost())
772 neighbor->subdomain_id();
777 cell->id(), master_cell_id);
782 master_cell_id, global_dof_indices);
785 const auto &bbox =
bboxes[polytope->index()];
812 template <
int dim,
int spacedim>
819 const unsigned int face_index,
825 ExcMessage(
"This cell must be a master one."));
828 const auto &neigh_polytope = it->
neighbor(face_index);
830 const CellId polytope_in_id = cell->id();
838 polytope_out_id = neigh_polytope->
id();
840 polytope_out_id = polytope_in_id;
843 {polytope_in_id, polytope_out_id});
845 std::vector<Point<spacedim>> final_unit_q_points;
846 std::vector<double> final_weights;
847 std::vector<Tensor<1, dim>> final_normals;
849 const unsigned int expected_qpoints =
851 final_unit_q_points.reserve(expected_qpoints);
852 final_weights.reserve(expected_qpoints);
853 final_normals.reserve(expected_qpoints);
856 for (
const auto &[deal_cell, local_face_idx] : common_face)
860 const auto &q_points =
863 const auto &normals = handler.
no_face_values->get_normal_vectors();
865 const unsigned int n_qpoints_agglo = q_points.size();
867 for (
unsigned int q = 0; q < n_qpoints_agglo; ++q)
869 final_unit_q_points.push_back(bbox.real_to_unit(q_points[q]));
870 final_weights.push_back(JxWs[q]);
871 final_normals.push_back(normals[q]);
876 final_unit_q_points, final_weights, final_normals);
879 std::make_unique<NonMatching::FEImmersedSurfaceValues<spacedim>>(
885 agglo_isv_ptr->reinit(cell);
887 return *agglo_isv_ptr;
906 ->global_active_cell_index()] ==
908 ExcMessage(
"The present cell with index " +
909 std::to_string(master_cell->global_active_cell_index()) +
910 "is not a master one."));
916 CellId current_polytope_id = master_cell->id();
919 std::set<types::global_cell_index> visited_polygonal_neighbors;
921 std::map<unsigned int, CellId> face_to_neigh_id;
923 std::map<unsigned int, bool> is_face_at_boundary;
926 std::set<CellId> visited_polygonal_neighbors_id;
927 unsigned int ghost_counter = 0;
929 for (
const auto &cell : agglomeration)
932 cell->active_cell_index();
934 const CellId cell_id = cell->id();
936 for (
const auto f : cell->face_indices())
938 const auto &neighboring_cell = cell->neighbor(f);
940 const bool valid_neighbor =
945 if (neighboring_cell->is_locally_owned() &&
971 neighboring_cell->active_cell_index();
974 const auto &master_of_neighbor =
976 neighboring_cell_index);
978 const auto nof = cell->neighbor_of_neighbor(f);
984 neighbor_polytope_index =
986 master_of_neighbor->active_cell_index());
988 CellId neighbor_polytope_id =
989 master_of_neighbor->id();
991 if (visited_polygonal_neighbors.find(
992 neighbor_polytope_index) ==
993 std::end(visited_polygonal_neighbors))
997 const unsigned int n_face =
999 [current_polytope_index];
1002 current_polytope_index, n_face}] = {
1003 false, master_of_neighbor};
1005 is_face_at_boundary[n_face] =
true;
1008 [current_polytope_index];
1010 visited_polygonal_neighbors.insert(
1011 neighbor_polytope_index);
1016 .find({cell_index, f}) ==
1018 .visited_cell_and_faces))
1022 current_polytope_id, neighbor_polytope_id}]
1023 .emplace_back(cell, f);
1031 .find({neighboring_cell_index, nof}) ==
1033 .visited_cell_and_faces))
1037 neighbor_polytope_id, current_polytope_id}]
1038 .emplace_back(neighboring_cell, nof);
1041 .insert({neighboring_cell_index, nof});
1050 neighbor_polytope_index =
1052 neighboring_cell_index);
1054 CellId neighbor_polytope_id =
1055 neighboring_cell->id();
1057 if (visited_polygonal_neighbors.find(
1058 neighbor_polytope_index) ==
1059 std::end(visited_polygonal_neighbors))
1062 const unsigned int n_face =
1064 [current_polytope_index];
1068 current_polytope_index, n_face}] = {
1069 false, neighboring_cell};
1071 is_face_at_boundary[n_face] =
true;
1074 [current_polytope_index];
1076 visited_polygonal_neighbors.insert(
1077 neighbor_polytope_index);
1083 .find({cell_index, f}) ==
1085 .visited_cell_and_faces))
1089 current_polytope_id, neighbor_polytope_id}]
1090 .emplace_back(cell, f);
1097 .find({neighboring_cell_index, nof}) ==
1099 .visited_cell_and_faces))
1103 neighbor_polytope_id, current_polytope_id}]
1104 .emplace_back(neighboring_cell, nof);
1107 .insert({neighboring_cell_index, nof});
1111 else if (neighboring_cell->is_ghost())
1113 const auto nof = cell->neighbor_of_neighbor(f);
1120 const auto &check_neigh_poly_ids =
1122 neighboring_cell->subdomain_id());
1124 const CellId neighboring_cell_id =
1125 neighboring_cell->id();
1127 const CellId &check_neigh_polytope_id =
1128 check_neigh_poly_ids.at(neighboring_cell_id);
1133 if (visited_polygonal_neighbors_id.find(
1134 check_neigh_polytope_id) ==
1135 std::end(visited_polygonal_neighbors_id))
1138 current_polytope_index,
1140 [current_polytope_index]}] = {
false,
1146 current_polytope_id,
1148 [current_polytope_index]}] =
1149 check_neigh_polytope_id;
1152 const unsigned int n_face =
1154 [current_polytope_index];
1156 face_to_neigh_id[n_face] = check_neigh_polytope_id;
1158 is_face_at_boundary[n_face] =
false;
1163 [current_polytope_index];
1165 visited_polygonal_neighbors_id.insert(
1166 check_neigh_polytope_id);
1176 .find({cell_id, f}) ==
1182 current_polytope_id, check_neigh_polytope_id}]
1183 .emplace_back(cell, f);
1193 .insert({cell_id, f});
1198 .find({neighboring_cell_id, nof}) ==
1204 check_neigh_polytope_id, current_polytope_id}]
1205 .emplace_back(neighboring_cell, nof);
1208 .insert({neighboring_cell_id, nof});
1212 else if (cell->face(f)->at_boundary())
1220 if (visited_polygonal_neighbors.find(
1221 std::numeric_limits<unsigned int>::max()) ==
1222 std::end(visited_polygonal_neighbors))
1227 current_polytope_index,
1229 [current_polytope_index]}] = {
true,
1232 const unsigned int n_face =
1234 [current_polytope_index];
1236 is_face_at_boundary[n_face] =
true;
1239 [current_polytope_index];
1241 visited_polygonal_neighbors.insert(
1242 std::numeric_limits<unsigned int>::max());
1253 current_polytope_id, current_polytope_id}]
1254 .emplace_back(cell, f);
1265 if (ghost_counter > 0)
1267 const auto parallel_triangulation =
dynamic_cast<
1268 const dealii::parallel::TriangulationBase<dim, spacedim> *
>(
1271 const unsigned int n_faces_current_poly =
1277 for (
const unsigned int neigh_rank :
1278 parallel_triangulation->ghost_owners())
1280 handler.
local_n_faces[neigh_rank].emplace(current_polytope_id,
1281 n_faces_current_poly);
1284 current_polytope_id, is_face_at_boundary);
1287 current_polytope_id, face_to_neigh_id);
1305 const bool keep_constrained_dofs,
1312 const bool keep_constrained_dofs,
1320 const bool keep_constrained_dofs,
1327 const bool keep_constrained_dofs,
1335 const bool keep_constrained_dofs,
1342 const bool keep_constrained_dofs,
void add_entries_local_to_global(const std::vector< size_type > &local_dof_indices, SparsityPatternBase &sparsity_pattern, const bool keep_constrained_entries=true, const Table< 2, bool > &dof_mask=Table< 2, bool >()) const
const unsigned int degree
unsigned int size() const
AgglomerationContainer get_agglomerate() const
bool is_locally_owned() const
const AgglomerationIterator< dim, spacedim > neighbor(const unsigned int f) const
DoFHandler< dim, spacedim >::active_cell_iterator as_dof_handler_iterator(const DoFHandler< dim, spacedim > &dof_handler) const
void get_dof_indices(std::vector< types::global_dof_index > &) const
types::subdomain_id subdomain_id() const
unsigned int n_dofs_per_cell() const noexcept
AgglomerationHandler()=default
std::map< types::subdomain_id, std::map< CellId, unsigned int > > local_n_faces
std::unique_ptr< GridTools::Cache< dim, spacedim > > cached_tria
LinearAlgebra::distributed::Vector< float > master_slave_relationships
std::map< types::subdomain_id, std::map< std::pair< CellId, unsigned int >, std::vector< Tensor< 1, spacedim > > > > local_normals
const FEValues< dim, spacedim > & reinit(const AgglomerationIterator< dim, spacedim > &polytope) const
std::map< types::subdomain_id, std::map< CellId, CellId > > recv_cell_ids_neigh_cell
FE_Nothing< dim, spacedim > dummy_fe
std::unique_ptr< NonMatching::FEImmersedSurfaceValues< spacedim > > agglomerated_isv_bdary
bool is_slave_cell(const CellIterator &cell) const
std::map< types::subdomain_id, std::map< CellId, std::map< unsigned int, bool > > > local_bdary_info
std::map< types::subdomain_id, std::map< std::pair< CellId, unsigned int >, std::vector< std::vector< double > > > > local_values
std::unique_ptr< NonMatching::FEImmersedSurfaceValues< spacedim > > agglomerated_isv
std::unique_ptr< ScratchData > standard_scratch
Quadrature< dim > agglomeration_quad
std::map< types::subdomain_id, std::map< std::pair< CellId, unsigned int >, std::vector< double > > > recv_jxws
std::map< types::subdomain_id, std::map< std::pair< CellId, unsigned int >, std::vector< Tensor< 1, spacedim > > > > recv_normals
Quadrature< dim - 1 > agglomeration_face_quad
std::unique_ptr< FEValues< dim, spacedim > > no_values
std::map< types::subdomain_id, std::map< CellId, unsigned int > > recv_n_faces
std::vector< BoundingBox< spacedim > > bboxes
void exchange_interface_values()
SmartPointer< const Triangulation< dim, spacedim > > tria
std::map< types::subdomain_id, std::map< CellId, BoundingBox< dim > > > recv_ghosted_bbox
bool are_cells_agglomerated(const typename Triangulation< dim, spacedim >::active_cell_iterator &cell, const typename Triangulation< dim, spacedim >::active_cell_iterator &other_cell) const
unsigned int n_agglomerations
Quadrature< dim > agglomerated_quadrature(const AgglomerationContainer &cells, const typename Triangulation< dim, spacedim >::active_cell_iterator &master_cell) const
AgglomerationIterator< dim, spacedim > agglomeration_iterator
std::map< const typename Triangulation< dim, spacedim >::active_cell_iterator, std::vector< typename Triangulation< dim >::active_face_iterator > > polygon_boundary
std::unordered_map< types::global_cell_index, std::vector< typename Triangulation< dim, spacedim >::active_cell_iterator > > master2slaves
void create_bounding_box(const AgglomerationContainer &polytope)
std::map< types::global_cell_index, types::global_cell_index > master2polygon
typename AgglomerationIterator< dim, spacedim >::AgglomerationContainer AgglomerationContainer
std::map< types::subdomain_id, std::map< std::pair< CellId, unsigned int >, std::vector< Point< spacedim > > > > recv_qpoints
std::pair< const FEValuesBase< dim, spacedim > &, const FEValuesBase< dim, spacedim > & > reinit_interface(const AgglomerationIterator< dim, spacedim > &polytope_in, const AgglomerationIterator< dim, spacedim > &neigh_polytope, const unsigned int local_in, const unsigned int local_outside) const
const MPI_Comm communicator
std::map< types::subdomain_id, std::map< CellId, std::vector< types::global_dof_index > > > recv_ghost_dofs
void setup_connectivity_of_agglomeration()
std::map< types::subdomain_id, std::map< std::pair< CellId, unsigned int >, std::vector< std::vector< Tensor< 1, spacedim > > > > > recv_gradients
const Triangulation< dim, spacedim > & get_triangulation() const
void create_agglomeration_sparsity_pattern(SparsityPatternType &sparsity_pattern, const AffineConstraints< Number > &constraints=AffineConstraints< Number >(), const bool keep_constrained_dofs=true, const types::subdomain_id subdomain_id=numbers::invalid_subdomain_id)
const Mapping< dim > & get_mapping() const
void setup_ghost_polytopes()
std::map< types::global_cell_index, typename Triangulation< dim, spacedim >::active_cell_iterator > master_slave_relationships_iterators
std::vector< typename Triangulation< dim, spacedim >::active_cell_iterator > get_agglomerate(const typename Triangulation< dim, spacedim >::active_cell_iterator &master_cell) const
unsigned int n_agglomerated_faces_per_cell(const typename Triangulation< dim, spacedim >::active_cell_iterator &cell) const
const UpdateFlags internal_agglomeration_face_flags
std::map< types::subdomain_id, std::map< std::pair< CellId, unsigned int >, std::vector< std::vector< Tensor< 1, spacedim > > > > > local_gradients
void distribute_agglomerated_dofs(const FiniteElement< dim > &fe_space)
std::vector< types::global_cell_index > number_of_agglomerated_faces
const UpdateFlags internal_agglomeration_flags
std::map< types::subdomain_id, std::map< CellId, std::map< unsigned int, bool > > > recv_bdary_info
void connect_to_tria_signals()
std::unique_ptr< FEFaceValues< dim, spacedim > > no_face_values
const FEValuesBase< dim, spacedim > & reinit_master(const typename DoFHandler< dim, spacedim >::active_cell_iterator &cell, const unsigned int face_number, std::unique_ptr< NonMatching::FEImmersedSurfaceValues< spacedim > > &agglo_isv_ptr) const
std::map< types::subdomain_id, std::map< CellId, std::vector< types::global_dof_index > > > local_ghost_dofs
std::vector< typename Triangulation< dim, spacedim >::active_cell_iterator > master_cells_container
friend class AgglomerationIterator
std::map< types::subdomain_id, std::map< std::pair< CellId, unsigned int >, std::vector< std::vector< double > > > > recv_values
bool is_master_cell(const CellIterator &cell) const
IteratorRange< agglomeration_iterator > polytope_iterators() const
void initialize_agglomeration_data(const std::unique_ptr< GridTools::Cache< dim, spacedim > > &cache_tria)
agglomeration_iterator define_agglomerate(const AgglomerationContainer &cells)
std::map< types::subdomain_id, std::map< std::pair< CellId, unsigned int >, std::vector< double > > > local_jxws
void initialize_fe_values(const Quadrature< dim > &cell_quadrature=QGauss< dim >(1), const UpdateFlags &flags=UpdateFlags::update_default, const Quadrature< dim - 1 > &face_quadrature=QGauss< dim - 1 >(1), const UpdateFlags &face_flags=UpdateFlags::update_default)
std::map< types::subdomain_id, std::map< std::pair< CellId, unsigned int >, std::vector< Point< spacedim > > > > local_qpoints
std::unique_ptr< NonMatching::FEImmersedSurfaceValues< spacedim > > agglomerated_isv_neigh
void define_agglomerate_with_check(const AgglomerationContainer &cells)
std::unique_ptr< ScratchData > agglomerated_scratch
UpdateFlags agglomeration_face_flags
hp::FECollection< dim, spacedim > fe_collection
std::map< types::subdomain_id, std::map< CellId, BoundingBox< dim > > > local_ghosted_bbox
DoFHandler< dim, spacedim > agglo_dh
void initialize_hp_structure()
std::unique_ptr< MappingBox< dim > > box_mapping
std::unique_ptr< FiniteElement< dim > > fe
UpdateFlags agglomeration_flags
std::map< types::subdomain_id, std::map< CellId, std::map< unsigned int, CellId > > > recv_ghosted_master_id
SmartPointer< const Mapping< dim, spacedim > > mapping
std::map< types::subdomain_id, std::map< CellId, CellId > > local_cell_ids_neigh_cell
internal::PolytopeCache< dim, spacedim > polytope_cache
std::map< types::subdomain_id, std::map< CellId, std::map< unsigned int, CellId > > > local_ghosted_master_id
IteratorState::IteratorStates state() const
static void setup_master_neighbor_connectivity(const typename Triangulation< dim, spacedim >::active_cell_iterator &master_cell, const AgglomerationHandler< dim, spacedim > &handler)
static const FEValuesBase< dim, spacedim > & reinit_master(const typename DoFHandler< dim, spacedim >::active_cell_iterator &cell, const unsigned int face_index, std::unique_ptr< NonMatching::FEImmersedSurfaceValues< spacedim > > &agglo_isv_ptr, const AgglomerationHandler< dim, spacedim > &handler)
#define Assert(cond, exc)
#define AssertThrow(cond, exc)
void make_sparsity_pattern(const DoFHandler< dim, spacedim > &dof_handler, SparsityPatternBase &sparsity_pattern, const AffineConstraints< number > &constraints={}, const bool keep_constrained_dofs=true, const types::subdomain_id subdomain_id=numbers::invalid_subdomain_id)
Tensor< 2, dim, Number > w(const Tensor< 2, dim, Number > &F, const Tensor< 2, dim, Number > &dF_dt)
std::map< unsigned int, T > some_to_some(const MPI_Comm comm, const std::map< unsigned int, T > &objects_to_send)
void create_graph_from_agglomerate(const std::vector< typename Triangulation< dim >::active_cell_iterator > &cells, Graph &g)
void compute_connected_components(Graph &g, std::vector< std::vector< types::global_cell_index > > &connected_components)
constexpr types::subdomain_id invalid_subdomain_id
unsigned int subdomain_id
unsigned int global_cell_index