16 #ifndef INCLUDE_IDEAL_II_DOFS_SLAB_DOF_HANDLER_HH_
17 #define INCLUDE_IDEAL_II_DOFS_SLAB_DOF_HANDLER_HH_
19 #include <ideal.II/distributed/slab_tria.hh>
21 #include <ideal.II/fe/fe_dg.hh>
23 #include <ideal.II/grid/slab_tria.hh>
25 #include <deal.II/dofs/dof_handler.h>
50 #ifdef DEAL_II_WITH_MPI
74 std::shared_ptr<dealii::DoFHandler<dim>>
81 std::shared_ptr<dealii::DoFHandler<1>>
152 const dealii::IndexSet &
156 std::shared_ptr<dealii::DoFHandler<dim>> _spatial_dof;
157 std::shared_ptr<dealii::DoFHandler<1>> _temporal_dof;
159 dealii::IndexSet _locally_owned_dofs;
Actual DoFHandler for a specific slab.
Definition: slab_dof_handler.hh:43
unsigned int n_dofs_spacetime()
Total number of space-time degrees of fredom on this slab.
std::shared_ptr< dealii::DoFHandler< 1 > > temporal()
The underlying temporal dof handler.
DoFHandler(const DoFHandler< dim > &other)
(shallow) copy constructor. Only the index set and fe support type are actually copied....
unsigned int n_dofs_time()
Number of temporal degrees of fredom on this slab.
unsigned int dofs_per_cell_space()
Number of spatial dofs in a single element.
spacetime::DG_FiniteElement< dim >::support_type fe_support_type()
The underlying support type used for constructing the temporal finite element.
void distribute_dofs(spacetime::DG_FiniteElement< dim > fe)
Distribute DoFs in space and time.
DoFHandler(Triangulation< dim > &tria)
Constructor linking a slab::Triangulation.
DoFHandler(slab::parallel::distributed::Triangulation< dim > &tria)
Constructor linking a parallel::distributed::slab::Triangulation.
const dealii::IndexSet & locally_owned_dofs()
Return the set of processor local dofs.
std::shared_ptr< dealii::DoFHandler< dim > > spatial()
The underlying spatial dof handler.
unsigned int n_dofs_space()
Number of spatial degrees of fredom on this slab.
unsigned int dofs_per_cell_time()
Number of temporal dofs in a single element/interval.
Actual Triangulation for a specific slab.
Definition: slab_tria.hh:35
Actual Triangulation for a specific slab with an MPI distributed spatial mesh.
Definition: slab_tria.hh:38
A class for dG elements in time and arbitrary elements in space.
Definition: fe_dg.hh:36
support_type
Choice of underlying temporal support points.
Definition: fe_dg.hh:56
Namespace for slab objects.
Definition: idealii.hh:33
typename std::list< DoFHandler< dim > >::iterator DoFHandlerIterator
A shortened type for iterators over a list of shared pointers to DoFHandler objects.
Definition: slab_dof_handler.hh:166