Doxygen API reference documentation for ideal.II
|
Actual DoFHandler for a specific slab. More...
#include <slab_dof_handler.hh>
Public Member Functions | |
DoFHandler (Triangulation< dim > &tria) | |
Constructor linking a slab::Triangulation. More... | |
DoFHandler (slab::parallel::distributed::Triangulation< dim > &tria) | |
Constructor linking a parallel::distributed::slab::Triangulation. More... | |
DoFHandler (const DoFHandler< dim > &other) | |
(shallow) copy constructor. Only the index set and fe support type are actually copied. The underlying pointers will point to the same dealii::DoFHandler objects as other. More... | |
std::shared_ptr< dealii::DoFHandler< dim > > | spatial () |
The underlying spatial dof handler. More... | |
std::shared_ptr< dealii::DoFHandler< 1 > > | temporal () |
The underlying temporal dof handler. More... | |
void | distribute_dofs (spacetime::DG_FiniteElement< dim > fe) |
Distribute DoFs in space and time. More... | |
unsigned int | n_dofs_spacetime () |
Total number of space-time degrees of fredom on this slab. More... | |
unsigned int | n_dofs_space () |
Number of spatial degrees of fredom on this slab. More... | |
unsigned int | n_dofs_time () |
Number of temporal degrees of fredom on this slab. More... | |
unsigned int | dofs_per_cell_time () |
Number of temporal dofs in a single element/interval. More... | |
unsigned int | dofs_per_cell_space () |
Number of spatial dofs in a single element. More... | |
spacetime::DG_FiniteElement< dim >::support_type | fe_support_type () |
The underlying support type used for constructing the temporal finite element. More... | |
const dealii::IndexSet & | locally_owned_dofs () |
Return the set of processor local dofs. More... | |
Actual DoFHandler for a specific slab.
This DoFHandler actually handles a spatial and a temporal dealii::DoFHandler object internally.
Currently it is restricted to dG elements in time i.e. spacetime::DG_FiniteElement.
idealii::slab::DoFHandler< dim >::DoFHandler | ( | Triangulation< dim > & | tria | ) |
Constructor linking a slab::Triangulation.
tria | A shared pointer to a slab::Triangulation. |
idealii::slab::DoFHandler< dim >::DoFHandler | ( | slab::parallel::distributed::Triangulation< dim > & | tria | ) |
Constructor linking a parallel::distributed::slab::Triangulation.
tria | A shared pointer to a parallel::distributed::slab::Triangulation. |
idealii::slab::DoFHandler< dim >::DoFHandler | ( | const DoFHandler< dim > & | other | ) |
(shallow) copy constructor. Only the index set and fe support type are actually copied. The underlying pointers will point to the same dealii::DoFHandler objects as other.
other | The DoFHandler to shallow copy. |
void idealii::slab::DoFHandler< dim >::distribute_dofs | ( | spacetime::DG_FiniteElement< dim > | fe | ) |
Distribute DoFs in space and time.
This function calls the function of the same name of the underlying dof handler objects with the matching spatial or temporal element in fe
.
fe | The spacetime finite element to base the distribution on. |
unsigned int idealii::slab::DoFHandler< dim >::dofs_per_cell_space | ( | ) |
Number of spatial dofs in a single element.
unsigned int idealii::slab::DoFHandler< dim >::dofs_per_cell_time | ( | ) |
Number of temporal dofs in a single element/interval.
spacetime::DG_FiniteElement<dim>::support_type idealii::slab::DoFHandler< dim >::fe_support_type | ( | ) |
The underlying support type used for constructing the temporal finite element.
const dealii::IndexSet& idealii::slab::DoFHandler< dim >::locally_owned_dofs | ( | ) |
Return the set of processor local dofs.
Parallelization is done in space only. Therefore the local space-time dof indices are the local indices of the spatial DoFHandler shifted by the total number of spatial degrees of freedom. Note that the IndexSet is not contiguous and can therefore currently not be used with PETScWrapper classes.
unsigned int idealii::slab::DoFHandler< dim >::n_dofs_space | ( | ) |
Number of spatial degrees of fredom on this slab.
unsigned int idealii::slab::DoFHandler< dim >::n_dofs_spacetime | ( | ) |
Total number of space-time degrees of fredom on this slab.
unsigned int idealii::slab::DoFHandler< dim >::n_dofs_time | ( | ) |
Number of temporal degrees of fredom on this slab.
std::shared_ptr<dealii::DoFHandler<dim> > idealii::slab::DoFHandler< dim >::spatial | ( | ) |
The underlying spatial dof handler.
std::shared_ptr<dealii::DoFHandler<1> > idealii::slab::DoFHandler< dim >::temporal | ( | ) |
The underlying temporal dof handler.