From: Wolfgang Bangerth Date: Thu, 10 Aug 2017 18:46:38 +0000 (-0600) Subject: Be careful for which cells and objects we allocate hp DoF indices. X-Git-Tag: v9.0.0-rc1~1299^2~2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=196cdd9971aaac9c68ce528b6d7acb3d408aeb57;p=dealii.git Be careful for which cells and objects we allocate hp DoF indices. The patch itself is actually pretty small -- we just have to occasionally exclude cells when we loop over them, specifically of they are artificial. The patch, however, is far larger because we replicated the same code for cells, faces, and vertices for the 1d, 2d, and 3d implementations. I didn't feel like making the same changes 3 times over, so I refactored these things into functions that deal with cells, faces, and vertices. This makes the overall patch rather large. --- diff --git a/source/hp/dof_handler.cc b/source/hp/dof_handler.cc index 1a18ad6e0c..1f296ec5ea 100644 --- a/source/hp/dof_handler.cc +++ b/source/hp/dof_handler.cc @@ -73,6 +73,42 @@ namespace internal */ struct Implementation { + /** + * Do that part of reserving space that pertains to releasing + * the previously used memory. + */ + template + static + void + reserve_space_release_space (DoFHandler &dof_handler) + { + // Release all space except the active_fe_indices field + // which we have to back up before + { + std::vector > + active_fe_backup(dof_handler.levels.size ()); + for (unsigned int level = 0; levelactive_fe_indices, + active_fe_backup[level]); + + // delete all levels and set them up newly, since vectors + // are troublesome if you want to change their size + dof_handler.clear_space (); + + for (unsigned int level=0; leveln_levels(); ++level) + { + dof_handler.levels.emplace_back (new internal::hp::DoFLevel); + std::swap (active_fe_backup[level], + dof_handler.levels[level]->active_fe_indices); + } + + if (dim > 1) + dof_handler.faces.reset (new internal::hp::DoFIndicesOnFaces); + } + } + + + /** * Do that part of reserving space that pertains to vertices, * since this is the same in all space dimensions. @@ -82,35 +118,53 @@ namespace internal void reserve_space_vertices (DoFHandler &dof_handler) { - // The final step is allocating memory is to set up vertex - // dof information. since vertices are sequentially + // The final step in all of the reserve_space() functions is to set + // up vertex dof information. since vertices are sequentially // numbered, what we do first is to set up an array in which // we record whether a vertex is associated with any of the // given fe's, by setting a bit. in a later step, we then // actually allocate memory for the required dofs + // + // in the following, we only need to consider vertices that are + // adjacent to either a locally owned or a ghost cell; we never + // store anything on vertices that are only surrounded by + // artificial cells. so figure out that subset of vertices + // first + std::vector locally_used_vertices (dof_handler.tria->n_vertices(), + false); + for (typename HpDoFHandler::active_cell_iterator + cell=dof_handler.begin_active(); cell!=dof_handler.end(); ++cell) + if (! cell->is_artificial()) + for (unsigned int v=0; v::vertices_per_cell; ++v) + locally_used_vertices[cell->vertex_index(v)] = true; + std::vector > vertex_fe_association (dof_handler.finite_elements->size(), std::vector (dof_handler.tria->n_vertices(), false)); for (typename HpDoFHandler::active_cell_iterator cell=dof_handler.begin_active(); cell!=dof_handler.end(); ++cell) - for (unsigned int v=0; v::vertices_per_cell; ++v) - vertex_fe_association[cell->active_fe_index()][cell->vertex_index(v)] - = true; + if (! cell->is_artificial()) + for (unsigned int v=0; v::vertices_per_cell; ++v) + vertex_fe_association[cell->active_fe_index()][cell->vertex_index(v)] + = true; // in debug mode, make sure that each vertex is associated // with at least one fe (note that except for unused - // vertices, all vertices are actually active) + // vertices, all vertices are actually active). this is of + // course only true for vertices that are part of either + // ghost or locally owned cells #ifdef DEBUG for (unsigned int v=0; vn_vertices(); ++v) - if (dof_handler.tria->vertex_used(v) == true) - { - unsigned int fe=0; - for (; fesize(); ++fe) - if (vertex_fe_association[fe][v] == true) - break; - Assert (fe != dof_handler.finite_elements->size(), ExcInternalError()); - } + if (locally_used_vertices[v] == true) + if (dof_handler.tria->vertex_used(v) == true) + { + unsigned int fe=0; + for (; fesize(); ++fe) + if (vertex_fe_association[fe][v] == true) + break; + Assert (fe != dof_handler.finite_elements->size(), ExcInternalError()); + } #endif // next count how much memory we actually need. for each @@ -124,14 +178,17 @@ namespace internal unsigned int vertex_slots_needed = 0; for (unsigned int v=0; vn_vertices(); ++v) if (dof_handler.tria->vertex_used(v) == true) - { - dof_handler.vertex_dofs_offsets[v] = vertex_slots_needed; + if (locally_used_vertices[v] == true) + { + dof_handler.vertex_dofs_offsets[v] = vertex_slots_needed; - for (unsigned int fe=0; fesize(); ++fe) - if (vertex_fe_association[fe][v] == true) - vertex_slots_needed += (*dof_handler.finite_elements)[fe].dofs_per_vertex + 1; - ++vertex_slots_needed; - } + for (unsigned int fe=0; fesize(); ++fe) + if (vertex_fe_association[fe][v] == true) + vertex_slots_needed += (*dof_handler.finite_elements)[fe].dofs_per_vertex + 1; + + // don't forget the end_marker: + ++vertex_slots_needed; + } // now allocate the space we have determined we need, and // set up the linked lists for each of the vertices @@ -139,71 +196,32 @@ namespace internal numbers::invalid_dof_index); for (unsigned int v=0; vn_vertices(); ++v) if (dof_handler.tria->vertex_used(v) == true) - { - types::global_dof_index pointer = dof_handler.vertex_dofs_offsets[v]; - for (unsigned int fe=0; fesize(); ++fe) - if (vertex_fe_association[fe][v] == true) - { - // if this vertex uses this fe, then set the - // fe_index and move the pointer ahead - dof_handler.vertex_dofs[pointer] = fe; - pointer += (*dof_handler.finite_elements)[fe].dofs_per_vertex + 1; - } - // finally place the end marker - dof_handler.vertex_dofs[pointer] = numbers::invalid_dof_index; - } + if (locally_used_vertices[v] == true) + { + unsigned int current_index = dof_handler.vertex_dofs_offsets[v]; + for (unsigned int fe=0; fesize(); ++fe) + if (vertex_fe_association[fe][v] == true) + { + // if this vertex uses this fe, then set the + // fe_index and move the pointer ahead + dof_handler.vertex_dofs[current_index] = fe; + current_index += (*dof_handler.finite_elements)[fe].dofs_per_vertex + 1; + } + // finally place the end marker + dof_handler.vertex_dofs[current_index] = numbers::invalid_dof_index; + } } - /** - * Reserve enough space in the levels[] objects to - * store the numbers of the degrees of freedom needed for the - * given element. The given element is that one which was - * selected when calling @p distribute_dofs the last time. + * Do that part of reserving space that pertains to cells, + * since this is the same in all space dimensions. */ - template + template static void - reserve_space (DoFHandler<1,spacedim> &dof_handler) + reserve_space_cells (DoFHandler &dof_handler) { - const unsigned int dim = 1; - - typedef DoFHandler BaseClass; - - Assert (dof_handler.finite_elements != nullptr, - typename BaseClass::ExcNoFESelected()); - Assert (dof_handler.finite_elements->size() > 0, - typename BaseClass::ExcNoFESelected()); - Assert (dof_handler.tria->n_levels() > 0, - typename - BaseClass::ExcInvalidTriangulation()); - Assert (dof_handler.tria->n_levels() == dof_handler.levels.size (), - ExcInternalError ()); - - // Release all space except the active_fe_indices field - // which we have to backup before - { - std::vector > - active_fe_backup(dof_handler.levels.size ()); - for (unsigned int level = 0; levelactive_fe_indices, - active_fe_backup[level]); - - // delete all levels and set them up newly, since vectors - // are troublesome if you want to change their size - dof_handler.clear_space (); - - for (unsigned int level=0; leveln_levels(); ++level) - { - dof_handler.levels.emplace_back (new internal::hp::DoFLevel); - std::swap (active_fe_backup[level], - dof_handler.levels[level]->active_fe_indices); - } - } - - // LINE (CELL) DOFs - // count how much space we need on each level for the cell // dofs and set the dof_*_offsets data. initially set the // latter to an invalid index, and only later set it to @@ -215,13 +233,11 @@ namespace internal for (unsigned int level=0; leveln_levels(); ++level) { dof_handler.levels[level]->dof_offsets - = std::vector ( - dof_handler.tria->n_raw_lines(level), - (DoFLevel::offset_type)(-1)); + = std::vector (dof_handler.tria->n_raw_cells(level), + (DoFLevel::offset_type)(-1)); dof_handler.levels[level]->cell_cache_offsets - = std::vector ( - dof_handler.tria->n_raw_lines(level), - (DoFLevel::offset_type)(-1)); + = std::vector (dof_handler.tria->n_raw_cells(level), + (DoFLevel::offset_type)(-1)); types::global_dof_index next_free_dof = 0; types::global_dof_index cache_size = 0; @@ -229,10 +245,12 @@ namespace internal cell=dof_handler.begin_active(level), endc=dof_handler.end_active(level); for (; cell!=endc; ++cell) - if (!cell->has_children()) + if (!cell->has_children() + && + !cell->is_artificial()) { dof_handler.levels[level]->dof_offsets[cell->index()] = next_free_dof; - next_free_dof += cell->get_fe().dofs_per_line; + next_free_dof += cell->get_fe().template n_dofs_per_object(); dof_handler.levels[level]->cell_cache_offsets[cell->index()] = cache_size; cache_size += cell->get_fe().dofs_per_cell; @@ -258,329 +276,327 @@ namespace internal cell=dof_handler.begin_active(level), endc=dof_handler.end_active(level); for (; cell!=endc; ++cell) - if (!cell->has_children()) - counter += cell->get_fe().dofs_per_line; + if (!cell->has_children() + && + !cell->is_artificial()) + counter += cell->get_fe().template n_dofs_per_object(); Assert (dof_handler.levels[level]->dof_indices.size() == counter, ExcInternalError()); + + // also check that the number of unassigned slots in the dof_offsets + // equals the number of cells on that level minus the number of + // active, non-artificial cells (because these are exactly the cells + // on which we do something) + unsigned int n_active_non_artificial_cells = 0; + for (cell=dof_handler.begin_active(level); cell!=endc; ++cell) + if (!cell->has_children() + && + !cell->is_artificial()) + ++n_active_non_artificial_cells; + Assert (static_cast (std::count (dof_handler.levels[level]->dof_offsets.begin(), dof_handler.levels[level]->dof_offsets.end(), (DoFLevel::offset_type)(-1))) == - dof_handler.tria->n_raw_lines(level) - dof_handler.tria->n_active_lines(level), + dof_handler.tria->n_raw_cells(level) - n_active_non_artificial_cells, ExcInternalError()); } #endif + } - // VERTEX DOFS - reserve_space_vertices (dof_handler); - } - template + /** + * Do that part of reserving space that pertains to faces, + * since this is the same in all space dimensions. + */ + template static void - reserve_space (DoFHandler<2,spacedim> &dof_handler) + reserve_space_faces (DoFHandler &dof_handler) { - const unsigned int dim = 2; - - typedef DoFHandler BaseClass; - - Assert (dof_handler.finite_elements != nullptr, - typename BaseClass::ExcNoFESelected()); - Assert (dof_handler.finite_elements->size() > 0, - typename BaseClass::ExcNoFESelected()); - Assert (dof_handler.tria->n_levels() > 0, - typename BaseClass::ExcInvalidTriangulation()); - Assert (dof_handler.tria->n_levels() == dof_handler.levels.size (), - ExcInternalError ()); - - // Release all space except the active_fe_indices field - // which we have to backup before - { - std::vector > - active_fe_backup(dof_handler.levels.size ()); - for (unsigned int level = 0; levelactive_fe_indices, - active_fe_backup[level]); - - // delete all levels and set them up newly, since vectors - // are troublesome if you want to change their size - dof_handler.clear_space (); - - for (unsigned int level=0; leveln_levels(); ++level) - { - dof_handler.levels.emplace_back (new internal::hp::DoFLevel); - std::swap (active_fe_backup[level], - dof_handler.levels[level]->active_fe_indices); - } - dof_handler.faces.reset (new internal::hp::DoFIndicesOnFaces<2>); - } - - // QUAD (CELL) DOFs - - // count how much space we need on each level for the cell - // dofs and set the dof_*_offsets data. initially set the - // latter to an invalid index, and only later set it to - // something reasonable for active dof_handler.cells - // - // note that for dof_handler.cells, the situation is simpler - // than for other (lower dimensional) objects since exactly - // one finite element is used for it - for (unsigned int level=0; leveln_levels(); ++level) - { - dof_handler.levels[level]->dof_offsets - = std::vector ( - dof_handler.tria->n_raw_quads(level), - (DoFLevel::offset_type)(-1)); - dof_handler.levels[level]->cell_cache_offsets - = std::vector ( - dof_handler.tria->n_raw_quads(level), - (DoFLevel::offset_type)(-1)); - - types::global_dof_index next_free_dof = 0; - types::global_dof_index cache_size = 0; - typename HpDoFHandler::active_cell_iterator - cell=dof_handler.begin_active(level), - endc=dof_handler.end_active(level); - for (; cell!=endc; ++cell) - if (!cell->has_children()) - { - dof_handler.levels[level]->dof_offsets[cell->index()] = next_free_dof; - next_free_dof += cell->get_fe().dofs_per_quad; - - dof_handler.levels[level]->cell_cache_offsets[cell->index()] = cache_size; - cache_size += cell->get_fe().dofs_per_cell; - } - - dof_handler.levels[level]->dof_indices - = std::vector (next_free_dof, - numbers::invalid_dof_index); - dof_handler.levels[level]->cell_dof_indices_cache - = std::vector (cache_size, - numbers::invalid_dof_index); - } - - // safety check: make sure that the number of DoFs we - // allocated is actually correct (above we have also set the - // dof_*_offsets field, so we couldn't use this simpler - // algorithm) -#ifdef DEBUG - for (unsigned int level=0; leveln_levels(); ++level) - { - types::global_dof_index counter = 0; - typename HpDoFHandler::active_cell_iterator - cell=dof_handler.begin_active(level), - endc=dof_handler.end_active(level); - for (; cell!=endc; ++cell) - if (!cell->has_children()) - counter += cell->get_fe().dofs_per_quad; - - Assert (dof_handler.levels[level]->dof_indices.size() == counter, - ExcInternalError()); - Assert (static_cast - (std::count (dof_handler.levels[level]->dof_offsets.begin(), - dof_handler.levels[level]->dof_offsets.end(), - (DoFLevel::offset_type)(-1))) - == - dof_handler.tria->n_raw_quads(level) - dof_handler.tria->n_active_quads(level), - ExcInternalError()); - } -#endif - - - // LINE DOFS + // make the code generic between lines and quads + std::vector &face_dof_offsets + = (dim == 2 + ? + reinterpret_cast&>(*dof_handler.faces).lines.dof_offsets + : + reinterpret_cast&>(*dof_handler.faces).quads.dof_offsets); + + std::vector &face_dof_indices + = (dim == 2 + ? + reinterpret_cast&>(*dof_handler.faces).lines.dofs + : + reinterpret_cast&>(*dof_handler.faces).quads.dofs); + + // FACE DOFS // - // same here: count line dofs, then allocate as much space - // as we need and prime the linked list for lines (see the + // count face dofs, then allocate as much space + // as we need and prime the linked list for faces (see the // description in hp::DoFLevel) with the indices we will - // need. note that our task is more complicated since two - // adjacent dof_handler.cells may have different + // need. note that our task is more complicated than for the + // cell case above since two adjacent cells may have different // active_fe_indices, in which case we need to allocate - // *two* sets of line dofs for the same line + // *two* sets of face dofs for the same face // // the way we do things is that we loop over all active - // dof_handler.cells (these are the ones that have DoFs only - // anyway) and all their dof_handler.faces. We note in the + // cells (these are the ones that have DoFs only + // anyway) and all their faces. We note in the // user flags whether we have previously visited a face and // if so skip it (consequently, we have to save and later - // restore the line flags) + // restore the face flags) { - std::vector saved_line_user_flags; - const_cast&>(*dof_handler.tria) - .save_user_flags_line (saved_line_user_flags); - const_cast&>(*dof_handler.tria) - .clear_user_flags_line (); + std::vector saved_face_user_flags; + switch (dim) + { + case 2: + { + const_cast&>(*dof_handler.tria) + .save_user_flags_line (saved_face_user_flags); + const_cast&>(*dof_handler.tria) + .clear_user_flags_line (); + + break; + } + + case 3: + { + const_cast&>(*dof_handler.tria) + .save_user_flags_quad (saved_face_user_flags); + const_cast&>(*dof_handler.tria) + .clear_user_flags_quad (); + + break; + } + + default: + Assert (false, ExcNotImplemented()); + } // an array to hold how many slots (see the hp::DoFLevel // class) we will have to store on each level - unsigned int n_line_slots = 0; + unsigned int n_face_slots = 0; for (typename HpDoFHandler::active_cell_iterator cell=dof_handler.begin_active(); cell!=dof_handler.end(); ++cell) - for (unsigned int face=0; face::faces_per_cell; ++face) - if (! cell->face(face)->user_flag_set()) - { - // ok, face has not been visited. so we need to - // allocate space for it. let's see how much we - // need: we need one set if a) there is no - // neighbor behind this face, or b) the neighbor - // is either coarser or finer than we are, or c) - // the neighbor is neither coarser nor finer, but - // has happens to have the same active_fe_index: - if (cell->at_boundary(face) - || - cell->face(face)->has_children() - || - cell->neighbor_is_coarser(face) - || - (!cell->at_boundary(face) - && - (cell->active_fe_index() == cell->neighbor(face)->active_fe_index()))) - // ok, one set of dofs. that makes one index, 1 - // times dofs_per_line dofs, and one stop index - n_line_slots - += (*dof_handler.finite_elements)[cell->active_fe_index()].dofs_per_line + 2; - - // otherwise we do indeed need two sets, i.e. two - // indices, two sets of dofs, and one stop index: - else - n_line_slots - += ((*dof_handler.finite_elements)[cell->active_fe_index()].dofs_per_line - + - (*dof_handler.finite_elements)[cell->neighbor(face)->active_fe_index()] - .dofs_per_line - + - 3); - - // mark this face as visited - cell->face(face)->set_user_flag (); - } + if (! cell->is_artificial()) + for (unsigned int face=0; face::faces_per_cell; ++face) + if (! cell->face(face)->user_flag_set()) + { + // ok, face has not been visited. so we need to + // allocate space for it. let's see how much we + // need: we need one set if a) there is no + // neighbor behind this face, or b) the neighbor + // is either coarser or finer than we are, or c) + // the neighbor is artificial, or d) the neighbor + // is neither coarser nor finer, nor is artificial, + // and just so happens to have the same active_fe_index : + if (cell->at_boundary(face) + || + cell->face(face)->has_children() + || + cell->neighbor_is_coarser(face) + || + (!cell->at_boundary(face) + && + cell->neighbor(face)->is_artificial()) + || + (!cell->at_boundary(face) + && + !cell->neighbor(face)->is_artificial() + && + (cell->active_fe_index() == cell->neighbor(face)->active_fe_index()))) + // ok, one set of dofs. that makes one active_fe_index, 1 + // times dofs_per_face dofs, and one stop index + n_face_slots + += 1 + (*dof_handler.finite_elements)[cell->active_fe_index()].template n_dofs_per_object() + 1; + + // otherwise we do indeed need two sets, i.e. two + // active_fe_indices, two sets of dofs, and one stop index: + else + n_face_slots + += (2 + + + (*dof_handler.finite_elements)[cell->active_fe_index()].template n_dofs_per_object() + + + (*dof_handler.finite_elements)[cell->neighbor(face)->active_fe_index()] + .template n_dofs_per_object() + + + 1); + + // mark this face as visited + cell->face(face)->set_user_flag (); + } - // now that we know how many line dofs we will have to + // now that we know how many face dofs we will have to // have on each level, allocate the memory. note that we - // allocate offsets for all lines, though only the active + // allocate offsets for all faces, though only the active // ones will have a non-invalid value later on - dof_handler.faces->lines.dof_offsets - = std::vector (dof_handler.tria->n_raw_lines(), + face_dof_offsets + = std::vector (dof_handler.tria->n_raw_faces(), (unsigned int)(-1)); - dof_handler.faces->lines.dofs - = std::vector (n_line_slots, + face_dof_indices + = std::vector (n_face_slots, numbers::invalid_dof_index); // with the memory now allocated, loop over the // dof_handler.cells again and prime the _offset values as // well as the fe_index fields - const_cast&>(*dof_handler.tria) - .clear_user_flags_line (); + switch (dim) + { + case 2: + { + const_cast&>(*dof_handler.tria) + .clear_user_flags_line (); - unsigned int next_free_line_slot = 0; + break; + } + + case 3: + { + const_cast&>(*dof_handler.tria) + .clear_user_flags_quad (); + + break; + } + + default: + Assert (false, ExcNotImplemented()); + } + + unsigned int next_free_face_slot = 0; for (typename HpDoFHandler::active_cell_iterator cell=dof_handler.begin_active(); cell!=dof_handler.end(); ++cell) - for (unsigned int face=0; face::faces_per_cell; ++face) - if (! cell->face(face)->user_flag_set()) - { - // same decision tree as before - if (cell->at_boundary(face) - || - cell->face(face)->has_children() - || - cell->neighbor_is_coarser(face) - || - (!cell->at_boundary(face) - && - (cell->active_fe_index() == cell->neighbor(face)->active_fe_index()))) - { - dof_handler.faces - ->lines.dof_offsets[cell->face(face)->index()] - = next_free_line_slot; - - // set first slot for this line to - // active_fe_index of this face - dof_handler.faces - ->lines.dofs[next_free_line_slot] - = cell->active_fe_index(); - - // the next dofs_per_line indices remain unset - // for the moment (i.e. at invalid_dof_index). - // following this comes the stop index, which - // also is invalid_dof_index and therefore - // does not have to be explicitly set - - // finally, mark those slots as used - next_free_line_slot - += (*dof_handler.finite_elements)[cell->active_fe_index()].dofs_per_line + 2; - } - else - { - dof_handler.faces - ->lines.dof_offsets[cell->face(face)->index()] - = next_free_line_slot; - - // set first slot for this line to - // active_fe_index of this face - dof_handler.faces - ->lines.dofs[next_free_line_slot] - = cell->active_fe_index(); - - // the next dofs_per_line indices remain unset - // for the moment (i.e. at invalid_dof_index). - // - // then comes the fe_index for the neighboring - // cell: - dof_handler.faces - ->lines.dofs[next_free_line_slot - + - (*dof_handler.finite_elements)[cell->active_fe_index()].dofs_per_line - + - 1] - = cell->neighbor(face)->active_fe_index(); - // then again a set of dofs that we need not - // set right now - // - // following this comes the stop index, which - // also is invalid_dof_index and therefore - // does not have to be explicitly set - - // finally, mark those slots as used - next_free_line_slot - += ((*dof_handler.finite_elements)[cell->active_fe_index()].dofs_per_line - + - (*dof_handler.finite_elements)[cell->neighbor(face)->active_fe_index()] - .dofs_per_line - + - 3); - } + if (! cell->is_artificial()) + for (unsigned int face=0; face::faces_per_cell; ++face) + if (! cell->face(face)->user_flag_set()) + { + // same decision tree as before + if (cell->at_boundary(face) + || + cell->face(face)->has_children() + || + cell->neighbor_is_coarser(face) + || + (!cell->at_boundary(face) + && + cell->neighbor(face)->is_artificial()) + || + (!cell->at_boundary(face) + && + !cell->neighbor(face)->is_artificial() + && + (cell->active_fe_index() == cell->neighbor(face)->active_fe_index()))) + { + face_dof_offsets[cell->face(face)->index()] + = next_free_face_slot; + + // set first slot for this face to + // active_fe_index of this face + face_dof_indices[next_free_face_slot] + = cell->active_fe_index(); + + // the next dofs_per_face indices remain unset + // for the moment (i.e. at invalid_dof_index). + // following this comes the stop index, which + // also is invalid_dof_index and therefore + // does not have to be explicitly set + + // finally, mark those slots as used + next_free_face_slot + += (*dof_handler.finite_elements)[cell->active_fe_index()].template n_dofs_per_object() + 2; + } + else + { + face_dof_offsets[cell->face(face)->index()] + = next_free_face_slot; + + // set first slot for this face to + // active_fe_index of this face + face_dof_indices[next_free_face_slot] + = cell->active_fe_index(); + + // the next dofs_per_line/quad indices remain unset + // for the moment (i.e. at invalid_dof_index). + // + // then comes the fe_index for the neighboring + // cell: + face_dof_indices[next_free_face_slot + + + (*dof_handler.finite_elements)[cell->active_fe_index()].template n_dofs_per_object() + + + 1] + = cell->neighbor(face)->active_fe_index(); + // then again a set of dofs that we need not + // set right now + // + // following this comes the stop index, which + // also is invalid_dof_index and therefore + // does not have to be explicitly set + + // finally, mark those slots as used + next_free_face_slot + += ((*dof_handler.finite_elements)[cell->active_fe_index()].template n_dofs_per_object() + + + (*dof_handler.finite_elements)[cell->neighbor(face)->active_fe_index()] + .template n_dofs_per_object() + + + 3); + } - // mark this face as visited - cell->face(face)->set_user_flag (); - } + // mark this face as visited + cell->face(face)->set_user_flag (); + } // we should have moved the cursor for each level to the // total number of dofs on that level. check that - Assert (next_free_line_slot == n_line_slots, + Assert (next_free_face_slot == n_face_slots, ExcInternalError()); - // at the end, restore the user flags for the lines - const_cast&>(*dof_handler.tria) - .load_user_flags_line (saved_line_user_flags); - } + // at the end, restore the user flags for the faces + switch (dim) + { + case 2: + { + const_cast&>(*dof_handler.tria) + .load_user_flags_line (saved_face_user_flags); + break; + } - // VERTEX DOFS - reserve_space_vertices (dof_handler); + case 3: + { + const_cast&>(*dof_handler.tria) + .load_user_flags_quad (saved_face_user_flags); + + break; + } + + default: + Assert (false, ExcNotImplemented()); + } + + } } + /** + * Reserve enough space in the levels[] objects to + * store the numbers of the degrees of freedom needed for the + * given element. The given element is that one which was + * selected when calling @p distribute_dofs the last time. + */ template static void - reserve_space (DoFHandler<3,spacedim> &dof_handler) + reserve_space (DoFHandler<1,spacedim> &dof_handler) { - const unsigned int dim = 3; + const unsigned int dim = 1; typedef DoFHandler BaseClass; @@ -589,285 +605,72 @@ namespace internal Assert (dof_handler.finite_elements->size() > 0, typename BaseClass::ExcNoFESelected()); Assert (dof_handler.tria->n_levels() > 0, - typename BaseClass::ExcInvalidTriangulation()); + typename + BaseClass::ExcInvalidTriangulation()); Assert (dof_handler.tria->n_levels() == dof_handler.levels.size (), ExcInternalError ()); - // Release all space except the active_fe_indices field - // which we have to backup before - { - std::vector > - active_fe_backup(dof_handler.levels.size ()); - for (unsigned int level = 0; levelactive_fe_indices, - active_fe_backup[level]); - - // delete all levels and set them up newly, since vectors - // are troublesome if you want to change their size - dof_handler.clear_space (); + reserve_space_release_space (dof_handler); - for (unsigned int level=0; leveln_levels(); ++level) - { - dof_handler.levels.emplace_back (new internal::hp::DoFLevel); - std::swap (active_fe_backup[level], - dof_handler.levels[level]->active_fe_indices); - } - dof_handler.faces.reset (new internal::hp::DoFIndicesOnFaces<3>); - } - - // HEX (CELL) DOFs - - // count how much space we need on each level for the cell - // dofs and set the dof_*_offsets data. initially set the - // latter to an invalid index, and only later set it to - // something reasonable for active dof_handler.cells - // - // note that for dof_handler.cells, the situation is simpler - // than for other (lower dimensional) objects since exactly - // one finite element is used for it - for (unsigned int level=0; leveln_levels(); ++level) - { - dof_handler.levels[level]->dof_offsets - = std::vector ( - dof_handler.tria->n_raw_hexs(level), - (DoFLevel::offset_type)(-1)); - dof_handler.levels[level]->cell_cache_offsets - = std::vector ( - dof_handler.tria->n_raw_hexs(level), - (DoFLevel::offset_type)(-1)); - - types::global_dof_index next_free_dof = 0; - types::global_dof_index cache_size = 0; - typename HpDoFHandler::active_cell_iterator - cell=dof_handler.begin_active(level), - endc=dof_handler.end_active(level); - for (; cell!=endc; ++cell) - if (!cell->has_children()) - { - dof_handler.levels[level]->dof_offsets[cell->index()] = next_free_dof; - next_free_dof += cell->get_fe().dofs_per_hex; + reserve_space_cells (dof_handler); + reserve_space_vertices (dof_handler); + } - dof_handler.levels[level]->cell_cache_offsets[cell->index()] = cache_size; - cache_size += cell->get_fe().dofs_per_cell; - } - dof_handler.levels[level]->dof_indices - = std::vector (next_free_dof, - numbers::invalid_dof_index); - dof_handler.levels[level]->cell_dof_indices_cache - = std::vector (cache_size, - numbers::invalid_dof_index); - } - // safety check: make sure that the number of DoFs we - // allocated is actually correct (above we have also set the - // dof_*_offsets field, so we couldn't use this simpler - // algorithm) -#ifdef DEBUG - for (unsigned int level=0; leveln_levels(); ++level) - { - types::global_dof_index counter = 0; - typename HpDoFHandler::active_cell_iterator - cell=dof_handler.begin_active(level), - endc=dof_handler.end_active(level); - for (; cell!=endc; ++cell) - if (!cell->has_children()) - counter += cell->get_fe().dofs_per_hex; + template + static + void + reserve_space (DoFHandler<2,spacedim> &dof_handler) + { + const unsigned int dim = 2; - Assert (dof_handler.levels[level]->dof_indices.size() == counter, - ExcInternalError()); - Assert (static_cast - (std::count (dof_handler.levels[level]->dof_offsets.begin(), - dof_handler.levels[level]->dof_offsets.end(), - (DoFLevel::offset_type)(-1))) - == - dof_handler.tria->n_raw_hexs(level) - dof_handler.tria->n_active_hexs(level), - ExcInternalError()); - } -#endif + typedef DoFHandler BaseClass; + Assert (dof_handler.finite_elements != nullptr, + typename BaseClass::ExcNoFESelected()); + Assert (dof_handler.finite_elements->size() > 0, + typename BaseClass::ExcNoFESelected()); + Assert (dof_handler.tria->n_levels() > 0, + typename BaseClass::ExcInvalidTriangulation()); + Assert (dof_handler.tria->n_levels() == dof_handler.levels.size (), + ExcInternalError ()); - // QUAD DOFS - // - // same here: count quad dofs, then allocate as much space - // as we need and prime the linked list for quad (see the - // description in hp::DoFLevel) with the indices we will - // need. note that our task is more complicated since two - // adjacent dof_handler.cells may have different - // active_fe_indices, in which case we need to allocate - // *two* sets of line dofs for the same line - // - // the way we do things is that we loop over all active - // dof_handler.cells (these are the ones that have DoFs only - // anyway) and all their dof_handler.faces. We note in the - // user flags whether we have previously visited a face and - // if so skip it (consequently, we have to save and later - // restore the line flags) - { - std::vector saved_quad_user_flags; - const_cast&>(*dof_handler.tria) - .save_user_flags_quad (saved_quad_user_flags); - const_cast&>(*dof_handler.tria) - .clear_user_flags_quad (); + reserve_space_release_space (dof_handler); - // examine, how how many slots (see the hp::DoFLevel - // class) we will have to store - unsigned int n_quad_slots = 0; + // FIRST CELLS AND FACES + reserve_space_cells (dof_handler); + reserve_space_faces (dof_handler); - for (typename HpDoFHandler::active_cell_iterator - cell=dof_handler.begin_active(); cell!=dof_handler.end(); ++cell) - for (unsigned int face=0; face::faces_per_cell; ++face) - if (! cell->face(face)->user_flag_set()) - { - // ok, face has not been visited. so we need to - // allocate space for it. let's see how much we - // need: we need one set if a) there is no - // neighbor behind this face, or b) the neighbor - // is not on the same level or further refined, or - // c) the neighbor is on the same level, but - // happens to have the same active_fe_index: - if (cell->at_boundary(face) - || - cell->face(face)->has_children() - || - cell->neighbor_is_coarser(face) - || - (!cell->at_boundary(face) - && - (cell->active_fe_index() == cell->neighbor(face)->active_fe_index()))) - // ok, one set of dofs. that makes one index, 1 - // times dofs_per_quad dofs, and one stop index - n_quad_slots - += (*dof_handler.finite_elements)[cell->active_fe_index()].dofs_per_quad + 2; - - // otherwise we do indeed need two sets, i.e. two - // indices, two sets of dofs, and one stop index: - else - n_quad_slots - += ((*dof_handler.finite_elements)[cell->active_fe_index()].dofs_per_quad - + - (*dof_handler.finite_elements)[cell->neighbor(face)->active_fe_index()] - .dofs_per_quad - + - 3); - - // mark this face as visited - cell->face(face)->set_user_flag (); - } + // VERTEX DOFS + reserve_space_vertices (dof_handler); + } - // now that we know how many quad dofs we will have to - // have, allocate the memory. note that we allocate - // offsets for all quads, though only the active ones will - // have a non-invalid value later on - if (true) - { - dof_handler.faces->quads.dof_offsets - = std::vector - (dof_handler.tria->n_raw_quads(), - (unsigned int)(-1)); - dof_handler.faces->quads.dofs - = std::vector (n_quad_slots, - numbers::invalid_dof_index); - } - // with the memory now allocated, loop over the - // dof_handler.cells again and prime the _offset values as - // well as the fe_index fields - const_cast&>(*dof_handler.tria) - .clear_user_flags_quad (); - unsigned int next_free_quad_slot = 0; + template + static + void + reserve_space (DoFHandler<3,spacedim> &dof_handler) + { + const unsigned int dim = 3; - for (typename HpDoFHandler::active_cell_iterator - cell=dof_handler.begin_active(); cell!=dof_handler.end(); ++cell) - for (unsigned int face=0; face::faces_per_cell; ++face) - if (! cell->face(face)->user_flag_set()) - { - // same decision tree as before - if (cell->at_boundary(face) - || - cell->face(face)->has_children() - || - cell->neighbor_is_coarser(face) - || - (!cell->at_boundary(face) - && - (cell->active_fe_index() == cell->neighbor(face)->active_fe_index()))) - { - dof_handler.faces - ->quads.dof_offsets[cell->face(face)->index()] - = next_free_quad_slot; - - // set first slot for this quad to - // active_fe_index of this face - dof_handler.faces - ->quads.dofs[next_free_quad_slot] - = cell->active_fe_index(); - - // the next dofs_per_quad indices remain unset - // for the moment (i.e. at invalid_dof_index). - // following this comes the stop index, which - // also is invalid_dof_index and therefore - // does not have to be explicitly set - - // finally, mark those slots as used - next_free_quad_slot - += (*dof_handler.finite_elements)[cell->active_fe_index()].dofs_per_quad + 2; - } - else - { - dof_handler.faces - ->quads.dof_offsets[cell->face(face)->index()] - = next_free_quad_slot; - - // set first slot for this quad to - // active_fe_index of this face - dof_handler.faces - ->quads.dofs[next_free_quad_slot] - = cell->active_fe_index(); - - // the next dofs_per_quad indices remain unset - // for the moment (i.e. at invalid_dof_index). - // - // then comes the fe_index for the neighboring - // cell: - dof_handler.faces - ->quads.dofs[next_free_quad_slot - + - (*dof_handler.finite_elements)[cell->active_fe_index()].dofs_per_quad - + - 1] - = cell->neighbor(face)->active_fe_index(); - // then again a set of dofs that we need not - // set right now - // - // following this comes the stop index, which - // also is invalid_dof_index and therefore - // does not have to be explicitly set - - // finally, mark those slots as used - next_free_quad_slot - += ((*dof_handler.finite_elements)[cell->active_fe_index()].dofs_per_quad - + - (*dof_handler.finite_elements)[cell->neighbor(face)->active_fe_index()] - .dofs_per_quad - + - 3); - } + typedef DoFHandler BaseClass; - // mark this face as visited - cell->face(face)->set_user_flag (); - } + Assert (dof_handler.finite_elements != nullptr, + typename BaseClass::ExcNoFESelected()); + Assert (dof_handler.finite_elements->size() > 0, + typename BaseClass::ExcNoFESelected()); + Assert (dof_handler.tria->n_levels() > 0, + typename BaseClass::ExcInvalidTriangulation()); + Assert (dof_handler.tria->n_levels() == dof_handler.levels.size (), + ExcInternalError ()); - // we should have moved the cursor to the total number of - // dofs. check that - Assert (next_free_quad_slot == n_quad_slots, - ExcInternalError()); + reserve_space_release_space (dof_handler); - // at the end, restore the user flags for the quads - const_cast&>(*dof_handler.tria) - .load_user_flags_quad (saved_quad_user_flags); - } + // FIRST CELLS AND FACES + reserve_space_cells (dof_handler); + reserve_space_faces (dof_handler); // LINE DOFS @@ -952,7 +755,6 @@ namespace internal } - // VERTEX DOFS reserve_space_vertices (dof_handler); } @@ -1500,9 +1302,10 @@ namespace hp // up front make sure that the fe collection is large enough to // cover all fe indices presently in use on the mesh for (active_cell_iterator cell = begin_active(); cell != end(); ++cell) - Assert (cell->active_fe_index() < finite_elements->size(), - ExcInvalidFEIndex (cell->active_fe_index(), - finite_elements->size())); + if (cell->is_locally_owned()) + Assert (cell->active_fe_index() < finite_elements->size(), + ExcInvalidFEIndex (cell->active_fe_index(), + finite_elements->size())); // then allocate space for all the other tables