16#ifndef dealii_face_setup_internal_h
17#define dealii_face_setup_internal_h
41 namespace MatrixFreeFunctions
83 const unsigned int mg_level,
84 const bool hold_all_faces_to_owned_cells,
85 const bool build_inner_faces,
86 std::vector<std::pair<unsigned int, unsigned int>> &cell_levels);
97 const std::vector<std::pair<unsigned int, unsigned int>> &cell_levels,
108 const unsigned int face_no,
109 const typename ::Triangulation<dim>::cell_iterator &cell,
110 const unsigned int number_cell_interior,
111 const typename ::Triangulation<dim>::cell_iterator &neighbor,
112 const unsigned int number_cell_exterior,
113 const bool is_mixed_mesh);
143 template <
int vectorization_w
idth>
147 const std::vector<bool> &hard_vectorization_boundary,
148 std::vector<unsigned int> &face_partition_data,
159 : use_active_cells(true)
166 FaceSetup<dim>::initialize(
168 const unsigned int mg_level,
169 const bool hold_all_faces_to_owned_cells,
170 const bool build_inner_faces,
171 std::vector<std::pair<unsigned int, unsigned int>> &cell_levels)
178 if (use_active_cells)
179 for (
const auto &cell_level : cell_levels)
181 typename ::Triangulation<dim>::cell_iterator dcell(
190 at_processor_boundary.resize(cell_levels.size(),
false);
193 FaceCategory::locally_active_done_elsewhere);
197 std::map<types::subdomain_id, FaceIdentifier>
198 inner_faces_at_proc_boundary;
204 for (
unsigned int i = 0; i < cell_levels.size(); ++i)
206 if (i > 0 && cell_levels[i] == cell_levels[i - 1])
208 typename ::Triangulation<dim>::cell_iterator dcell(
210 for (
const unsigned int f : dcell->face_indices())
212 if (dcell->at_boundary(f) && !dcell->has_periodic_neighbor(f))
214 typename ::Triangulation<dim>::cell_iterator neighbor =
215 dcell->neighbor_or_periodic_neighbor(f);
221 const CellId id_mine = dcell->id();
222 if (use_active_cells && neighbor->has_children())
223 for (
unsigned int c = 0;
224 c < (dcell->has_periodic_neighbor(f) ?
225 dcell->periodic_neighbor(f)
226 ->face(dcell->periodic_neighbor_face_no(f))
228 dcell->face(f)->n_children());
231 typename ::Triangulation<dim>::cell_iterator
233 dcell->at_boundary(f) ?
234 dcell->periodic_neighbor_child_on_subface(f, c) :
235 dcell->neighbor_child_on_subface(f, c);
237 neighbor_c->subdomain_id();
238 if (my_domain < neigh_domain)
239 inner_faces_at_proc_boundary[neigh_domain]
240 .n_hanging_faces_larger_subdomain++;
241 else if (my_domain > neigh_domain)
242 inner_faces_at_proc_boundary[neigh_domain]
243 .n_hanging_faces_smaller_subdomain++;
248 use_active_cells ? neighbor->subdomain_id() :
249 neighbor->level_subdomain_id();
250 if (neighbor->level() < dcell->level() &&
253 if (my_domain < neigh_domain)
254 inner_faces_at_proc_boundary[neigh_domain]
255 .n_hanging_faces_smaller_subdomain++;
256 else if (my_domain > neigh_domain)
257 inner_faces_at_proc_boundary[neigh_domain]
258 .n_hanging_faces_larger_subdomain++;
260 else if (neighbor->level() == dcell->level() &&
261 my_domain != neigh_domain)
267 const CellId id_neigh = neighbor->id();
268 if (my_domain < neigh_domain)
269 inner_faces_at_proc_boundary[neigh_domain]
270 .shared_faces.emplace_back(id_mine, id_neigh);
272 inner_faces_at_proc_boundary[neigh_domain]
273 .shared_faces.emplace_back(id_neigh, id_mine);
282 for (
auto &inner_face : inner_faces_at_proc_boundary)
284 Assert(inner_face.first != my_domain,
286 std::sort(inner_face.second.shared_faces.begin(),
287 inner_face.second.shared_faces.end());
288 inner_face.second.shared_faces.erase(
289 std::unique(inner_face.second.shared_faces.begin(),
290 inner_face.second.shared_faces.end()),
291 inner_face.second.shared_faces.end());
296# if defined(DEAL_II_WITH_MPI) && defined(DEBUG)
298 if (const ::parallel::TriangulationBase<dim> *ptria =
299 dynamic_cast<const ::parallel::TriangulationBase<dim>
301 comm = ptria->get_mpi_communicator();
304 unsigned int mysize = inner_face.second.shared_faces.size();
307 int ierr = MPI_Sendrecv(&mysize,
316 600 + inner_face.first,
321 mysize = inner_face.second.n_hanging_faces_smaller_subdomain;
322 ierr = MPI_Sendrecv(&mysize,
331 700 + inner_face.first,
336 mysize = inner_face.second.n_hanging_faces_larger_subdomain;
337 ierr = MPI_Sendrecv(&mysize,
346 800 + inner_face.first,
368 std::vector<std::tuple<CellId, CellId, unsigned int>> other_range(
369 inner_face.second.shared_faces.size());
370 for (
unsigned int i = 0; i < other_range.size(); ++i)
372 std::make_tuple(inner_face.second.shared_faces[i].second,
373 inner_face.second.shared_faces[i].first,
375 std::sort(other_range.begin(), other_range.end());
383 unsigned int n_faces_lower_proc = 0, n_faces_higher_proc = 0;
384 std::vector<signed char> assignment(other_range.size(), 0);
385 if (inner_face.second.shared_faces.size() > 0)
389 unsigned int count = 0;
390 for (
unsigned int i = 1;
391 i < inner_face.second.shared_faces.size();
393 if (inner_face.second.shared_faces[i].first ==
394 inner_face.second.shared_faces[i - 1 - count].first)
401 for (
unsigned int k = 0; k <= count; ++k)
402 assignment[i - 1 - k] = 1;
403 n_faces_higher_proc += count + 1;
413 for (
unsigned int i = 1; i < other_range.size(); ++i)
414 if (std::get<0>(other_range[i]) ==
415 std::get<0>(other_range[i - 1 - count]))
422 for (
unsigned int k = 0; k <= count; ++k)
425 .shared_faces[std::get<2>(
429 .shared_faces[std::get<2>(
430 other_range[i - 1 - k])]
435 if (assignment[std::get<2>(
436 other_range[i - 1 - k])] == 0)
438 assignment[std::get<2>(
439 other_range[i - 1 - k])] = -1;
440 ++n_faces_lower_proc;
454 n_faces_lower_proc +=
455 inner_face.second.n_hanging_faces_smaller_subdomain;
456 n_faces_higher_proc +=
457 inner_face.second.n_hanging_faces_larger_subdomain;
458 const unsigned int n_total_faces_at_proc_boundary =
459 (inner_face.second.shared_faces.size() +
460 inner_face.second.n_hanging_faces_smaller_subdomain +
461 inner_face.second.n_hanging_faces_larger_subdomain);
462 unsigned int split_index = n_total_faces_at_proc_boundary / 2;
463 if (split_index < n_faces_lower_proc)
465 else if (split_index <
466 n_total_faces_at_proc_boundary - n_faces_higher_proc)
467 split_index -= n_faces_lower_proc;
469 split_index = n_total_faces_at_proc_boundary -
470 n_faces_higher_proc - n_faces_lower_proc;
473# if defined(DEAL_II_WITH_MPI) && defined(DEBUG)
474 ierr = MPI_Sendrecv(&split_index,
483 900 + inner_face.first,
488 ierr = MPI_Sendrecv(&n_faces_lower_proc,
497 1000 + inner_face.first,
502 ierr = MPI_Sendrecv(&n_faces_higher_proc,
511 1100 + inner_face.first,
519 std::vector<std::pair<CellId, CellId>> owned_faces_lower,
521 for (
unsigned int i = 0; i < assignment.size(); ++i)
522 if (assignment[i] < 0)
523 owned_faces_lower.push_back(
524 inner_face.second.shared_faces[i]);
525 else if (assignment[i] > 0)
526 owned_faces_higher.push_back(
527 inner_face.second.shared_faces[i]);
529 inner_face.second.shared_faces.size() + 1 -
530 owned_faces_lower.size() -
531 owned_faces_higher.size());
533 unsigned int i = 0, c = 0;
534 for (; i < assignment.size() && c < split_index; ++i)
535 if (assignment[i] == 0)
537 owned_faces_lower.push_back(
538 inner_face.second.shared_faces[i]);
541 for (; i < assignment.size(); ++i)
542 if (assignment[i] == 0)
544 owned_faces_higher.push_back(
545 inner_face.second.shared_faces[i]);
551 std::vector<std::pair<CellId, CellId>> check_faces;
552 check_faces.insert(check_faces.end(),
553 owned_faces_lower.begin(),
554 owned_faces_lower.end());
555 check_faces.insert(check_faces.end(),
556 owned_faces_higher.begin(),
557 owned_faces_higher.end());
558 std::sort(check_faces.begin(), check_faces.end());
560 inner_face.second.shared_faces.size());
561 for (
unsigned int i = 0; i < check_faces.size(); ++i)
562 Assert(check_faces[i] == inner_face.second.shared_faces[i],
567 if (my_domain < inner_face.first)
568 inner_face.second.shared_faces.swap(owned_faces_lower);
570 inner_face.second.shared_faces.swap(owned_faces_higher);
572 std::sort(inner_face.second.shared_faces.begin(),
573 inner_face.second.shared_faces.end());
579 std::set<std::pair<unsigned int, unsigned int>> ghost_cells;
580 for (
unsigned int i = 0; i < cell_levels.size(); ++i)
582 typename ::Triangulation<dim>::cell_iterator dcell(
584 if (use_active_cells)
586 for (
const auto f : dcell->face_indices())
588 if (dcell->at_boundary(f) && !dcell->has_periodic_neighbor(f))
589 face_is_owned[dcell->face(f)->index()] =
590 FaceCategory::locally_active_at_boundary;
591 else if (!build_inner_faces)
596 else if ((dcell->at_boundary(f) ==
false ||
597 dcell->has_periodic_neighbor(f)) &&
599 dcell->neighbor_or_periodic_neighbor(f)->level() <
602 face_is_owned[dcell->face(f)->index()] =
603 FaceCategory::multigrid_refinement_edge;
607 typename ::Triangulation<dim>::cell_iterator neighbor =
608 dcell->neighbor_or_periodic_neighbor(f);
611 if (use_active_cells && neighbor->has_children() &&
612 hold_all_faces_to_owned_cells ==
false)
615 bool add_to_ghost =
false;
617 id1 = use_active_cells ? dcell->subdomain_id() :
618 dcell->level_subdomain_id(),
619 id2 = use_active_cells ?
620 (neighbor->has_children() ?
621 dcell->neighbor_child_on_subface(f, 0)
623 neighbor->subdomain_id()) :
624 neighbor->level_subdomain_id();
632 (use_active_cells ==
false || neighbor->is_active())) ||
633 dcell->level() > neighbor->level() ||
635 inner_faces_at_proc_boundary[id2].shared_faces.begin(),
636 inner_faces_at_proc_boundary[id2].shared_faces.end(),
637 std::make_pair(id1 < id2 ? dcell->
id() : neighbor->id(),
638 id1 < id2 ? neighbor->id() :
641 face_is_owned[dcell->face(f)->index()] =
642 FaceCategory::locally_active_done_here;
643 if (dcell->level() == neighbor->level())
646 ->face(dcell->has_periodic_neighbor(f) ?
647 dcell->periodic_neighbor_face_no(f) :
648 dcell->neighbor_face_no(f))
650 FaceCategory::locally_active_done_here;
656 if (use_active_cells)
658 (dcell->subdomain_id() != neighbor->subdomain_id());
660 add_to_ghost = (dcell->level_subdomain_id() !=
661 neighbor->level_subdomain_id());
663 else if (hold_all_faces_to_owned_cells ==
true)
666 face_is_owned[dcell->face(f)->index()] =
667 FaceCategory::ghosted;
668 if (use_active_cells)
670 if (neighbor->has_children())
671 for (
unsigned int s = 0;
672 s < dcell->face(f)->n_children();
674 if (dcell->at_boundary(f))
677 ->periodic_neighbor_child_on_subface(f,
680 dcell->subdomain_id())
685 if (dcell->neighbor_child_on_subface(f, s)
687 dcell->subdomain_id())
691 add_to_ghost = (dcell->subdomain_id() !=
692 neighbor->subdomain_id());
695 add_to_ghost = (dcell->level_subdomain_id() !=
696 neighbor->level_subdomain_id());
701 if (use_active_cells && neighbor->has_children())
702 for (
unsigned int s = 0;
703 s < dcell->face(f)->n_children();
706 typename ::Triangulation<dim>::cell_iterator
708 dcell->at_boundary(f) ?
709 dcell->periodic_neighbor_child_on_subface(f,
711 dcell->neighbor_child_on_subface(f, s);
712 if (neighbor_child->subdomain_id() !=
713 dcell->subdomain_id())
715 std::pair<unsigned int, unsigned int>(
716 neighbor_child->level(),
717 neighbor_child->index()));
721 std::pair<unsigned int, unsigned int>(
722 neighbor->level(), neighbor->index()));
723 at_processor_boundary[i] =
true;
731 for (
const auto &ghost_cell : ghost_cells)
732 cell_levels.push_back(ghost_cell);
739 FaceSetup<dim>::generate_faces(
741 const std::vector<std::pair<unsigned int, unsigned int>> &cell_levels,
748 std::map<std::pair<unsigned int, unsigned int>,
unsigned int>
750 for (
unsigned int cell = 0; cell < cell_levels.size(); ++cell)
751 if (cell == 0 || cell_levels[cell] != cell_levels[cell - 1])
753 typename ::Triangulation<dim>::cell_iterator dcell(
755 cell_levels[cell].
first,
756 cell_levels[cell].
second);
757 std::pair<unsigned int, unsigned int> level_index(dcell->level(),
759 map_to_vectorized[level_index] = cell;
763 const unsigned int vectorization_length = task_info.vectorization_length;
764 task_info.face_partition_data.resize(
765 task_info.cell_partition_data.size() - 1, 0);
766 task_info.boundary_partition_data.resize(
767 task_info.cell_partition_data.size() - 1, 0);
768 std::vector<unsigned char> face_visited(face_is_owned.size(), 0);
769 for (
unsigned int partition = 0;
770 partition < task_info.cell_partition_data.size() - 2;
773 unsigned int boundary_counter = 0;
774 unsigned int inner_counter = 0;
775 for (
unsigned int cell = task_info.cell_partition_data[partition] *
776 vectorization_length;
777 cell < task_info.cell_partition_data[
partition + 1] *
778 vectorization_length;
780 if (cell == 0 || cell_levels[cell] != cell_levels[cell - 1])
782 typename ::Triangulation<dim>::cell_iterator dcell(
784 cell_levels[cell].
first,
785 cell_levels[cell].
second);
786 for (
const auto f : dcell->face_indices())
789 if (face_is_owned[dcell->face(f)->index()] ==
790 FaceCategory::locally_active_at_boundary)
794 FaceToCellTopology<1> info;
795 info.cells_interior[0] = cell;
797 info.interior_face_no = f;
798 info.exterior_face_no = dcell->face(f)->boundary_id();
801 (dcell->face(f)->reference_cell() !=
806 info.face_orientation = 0;
807 boundary_faces.push_back(info);
809 face_visited[dcell->face(f)->index()]++;
814 typename ::Triangulation<dim>::cell_iterator
815 neighbor = dcell->neighbor_or_periodic_neighbor(f);
816 if (use_active_cells && neighbor->has_children() &&
821 for (
unsigned int c = 0;
822 c < dcell->face(f)->n_children();
825 typename ::Triangulation<
826 dim>::cell_iterator neighbor_c =
827 dcell->at_boundary(f) ?
828 dcell->periodic_neighbor_child_on_subface(
830 dcell->neighbor_child_on_subface(f, c);
832 neighbor_c->subdomain_id();
833 const unsigned int neighbor_face_no =
834 dcell->has_periodic_neighbor(f) ?
835 dcell->periodic_neighbor_face_no(f) :
836 dcell->neighbor_face_no(f);
837 if (neigh_domain != dcell->subdomain_id() ||
839 [dcell->face(f)->child(c)->index()] ==
842 std::pair<unsigned int, unsigned int>
843 level_index(neighbor_c->level(),
844 neighbor_c->index());
846 [dcell->face(f)->child(c)->index()] ==
847 FaceCategory::locally_active_done_here)
850 inner_faces.push_back(create_face(
853 map_to_vectorized[level_index],
858 else if (face_is_owned[dcell->face(f)
861 FaceCategory::ghosted ||
862 face_is_owned[dcell->face(f)
864 FaceCategory::ghosted)
866 inner_ghost_faces.push_back(create_face(
869 map_to_vectorized[level_index],
875 Assert(face_is_owned[dcell->face(f)
878 locally_active_done_elsewhere,
884 [dcell->face(f)->child(c)->index()] = 1;
895 if (face_visited[dcell->face(f)->index()] == 0 &&
896 !(neighbor->has_children()))
898 std::pair<unsigned int, unsigned int>
899 level_index(neighbor->level(),
901 if (face_is_owned[dcell->face(f)->index()] ==
902 FaceCategory::locally_active_done_here)
904 Assert(use_active_cells ||
909 inner_faces.push_back(create_face(
914 map_to_vectorized[level_index],
916 face_visited[dcell->face(f)->index()] = 1;
918 else if (face_is_owned[dcell->face(f)
920 FaceCategory::ghosted)
922 inner_ghost_faces.push_back(create_face(
927 map_to_vectorized[level_index],
929 face_visited[dcell->face(f)->index()] = 1;
932 if (face_is_owned[dcell->face(f)->index()] ==
933 FaceCategory::multigrid_refinement_edge)
935 refinement_edge_faces.push_back(
940 refinement_edge_faces.size(),
947 use_active_cells ? dcell->subdomain_id() :
948 dcell->level_subdomain_id();
950 use_active_cells ? neighbor->subdomain_id() :
951 neighbor->level_subdomain_id();
952 if (neigh_domain != my_domain ||
953 face_visited[dcell->face(f)->index()] == 1)
955 std::pair<unsigned int, unsigned int>
956 level_index(neighbor->level(),
958 if (face_is_owned[dcell->face(f)->index()] ==
959 FaceCategory::locally_active_done_here)
961 Assert(use_active_cells ||
966 inner_faces.push_back(create_face(
971 map_to_vectorized[level_index],
974 else if (face_is_owned[dcell->face(f)
976 FaceCategory::ghosted)
978 inner_ghost_faces.push_back(create_face(
983 map_to_vectorized[level_index],
989 face_visited[dcell->face(f)->index()] = 1;
990 if (dcell->has_periodic_neighbor(f))
994 dcell->periodic_neighbor_face_no(f))
997 if (face_is_owned[dcell->face(f)->index()] ==
998 FaceCategory::multigrid_refinement_edge)
1000 refinement_edge_faces.push_back(
1005 refinement_edge_faces.size(),
1012 task_info.face_partition_data[
partition + 1] =
1013 task_info.face_partition_data[
partition] + inner_counter;
1014 task_info.boundary_partition_data[
partition + 1] =
1015 task_info.boundary_partition_data[
partition] + boundary_counter;
1017 task_info.ghost_face_partition_data.resize(2);
1018 task_info.ghost_face_partition_data[0] = 0;
1019 task_info.ghost_face_partition_data[1] = inner_ghost_faces.size();
1020 task_info.refinement_edge_face_partition_data.resize(2);
1021 task_info.refinement_edge_face_partition_data[0] = 0;
1022 task_info.refinement_edge_face_partition_data[1] =
1023 refinement_edge_faces.size();
1029 FaceToCellTopology<1>
1030 FaceSetup<dim>::create_face(
1031 const unsigned int face_no,
1032 const typename ::Triangulation<dim>::cell_iterator &cell,
1033 const unsigned int number_cell_interior,
1034 const typename ::Triangulation<dim>::cell_iterator &neighbor,
1035 const unsigned int number_cell_exterior,
1036 const bool is_mixed_mesh)
1038 FaceToCellTopology<1> info;
1039 info.cells_interior[0] = number_cell_interior;
1040 info.cells_exterior[0] = number_cell_exterior;
1041 info.interior_face_no = face_no;
1042 if (cell->has_periodic_neighbor(face_no))
1043 info.exterior_face_no = cell->periodic_neighbor_face_no(face_no);
1045 info.exterior_face_no = cell->neighbor_face_no(face_no);
1047 info.face_type = is_mixed_mesh ?
1048 (cell->face(face_no)->reference_cell() !=
1056 if (dim > 1 && cell->level() > neighbor->level())
1058 if (cell->has_periodic_neighbor(face_no))
1059 info.subface_index =
1060 cell->periodic_neighbor_of_coarser_periodic_neighbor(face_no)
1063 info.subface_index =
1064 cell->neighbor_of_coarser_neighbor(face_no).second;
1068 if (cell->has_periodic_neighbor(face_no))
1070 info.face_orientation = cell->get_triangulation()
1071 .get_periodic_face_map()
1072 .at({cell, face_no})
1077 const auto interior_face_orientation =
1078 cell->combined_face_orientation(face_no);
1079 const auto exterior_face_orientation =
1080 neighbor->combined_face_orientation(info.exterior_face_no);
1081 if (interior_face_orientation !=
1084 info.face_orientation = 8 + interior_face_orientation;
1085 Assert(exterior_face_orientation ==
1088 "Face seems to be wrongly oriented from both sides"));
1091 info.face_orientation = exterior_face_orientation;
1095 if (cell->level() > neighbor->level() &&
1096 exterior_face_orientation > 0)
1099 ShapeInfo<double>::compute_orientation_table(2);
1100 const auto face_reference_cell =
1101 cell->face(face_no)->reference_cell();
1102 info.subface_index = orientation(
1103 face_reference_cell.get_inverse_combined_orientation(
1104 exterior_face_orientation),
1105 info.subface_index);
1121 compare_faces_for_vectorization(
1122 const FaceToCellTopology<1> &face1,
1123 const FaceToCellTopology<1> &face2,
1124 const std::vector<unsigned int> &active_fe_indices,
1125 const unsigned int length)
1127 if (face1.interior_face_no != face2.interior_face_no)
1129 if (face1.exterior_face_no != face2.exterior_face_no)
1131 if (face1.subface_index != face2.subface_index)
1133 if (face1.face_orientation != face2.face_orientation)
1135 if (face1.face_type != face2.face_type)
1138 if (active_fe_indices.size() > 0)
1140 if (active_fe_indices[face1.cells_interior[0] / length] !=
1141 active_fe_indices[face2.cells_interior[0] / length])
1145 if (active_fe_indices[face1.cells_exterior[0] / length] !=
1146 active_fe_indices[face2.cells_exterior[0] / length])
1161 template <
int length>
1162 struct FaceComparator
1164 FaceComparator(
const std::vector<unsigned int> &active_fe_indices)
1165 : active_fe_indices(active_fe_indices)
1169 operator()(
const FaceToCellTopology<length> &face1,
1170 const FaceToCellTopology<length> &face2)
const
1173 if (face1.face_type < face2.face_type)
1175 else if (face1.face_type > face2.face_type)
1179 if (active_fe_indices.size() > 0)
1182 if (active_fe_indices[face1.cells_interior[0] / length] <
1183 active_fe_indices[face2.cells_interior[0] / length])
1185 else if (active_fe_indices[face1.cells_interior[0] / length] >
1186 active_fe_indices[face2.cells_interior[0] / length])
1192 if (active_fe_indices[face1.cells_exterior[0] / length] <
1193 active_fe_indices[face2.cells_exterior[0] / length])
1195 else if (active_fe_indices[face1.cells_exterior[0] / length] >
1196 active_fe_indices[face2.cells_exterior[0] / length])
1201 for (
unsigned int i = 0; i < length; ++i)
1202 if (face1.cells_interior[i] < face2.cells_interior[i])
1204 else if (face1.cells_interior[i] > face2.cells_interior[i])
1206 for (
unsigned int i = 0; i < length; ++i)
1207 if (face1.cells_exterior[i] < face2.cells_exterior[i])
1209 else if (face1.cells_exterior[i] > face2.cells_exterior[i])
1211 if (face1.interior_face_no < face2.interior_face_no)
1213 else if (face1.interior_face_no > face2.interior_face_no)
1215 if (face1.exterior_face_no < face2.exterior_face_no)
1217 else if (face1.exterior_face_no > face2.exterior_face_no)
1230 const std::vector<unsigned int> &active_fe_indices;
1235 template <
int vectorization_w
idth>
1238 const std::vector<FaceToCellTopology<1>> &faces_in,
1239 const std::vector<bool> &hard_vectorization_boundary,
1240 std::vector<unsigned int> &face_partition_data,
1241 std::vector<FaceToCellTopology<vectorization_width>> &faces_out,
1242 const std::vector<unsigned int> &active_fe_indices)
1244 FaceToCellTopology<vectorization_width> face_batch;
1245 std::vector<std::vector<unsigned int>> faces_type;
1247 unsigned int face_start = face_partition_data[0],
1248 face_end = face_partition_data[0];
1250 face_partition_data[0] = faces_out.size();
1251 for (
unsigned int partition = 0;
1252 partition < face_partition_data.size() - 1;
1255 std::vector<std::vector<unsigned int>> new_faces_type;
1258 face_start = face_end;
1259 face_end = face_partition_data[
partition + 1];
1266 for (
unsigned int face = face_start; face < face_end; ++face)
1268 for (
auto &face_type : faces_type)
1271 if (compare_faces_for_vectorization(faces_in[face],
1272 faces_in[face_type[0]],
1274 vectorization_width))
1276 face_type.push_back(face);
1280 faces_type.emplace_back(1, face);
1286 FaceComparator<vectorization_width> face_comparator(
1288 std::set<FaceToCellTopology<vectorization_width>,
1289 FaceComparator<vectorization_width>>
1290 new_faces(face_comparator);
1291 for (
const auto &face_type : faces_type)
1293 face_batch.face_type = faces_in[face_type[0]].face_type;
1294 face_batch.interior_face_no =
1295 faces_in[face_type[0]].interior_face_no;
1296 face_batch.exterior_face_no =
1297 faces_in[face_type[0]].exterior_face_no;
1298 face_batch.subface_index = faces_in[face_type[0]].subface_index;
1299 face_batch.face_orientation =
1300 faces_in[face_type[0]].face_orientation;
1301 unsigned int no_faces = face_type.size();
1302 std::vector<unsigned char> touched(no_faces, 0);
1308 unsigned int n_vectorized = 0;
1309 for (
unsigned int f = 0; f < no_faces; ++f)
1310 if (faces_in[face_type[f]].cells_interior[0] %
1311 vectorization_width ==
1314 bool is_contiguous =
true;
1315 if (f + vectorization_width > no_faces)
1316 is_contiguous =
false;
1318 for (
unsigned int v = 1; v < vectorization_width; ++v)
1319 if (faces_in[face_type[f + v]].cells_interior[0] !=
1320 faces_in[face_type[f]].cells_interior[0] + v)
1321 is_contiguous =
false;
1326 vectorization_width + 1);
1327 for (
unsigned int v = 0; v < vectorization_width; ++v)
1329 face_batch.cells_interior[v] =
1330 faces_in[face_type[f + v]].cells_interior[0];
1331 face_batch.cells_exterior[v] =
1332 faces_in[face_type[f + v]].cells_exterior[0];
1335 new_faces.insert(face_batch);
1336 f += vectorization_width - 1;
1337 n_vectorized += vectorization_width;
1341 std::vector<unsigned int> untouched;
1342 untouched.reserve(no_faces - n_vectorized);
1343 for (
unsigned int f = 0; f < no_faces; ++f)
1344 if (touched[f] == 0)
1345 untouched.push_back(f);
1347 for (
const auto f : untouched)
1349 face_batch.cells_interior[v] =
1350 faces_in[face_type[f]].cells_interior[0];
1351 face_batch.cells_exterior[v] =
1352 faces_in[face_type[f]].cells_exterior[0];
1354 if (v == vectorization_width)
1356 new_faces.insert(face_batch);
1360 if (v > 0 && v < vectorization_width)
1363 if (hard_vectorization_boundary[partition + 1] ||
1364 partition == face_partition_data.size() - 2)
1366 for (; v < vectorization_width; ++v)
1369 face_batch.cells_interior[v] =
1371 face_batch.cells_exterior[v] =
1374 new_faces.insert(face_batch);
1379 std::vector<unsigned int> untreated(v);
1380 for (
unsigned int f = 0; f < v; ++f)
1381 untreated[f] = face_type[*(untouched.end() - 1 - f)];
1382 new_faces_type.push_back(untreated);
1388 for (
auto it = new_faces.begin(); it != new_faces.end(); ++it)
1389 faces_out.push_back(*it);
1390 face_partition_data[
partition + 1] += new_faces.size();
1393 faces_type = std::move(new_faces_type);
1399 for (
const auto &face_type : faces_type)
1403 unsigned int nfaces = 0;
1404 for (
unsigned int i = face_partition_data[0];
1405 i < face_partition_data.back();
1407 for (
unsigned int v = 0; v < vectorization_width; ++v)
1408 nfaces += (faces_out[i].cells_interior[v] !=
1412 std::vector<std::pair<unsigned int, unsigned int>> in_faces,
1414 for (
const auto &face_in : faces_in)
1415 in_faces.emplace_back(face_in.cells_interior[0],
1416 face_in.cells_exterior[0]);
1417 for (
unsigned int i = face_partition_data[0];
1418 i < face_partition_data.back();
1420 for (
unsigned int v = 0;
1421 v < vectorization_width && faces_out[i].cells_interior[v] !=
1424 out_faces.emplace_back(faces_out[i].cells_interior[v],
1425 faces_out[i].cells_exterior[v]);
1426 std::sort(in_faces.begin(), in_faces.end());
1427 std::sort(out_faces.begin(), out_faces.end());
1429 for (
unsigned int i = 0; i < in_faces.size(); ++i)
#define DEAL_II_NAMESPACE_OPEN
constexpr bool running_in_debug_mode()
#define DEAL_II_NAMESPACE_CLOSE
static ::ExceptionBase & ExcNotImplemented()
#define Assert(cond, exc)
#define AssertDimension(dim1, dim2)
#define AssertThrowMPI(error_code)
#define AssertIndexRange(index, range)
static ::ExceptionBase & ExcInternalError()
static ::ExceptionBase & ExcMessage(std::string arg1)
#define AssertThrow(cond, exc)
constexpr const ReferenceCell & get_hypercube()
void collect_faces_vectorization(const std::vector< FaceToCellTopology< 1 > > &faces_in, const std::vector< bool > &hard_vectorization_boundary, std::vector< unsigned int > &face_partition_data, std::vector< FaceToCellTopology< vectorization_width > > &faces_out)
constexpr unsigned int invalid_unsigned_int
constexpr types::subdomain_id invalid_subdomain_id
constexpr types::geometric_orientation default_geometric_orientation
const ::parallel::distributed::Triangulation< dim, spacedim > * triangulation
unsigned int n_hanging_faces_smaller_subdomain
unsigned int n_hanging_faces_larger_subdomain
std::vector< std::pair< CellId, CellId > > shared_faces
std::vector< FaceToCellTopology< 1 > > inner_faces
std::vector< bool > at_processor_boundary
std::vector< FaceToCellTopology< 1 > > boundary_faces
std::vector< FaceToCellTopology< 1 > > refinement_edge_faces
FaceToCellTopology< 1 > create_face(const unsigned int face_no, const typename ::Triangulation< dim >::cell_iterator &cell, const unsigned int number_cell_interior, const typename ::Triangulation< dim >::cell_iterator &neighbor, const unsigned int number_cell_exterior, const bool is_mixed_mesh)
std::vector< FaceCategory > face_is_owned
@ locally_active_done_here
@ multigrid_refinement_edge
@ locally_active_at_boundary
@ locally_active_done_elsewhere
void initialize(const ::Triangulation< dim > &triangulation, const unsigned int mg_level, const bool hold_all_faces_to_owned_cells, const bool build_inner_faces, std::vector< std::pair< unsigned int, unsigned int > > &cell_levels)
std::vector< FaceToCellTopology< 1 > > inner_ghost_faces
void generate_faces(const ::Triangulation< dim > &triangulation, const std::vector< std::pair< unsigned int, unsigned int > > &cell_levels, TaskInfo &task_info)