![]() |
Reference documentation for deal.II version 9.3.3
|
#include <deal.II/hp/dof_handler.h>
Public Types | |
using | cell_accessor = typename ActiveSelector::CellAccessor |
using | face_accessor = typename ActiveSelector::FaceAccessor |
using | line_iterator = typename ActiveSelector::line_iterator |
using | active_line_iterator = typename ActiveSelector::active_line_iterator |
using | quad_iterator = typename ActiveSelector::quad_iterator |
using | active_quad_iterator = typename ActiveSelector::active_quad_iterator |
using | hex_iterator = typename ActiveSelector::hex_iterator |
using | active_hex_iterator = typename ActiveSelector::active_hex_iterator |
using | active_cell_iterator = typename ActiveSelector::active_cell_iterator |
using | cell_iterator = typename ActiveSelector::cell_iterator |
using | face_iterator = typename ActiveSelector::face_iterator |
using | active_face_iterator = typename ActiveSelector::active_face_iterator |
using | level_cell_accessor = typename LevelSelector::CellAccessor |
using | level_face_accessor = typename LevelSelector::FaceAccessor |
using | level_cell_iterator = typename LevelSelector::cell_iterator |
using | level_face_iterator = typename LevelSelector::face_iterator |
using | active_fe_index_type = unsigned short int |
using | offset_type = unsigned int |
Public Member Functions | |
void | initialize (const Triangulation< dim, spacedim > &tria, const FiniteElement< dim, spacedim > &fe) |
void | initialize (const Triangulation< dim, spacedim > &tria, const hp::FECollection< dim, spacedim > &fe) |
void | set_fe (const FiniteElement< dim, spacedim > &fe) |
void | set_fe (const hp::FECollection< dim, spacedim > &fe) |
void | set_active_fe_indices (const std::vector< unsigned int > &active_fe_indices) |
void | get_active_fe_indices (std::vector< unsigned int > &active_fe_indices) const |
void | reinit (const Triangulation< dim, spacedim > &tria) |
void | distribute_dofs (const FiniteElement< dim, spacedim > &fe) |
void | distribute_dofs (const hp::FECollection< dim, spacedim > &fe) |
void | distribute_mg_dofs () |
bool | has_hp_capabilities () const |
bool | has_level_dofs () const |
bool | has_active_dofs () const |
void | initialize_local_block_info () |
void | clear () |
void | renumber_dofs (const std::vector< types::global_dof_index > &new_numbers) |
void | renumber_dofs (const unsigned int level, const std::vector< types::global_dof_index > &new_numbers) |
unsigned int | max_couplings_between_dofs () const |
unsigned int | max_couplings_between_boundary_dofs () const |
Cell iterator functions | |
cell_iterator | begin (const unsigned int level=0) const |
active_cell_iterator | begin_active (const unsigned int level=0) const |
cell_iterator | end () const |
cell_iterator | end (const unsigned int level) const |
active_cell_iterator | end_active (const unsigned int level) const |
level_cell_iterator | begin_mg (const unsigned int level=0) const |
level_cell_iterator | end_mg (const unsigned int level) const |
level_cell_iterator | end_mg () const |
Static Public Attributes | |
static const unsigned int | dimension |
static const unsigned int | space_dimension |
static const unsigned int | default_fe_index |
static const unsigned int | invalid_fe_index |
static const active_fe_index_type | invalid_active_fe_index |
Private Types | |
using | ActiveSelector = ::internal::DoFHandlerImplementation::Iterators< dim, spacedim, false > |
using | LevelSelector = ::internal::DoFHandlerImplementation::Iterators< dim, spacedim, true > |
Subscriptor functionality | |
Classes derived from Subscriptor provide a facility to subscribe to this object. This is mostly used by the SmartPointer class. | |
using | map_value_type = decltype(counter_map)::value_type |
using | map_iterator = decltype(counter_map)::iterator |
std::atomic< unsigned int > | counter |
std::map< std::string, unsigned int > | counter_map |
std::vector< std::atomic< bool > * > | validity_pointers |
const std::type_info * | object_info |
void | subscribe (std::atomic< bool > *const validity, const std::string &identifier="") const |
void | unsubscribe (std::atomic< bool > *const validity, const std::string &identifier="") const |
unsigned int | n_subscriptions () const |
template<typename StreamType > | |
void | list_subscribers (StreamType &stream) const |
void | list_subscribers () const |
static ::ExceptionBase & | ExcInUse (int arg1, std::string arg2, std::string arg3) |
static ::ExceptionBase & | ExcNoSubscriber (std::string arg1, std::string arg2) |
void | check_no_subscribers () const noexcept |
static std::mutex | mutex |
Manage the distribution and numbering of the degrees of freedom for hp- FEM algorithms. This class satisfies the MeshType concept requirements.
The purpose of this class is to allow for an enumeration of degrees of freedom in the same way as the DoFHandler class, but it allows to use a different finite element on every cell. To this end, one assigns an active_fe_index
to every cell that indicates which element within a collection of finite elements (represented by an object of type hp::FECollection) is the one that lives on this cell. The class then enumerates the degree of freedom associated with these finite elements on each cell of a triangulation and, if possible, identifies degrees of freedom at the interfaces of cells if they match. If neighboring cells have degrees of freedom along the common interface that do not immediate match (for example, if you have Q_2 and Q_3 elements meeting at a common face), then one needs to compute constraints to ensure that the resulting finite element space on the mesh remains conforming.
The whole process of working with objects of this type is explained in step-27. Many of the algorithms this class implements are described in the hp-paper.
The typical workflow for using this class is to create a mesh, assign an active FE index to every active cell, calls hp::DoFHandler::distribute_dofs(), and then assemble a linear system and solve a problem on this finite element space. However, one can skip assigning active FE indices upon mesh refinement in certain circumstances. In particular, the following rules apply:
When this class is used with either a parallel::shared::Triangulation or a parallel::distributed::Triangulation, you can only set active FE indices on cells that are locally owned, using a call such as cell->set_active_fe_index(...)
. On the other hand, setting the active FE index on ghost or artificial cells is not allowed.
Ghost cells do acquire the information what element is active on them, however: whenever you call hp::DoFHandler::distribute_dofs(), all processors that participate in the parallel mesh exchange information in such a way that the active FE index on ghost cells equals the active FE index that was set on that processor that owned that particular ghost cell. Consequently, one can query the active_fe_index
on ghost cells, just not set it by hand.
On artificial cells, no information is available about the active_fe_index
used there. That's because we don't even know whether these cells exist at all, and even if they did, the current processor does not know anything specific about them. See the glossary entry on artificial cells for more information.
During refinement and coarsening, information about the active_fe_index
of each cell will be automatically transferred.
However, using a parallel::distributed::Triangulation with an hp::DoFHandler requires additional attention during serialization, since no information on active FE indices will be automatically transferred. This has to be done manually using the prepare_for_serialization_of_active_fe_indices() and deserialize_active_fe_indices() functions. The former has to be called before parallel::distributed::Triangulation::save() is invoked, and the latter needs to be run after parallel::distributed::Triangulation::load(). If further data will be attached to the triangulation via the parallel::distributed::CellDataTransfer, parallel::distributed::SolutionTransfer, or Particles::ParticleHandler classes, all corresponding preparation and deserialization function calls need to happen in the same order. Consult the documentation of parallel::distributed::SolutionTransfer for more information.
Definition at line 125 of file dof_handler.h.
|
privateinherited |
Definition at line 316 of file dof_handler.h.
|
privateinherited |
Definition at line 318 of file dof_handler.h.
|
inherited |
An alias that is used to identify cell iterators in DoFHandler objects. The concept of iterators is discussed at length in the iterators documentation module.
The current alias works, in essence, like the corresponding Triangulation::cell_accessor alias. However, it also makes available the member functions of DoFCellAccessor, in addition to the ones already available through the CellAccessor class.
Definition at line 334 of file dof_handler.h.
|
inherited |
An alias that is used to identify iterators that point to faces. The concept of iterators is discussed at length in the iterators documentation module.
The current alias works, in essence, like the corresponding Triangulation::face_accessor alias. However, it also makes available the member functions of DoFAccessor, in addition to the ones already available through the TriaAccessor class.
Definition at line 348 of file dof_handler.h.
|
inherited |
An alias that defines an iterator over the (one-dimensional) lines of a mesh. In one-dimensional meshes, these are the cells of the mesh, whereas in two-dimensional meshes the lines are the faces of cells.
Definition at line 357 of file dof_handler.h.
|
inherited |
An alias that allows iterating over the active lines, i.e., that subset of lines that have no children. In one-dimensional meshes, these are the cells of the mesh, whereas in two-dimensional meshes the lines are the faces of cells.
In two- or three-dimensional meshes, lines without children (i.e., the active lines) are part of at least one active cell. Each such line may additionally be a child of a line of a coarser cell adjacent to a cell that is active. (This coarser neighbor would then also be active.)
Definition at line 372 of file dof_handler.h.
|
inherited |
An alias that defines an iterator over the (two-dimensional) quads of a mesh. In two-dimensional meshes, these are the cells of the mesh, whereas in three-dimensional meshes the quads are the faces of cells.
Definition at line 381 of file dof_handler.h.
|
inherited |
An alias that allows iterating over the active quads, i.e., that subset of quads that have no children. In two-dimensional meshes, these are the cells of the mesh, whereas in three-dimensional meshes the quads are the faces of cells.
In three-dimensional meshes, quads without children (i.e., the active quads) are faces of at least one active cell. Each such quad may additionally be a child of a quad face of a coarser cell adjacent to a cell that is active. (This coarser neighbor would then also be active.)
Definition at line 396 of file dof_handler.h.
|
inherited |
An alias that defines an iterator over the (three-dimensional) hexes of a mesh. This iterator only makes sense in three-dimensional meshes, where hexes are the cells of the mesh.
Definition at line 405 of file dof_handler.h.
|
inherited |
An alias that allows iterating over the active hexes of a mesh. This iterator only makes sense in three-dimensional meshes, where hexes are the cells of the mesh. Consequently, in these three-dimensional meshes, this iterator is equivalent to the active_cell_iterator
alias.
Definition at line 416 of file dof_handler.h.
|
inherited |
An alias that is used to identify active cell iterators. The concept of iterators is discussed at length in the iterators documentation module.
The current alias identifies active cells in a DoFHandler object. While the actual data type of the alias is hidden behind a few layers of (unfortunately necessary) indirections, it is in essence TriaActiveIterator<DoFCellAccessor>. The TriaActiveIterator class works like a pointer to active objects that when you dereference it yields an object of type DoFCellAccessor. DoFCellAccessor is a class that identifies properties that are specific to cells in a DoFHandler, but it is derived (and consequently inherits) from both DoFAccessor, TriaCellAccessor and TriaAccessor that describe what you can ask of more general objects (lines, faces, as well as cells) in a triangulation and DoFHandler objects.
Definition at line 438 of file dof_handler.h.
|
inherited |
An alias that is used to identify cell iterators. The concept of iterators is discussed at length in the iterators documentation module.
The current alias identifies cells in a DoFHandler object. Some of these cells may in fact be active (see active cell iterators) in which case they can in fact be asked for the degrees of freedom that live on them. On the other hand, if the cell is not active, any such query will result in an error. Note that this is what distinguishes this alias from the level_cell_iterator alias.
While the actual data type of the alias is hidden behind a few layers of (unfortunately necessary) indirections, it is in essence TriaIterator<DoFCellAccessor>. The TriaIterator class works like a pointer to objects that when you dereference it yields an object of type DoFCellAccessor. DoFCellAccessor is a class that identifies properties that are specific to cells in a DoFHandler, but it is derived (and consequently inherits) from both DoFAccessor, TriaCellAccessor and TriaAccessor that describe what you can ask of more general objects (lines, faces, as well as cells) in a triangulation and DoFHandler objects.
Definition at line 466 of file dof_handler.h.
|
inherited |
An alias that is used to identify iterators that point to faces. The concept of iterators is discussed at length in the iterators documentation module.
While the actual data type of the alias is hidden behind a few layers of (unfortunately necessary) indirections, it is in essence TriaIterator<DoFAccessor>. The TriaIterator class works like a pointer to objects that when you dereference it yields an object of type DoFAccessor. DoFAccessor, in turn, is a class that can be used to query DoF indices on faces, but it is also derived from TriaAccessor and consequently can be used to query geometric properties such as vertices of faces, their area, etc.
Definition at line 484 of file dof_handler.h.
|
inherited |
An alias that is used to identify iterators that point to active faces, i.e., to faces that have no children. Active faces must be faces of at least one active cell.
Other than the "active" qualification, this alias is identical to the face_iterator
alias. In particular, dereferencing either yields the same kind of object.
Definition at line 497 of file dof_handler.h.
|
inherited |
Definition at line 499 of file dof_handler.h.
|
inherited |
Definition at line 500 of file dof_handler.h.
|
inherited |
Definition at line 502 of file dof_handler.h.
|
inherited |
Definition at line 503 of file dof_handler.h.
|
inherited |
The type in which we store the active FE index.
Definition at line 529 of file dof_handler.h.
|
inherited |
The type in which we store the offsets in the CRS data structures.
Definition at line 534 of file dof_handler.h.
|
inherited |
Assign a Triangulation and a FiniteElement to the DoFHandler and compute the distribution of degrees of freedom over the mesh.
|
inherited |
Same as above but taking an hp::FECollection object.
|
inherited |
Assign a FiniteElement fe
to this object.
|
inherited |
Same as above but taking an hp::FECollection object.
|
inherited |
Go through the triangulation and set the active FE indices of all active cells to the values given in active_fe_indices
.
|
inherited |
Go through the triangulation and store the active FE indices of all active cells to the vector active_fe_indices
. This vector is resized, if necessary.
|
inherited |
Assign a Triangulation to the DoFHandler.
Remove all associations with the previous Triangulation object and establish connections with the new one. All information about previous degrees of freedom will be removed. Activates hp-mode.
|
inherited |
Go through the triangulation and "distribute" the degrees of freedom needed for the given finite element. "Distributing" degrees of freedom involves allocating memory to store the indices on all entities on which degrees of freedom can be located (e.g., vertices, edges, faces, etc.) and to then enumerate all degrees of freedom. In other words, while the mesh and the finite element object by themselves simply define a finite element space V_h, the process of distributing degrees of freedom makes sure that there is a basis for this space and that the shape functions of this basis are enumerated in an indexable, predictable way.
The exact order in which degrees of freedom on a mesh are ordered, i.e., the order in which basis functions of the finite element space are enumerated, is something that deal.II treats as an implementation detail. By and large, degrees of freedom are enumerated in the same order in which we traverse cells, but you should not rely on any specific numbering. In contrast, if you want a particular ordering, use the functions in namespace DoFRenumbering.
This function is first discussed in the introduction to the step-2 tutorial program.
|
inherited |
Same as above but taking an hp::FECollection object.
|
inherited |
Distribute level degrees of freedom on each level for geometric multigrid. The active DoFs need to be distributed using distribute_dofs() before calling this function.
|
inherited |
Returns whether this DoFHandler has hp-capabilities.
|
inherited |
This function returns whether this DoFHandler has DoFs distributed on each multigrid level or in other words if distribute_mg_dofs() has been called.
|
inherited |
This function returns whether this DoFHandler has active DoFs. This is equivalent to asking whether (i) distribute_dofs() has been called and (ii) the finite element for which degrees of freedom have been distributed actually has degrees of freedom (which is not the case for FE_Nothing, for example).
If this object is based on a parallel::distributed::Triangulation, then the current function returns true if any partition of the parallel DoFHandler object has any degrees of freedom. In other words, the function returns true even if the Triangulation does not own any active cells on the current MPI process, but at least one process owns cells and at least this one process has any degrees of freedom associated with it.
|
inherited |
After distribute_dofs() with an FESystem element, the block structure of global and level vectors is stored in a BlockInfo object accessible with block_info(). This function initializes the local block structure on each cell in the same object.
|
inherited |
Clear all data of this object.
|
inherited |
Renumber degrees of freedom based on a list of new DoF indices for each of the degrees of freedom.
This function is called by the functions in DoFRenumbering function after computing a new ordering of the degree of freedom indices. However, it can of course also be called from user code.
i
is currently locally owned, then new_numbers[locally_owned_dofs().index_within_set(i)]
returns the new global DoF index of i
. Since the IndexSet of locally_owned_dofs() is complete in the sequential case, the latter convention for the content of the array reduces to the former in the case that only one processor participates in the mesh.true
) are of course affected by the exact renumbering performed here. For example, while the initial numbering of DoF indices done in distribute_dofs() yields a contiguous numbering, the renumbering performed by DoFRenumbering::component_wise() will, in general, not yield contiguous locally owned DoF indices.
|
inherited |
The same function as above, but renumber the degrees of freedom of a single level of a multigrid hierarchy.
|
inherited |
Return the maximum number of degrees of freedom a degree of freedom in the given triangulation with the given finite element may couple with. This is the maximum number of entries per line in the system matrix; this information can therefore be used upon construction of the SparsityPattern object.
The returned number is not really the maximum number but an estimate based on the finite element and the maximum number of cells meeting at a vertex. The number holds for the constrained matrix as well.
The determination of the number of couplings can be done by simple picture drawing. An example can be found in the implementation of this function.
|
inherited |
Return the number of degrees of freedom located on the boundary another dof on the boundary can couple with.
The number is the same as for max_couplings_between_dofs() in one dimension less.
|
inherited |
Iterator to the first used cell on level level
.
|
inherited |
Iterator to the first active cell on level level
. If the given level does not contain any active cells (i.e., all cells on this level are further refined), then this function returns end_active(level)
so that loops of the kind
have zero iterations, as may be expected if there are no active cells on this level.
|
inherited |
Iterator past the end; this iterator serves for comparisons of iterators with past-the-end or before-the-beginning states.
|
inherited |
Return an iterator which is the first iterator not on the given level. If level
is the last level, then this returns end()
.
|
inherited |
Return an active iterator which is the first active iterator not on the given level. If level
is the last level, then this returns end()
.
|
inherited |
Iterator to the first used cell on level level
. This returns a level_cell_iterator that returns level dofs when dof_indices() is called.
|
inherited |
Iterator past the last cell on level level
. This returns a level_cell_iterator that returns level dofs when dof_indices() is called.
|
inherited |
Iterator past the end; this iterator serves for comparisons of iterators with past-the-end or before-the-beginning states.
|
inherited |
Return an iterator range that contains all cells (active or not) that make up this DoFHandler. Such a range is useful to initialize range-based for loops as supported by C++11. See the example in the documentation of active_cell_iterators().
|
inherited |
Return an iterator range that contains all active cells that make up this DoFHandler. Such a range is useful to initialize range-based for loops as supported by C++11, see also C++11 standard.
Range-based for loops are useful in that they require much less code than traditional loops (see here for a discussion of how they work). An example is that without range-based for loops, one often writes code such as the following:
Using C++11's range-based for loops, this is now entirely equivalent to the following:
[this->begin_active(), this->end())
|
inherited |
Return an iterator range that contains all cells (active or not) that make up this DoFHandler in their level-cell form. Such a range is useful to initialize range-based for loops as supported by C++11. See the example in the documentation of active_cell_iterators().
[this->begin_mg(), this->end_mg())
|
inherited |
Return an iterator range that contains all cells (active or not) that make up the given level of this DoFHandler. Such a range is useful to initialize range-based for loops as supported by C++11. See the example in the documentation of active_cell_iterators().
[in] | level | A given level in the refinement hierarchy of this triangulation. |
[this->begin(level), this->end(level))
|
inherited |
Return an iterator range that contains all active cells that make up the given level of this DoFHandler. Such a range is useful to initialize range-based for loops as supported by C++11. See the example in the documentation of active_cell_iterators().
[in] | level | A given level in the refinement hierarchy of this triangulation. |
[this->begin_active(level), this->end(level))
|
inherited |
Return an iterator range that contains all cells (active or not) that make up the given level of this DoFHandler in their level-cell form. Such a range is useful to initialize range-based for loops as supported by C++11. See the example in the documentation of active_cell_iterators().
[in] | level | A given level in the refinement hierarchy of this triangulation. |
[this->begin_mg(level), this->end_mg(level))
|
inherited |
Return the global number of degrees of freedom. If the current object handles all degrees of freedom itself (even if you may intend to solve your linear system in parallel, such as in step-17 or step-18), then this number equals the number of locally owned degrees of freedom since this object doesn't know anything about what you want to do with it and believes that it owns every degree of freedom it knows about.
On the other hand, if this object operates on a parallel::distributed::Triangulation object, then this function returns the global number of degrees of freedom, accumulated over all processors.
In either case, included in the returned number are those DoFs which are constrained by hanging nodes, see Constraints on degrees of freedom.
Mathematically speaking, the number returned by this function equals the dimension of the finite element space (without taking into account constraints) that corresponds to (i) the mesh on which it is defined, and (ii) the finite element that is used by the current object. It also, of course, equals the number of shape functions that span this space.
|
inherited |
The (global) number of multilevel degrees of freedom on a given level.
If no level degrees of freedom have been assigned to this level, returns numbers::invalid_dof_index. Else returns the number of degrees of freedom on this level.
|
inherited |
Return the number of locally owned degrees of freedom located on the boundary.
|
inherited |
Return the number of locally owned degrees of freedom located on those parts of the boundary which have a boundary indicator listed in the given set. The reason that a map
rather than a set
is used is the same as described in the documentation of that variant of DoFTools::make_boundary_sparsity_pattern() that takes a map.
There is, however, another overload of this function that takes a set
argument (see below).
|
inherited |
Return the number of degrees of freedom located on those parts of the boundary which have a boundary indicator listed in the given set. The
|
inherited |
Access to an object informing of the block structure of the dof handler.
If an FESystem is used in distribute_dofs(), degrees of freedom naturally split into several blocks. For each base element as many blocks appear as its multiplicity.
At the end of distribute_dofs(), the number of degrees of freedom in each block is counted, and stored in a BlockInfo object, which can be accessed here. If you have previously called distribute_mg_dofs(), the same is done on each level of the multigrid hierarchy. Additionally, the block structure on each cell can be generated in this object by calling initialize_local_block_info().
|
inherited |
Return the number of degrees of freedom that belong to this process.
If this is a sequential DoFHandler, then the result equals that produced by n_dofs(). (Here, "sequential" means that either the whole program does not use MPI, or that it uses MPI but only uses a single MPI process, or that there are multiple MPI processes but the Triangulation on which this DoFHandler builds works only on one MPI process.) On the other hand, if we are operating on a parallel::distributed::Triangulation or parallel::shared::Triangulation, then it includes only the degrees of freedom that the current processor owns. Note that in this case this does not include all degrees of freedom that have been distributed on the current processor's image of the mesh: in particular, some of the degrees of freedom on the interface between the cells owned by this processor and cells owned by other processors may be theirs, and degrees of freedom on ghost cells are also not necessarily included.
|
inherited |
Return an IndexSet describing the set of locally owned DoFs as a subset of 0..n_dofs(). The number of elements of this set equals n_locally_owned_dofs().
|
inherited |
Return an IndexSet describing the set of locally owned DoFs used for the given multigrid level as a subset of 0..n_dofs(level).
|
inherited |
Return a vector that stores the locally owned DoFs of each processor.
Utilities::MPI::all_gather(comm,
locally_owned_dofs())
upon the first invocation, including global communication. Use Utilities::MPI::all_gather(comm, dof_handler.locally_owned_dofs())
instead if using up to a few thousands of MPI ranks or some variant involving local communication with more processors.
|
inherited |
Return a vector that stores the number of degrees of freedom each processor that participates in this triangulation owns locally. The sum of all these numbers equals the number of degrees of freedom that exist globally, i.e. what n_dofs() returns.
Utilities::MPI::all_gather(comm, n_locally_owned_dofs()
upon the first invocation, including global communication. Use Utilities::MPI::all_gather(comm, dof_handler.n_locally_owned_dofs()
instead if using up to a few thousands of MPI ranks or some variant involving local communication with more processors.
|
inherited |
Return a vector that stores the locally owned DoFs of each processor on the given level level
.
Utilities::MPI::all_gather(comm,
locally_owned_dofs_mg())
upon the first invocation, including global communication. Use Utilities::MPI::all_gather(comm, dof_handler.locally_owned_dofs_mg())
instead if using up to a few thousands of MPI ranks or some variant involving local communication with more processors.
|
inherited |
Return a constant reference to the indexth finite element object that is used by this object.
|
inherited |
Return a constant reference to the set of finite element objects that are used by this object.
|
inherited |
Return a constant reference to the triangulation underlying this object.
|
inherited |
Return MPI communicator used by the underlying triangulation.
|
inherited |
Whenever serialization with a parallel::distributed::Triangulation as the underlying triangulation is considered, we also need to consider storing the active FE indices on all active cells as well.
This function registers that these indices are to be stored whenever the parallel::distributed::Triangulation::save() function is called on the underlying triangulation.
|
inherited |
Whenever serialization with a parallel::distributed::Triangulation as the underlying triangulation is considered, we also need to consider storing the active FE indices on all active cells as well.
This function deserializes and distributes the previously stored active FE indices on all active cells.
|
virtualinherited |
Determine an estimate for the memory consumption (in bytes) of this object.
This function is made virtual, since a dof handler object might be accessed through a pointers to this base class, although the actual object might be a derived class.
|
inherited |
Write the data of this object to a stream for the purpose of serialization using the BOOST serialization library.
|
inherited |
Read the data of this object from a stream for the purpose of serialization using the BOOST serialization library.
|
inherited |
Write and read the data of this object from a stream for the purpose of serialization using the BOOST serialization library.
|
staticinherited |
Exception
|
staticinherited |
Exception
|
staticinherited |
Exception
|
staticinherited |
Exception
|
staticinherited |
Exception
|
staticinherited |
Exception used when a certain feature doesn't make sense when DoFHandler does not hp-capabilities.
|
staticinherited |
Exception used when a certain feature is not implemented when the DoFHandler has hp-capabilities.
|
privateinherited |
Free all memory used for non-multigrid data structures.
|
privateinherited |
Free all memory used for multigrid data structures.
|
privateinherited |
Return dof index of specified object.
|
privateinherited |
Return dof index of specified object.
|
privateinherited |
Set up DoFHandler policy.
|
privateinherited |
Set up connections to signals of the underlying triangulation.
|
privateinherited |
Create default tables for the active and future fe_indices.
Active indices are initialized with a zero indicator, meaning that fe[0] is going to be used by default. Future indices are initialized with an invalid indicator, meaning that no p-adaptation is scheduled by default.
This method is called upon construction and whenever the underlying triangulation gets created. This ensures that each cell has a valid active and future fe_index.
|
privateinherited |
Update tables for active and future fe_indices.
Whenever the underlying triangulation changes (either by adaptation or deserialization), active and future FE index tables will be adjusted to the current structure of the triangulation. Missing values of active and future indices will be initialized with their defaults (see create_active_fe_table()).
This method is called post refinement and post deserialization. This ensures that each cell has a valid active and future fe_index.
|
privateinherited |
A function that will be triggered through a triangulation signal just before the associated Triangulation or parallel::shared::Triangulation is modified.
The function that stores the active FE indices of all cells that will be refined or coarsened before the refinement happens, so that they can be set again after refinement.
|
privateinherited |
A function that will be triggered through a triangulation signal just after the associated Triangulation or parallel::shared::Triangulation is modified.
The function that restores the active FE indices of all cells that were refined or coarsened.
|
privateinherited |
A function that will be triggered through a triangulation signal just before the associated parallel::distributed::Triangulation is modified.
The function that stores all active FE indices on locally owned cells for distribution over all participating processors.
|
privateinherited |
A function that will be triggered through a triangulation signal just after the associated parallel::distributed::Triangulation is modified.
The function that restores all active FE indices on locally owned cells that have been communicated.
|
staticinherited |
Make the dimension available in function templates.
Definition at line 509 of file dof_handler.h.
|
staticinherited |
Make the space dimension available in function templates.
Definition at line 514 of file dof_handler.h.
|
staticinherited |
The default index of the finite element to be used on a given cell.
Definition at line 519 of file dof_handler.h.
|
staticinherited |
Invalid index of the finite element to be used on a given cell.
Definition at line 524 of file dof_handler.h.
|
staticinherited |
Invalid active FE index which will be used as a default value to determine whether a future FE index has been set or not.
Definition at line 540 of file dof_handler.h.
|
privateinherited |
An object containing information on the block structure.
Definition at line 1531 of file dof_handler.h.
|
privateinherited |
Boolean indicating whether or not the current DoFHandler has hp- capabilities.
Definition at line 1537 of file dof_handler.h.
|
privateinherited |
Address of the triangulation to work on.
Definition at line 1543 of file dof_handler.h.
|
privateinherited |
Store a hp::FECollection object. If only a single FiniteElement is used during initialization of this object, it contains the (one) FiniteElement.
Definition at line 1550 of file dof_handler.h.
|
privateinherited |
An object that describes how degrees of freedom should be distributed and renumbered.
Definition at line 1558 of file dof_handler.h.
|
privateinherited |
A structure that contains all sorts of numbers that characterize the degrees of freedom this object works on.
For most members of this structure, there is an accessor function in this class that returns its value.
Definition at line 1567 of file dof_handler.h.
|
privateinherited |
Data structure like number_cache, but for each multigrid level.
Definition at line 1573 of file dof_handler.h.
|
mutableprivateinherited |
Cached indices of the degrees of freedom of all active cell. Identification of the appropriate position of a cell in the vectors is done via cell_dof_cache_ptr (CRS scheme).
Definition at line 1581 of file dof_handler.h.
|
mutableprivateinherited |
Pointer to the first cached degree of freedom of an active cell (identified by level and level index) within cell_dof_cache_indices.
Definition at line 1587 of file dof_handler.h.
|
mutableprivateinherited |
Indices of degree of freedom of each d+1 geometric object (3D: vertex, line, quad, hex) for all relevant active finite elements. Identification of the appropriate position is done via object_dof_ptr (CRS scheme).
Definition at line 1595 of file dof_handler.h.
|
mutableprivateinherited |
Pointer to the first cached degree of freedom of a geometric object for all relevant active finite elements.
Definition at line 1606 of file dof_handler.h.
|
mutableprivateinherited |
Active FE indices of each geometric object. Identification of the appropriate position of a cell in the vectors is done via hp_object_fe_ptr (CRS scheme).
Definition at line 1614 of file dof_handler.h.
|
mutableprivateinherited |
Pointer to the first FE index of a geometric object.
Definition at line 1619 of file dof_handler.h.
|
mutableprivateinherited |
Active FE index of an active cell (identified by level and level index). This vector is only used in hp-mode.
Definition at line 1626 of file dof_handler.h.
|
mutableprivateinherited |
Future FE index of an active cell (identified by level and level index). This vector is only used in hp-mode.
Definition at line 1633 of file dof_handler.h.
|
privateinherited |
An array to store the indices for level degrees of freedom located at vertices.
Definition at line 1639 of file dof_handler.h.
|
privateinherited |
Space to store the DoF numbers for the different multigrid levels.
Definition at line 1646 of file dof_handler.h.
|
privateinherited |
Space to store DoF numbers of faces in the multigrid context.
Definition at line 1652 of file dof_handler.h.
|
privateinherited |
We embed our data structure into a pointer to control that all transfer related data only exists during the actual transfer process.
Definition at line 1658 of file dof_handler.h.
|
privateinherited |
A list of connections with which this object connects to the triangulation to get information about when the triangulation changes.
Definition at line 1664 of file dof_handler.h.
|
privateinherited |
A list of connections with which this object connects to the triangulation. They get triggered specifically when data needs to be transferred due to refinement or repartitioning. Only active in hp-mode.
Definition at line 1671 of file dof_handler.h.