16 #ifndef INCLUDE_IDEAL_II_DISTRIBUTED_FIXED_TRIA_HH_
17 #define INCLUDE_IDEAL_II_DISTRIBUTED_FIXED_TRIA_HH_
19 #include <ideal.II/distributed/spacetime_tria.hh>
21 #ifdef DEAL_II_WITH_MPI
43 dealii::types::global_cell_index max_N_intervals_per_slab = 0);
54 generate(std::shared_ptr<dealii::parallel::distributed::Triangulation<dim>>
62 const unsigned int times_time = 1);
The spacetime triangulation object with MPI parallel distributed spatial meshes.
Definition: spacetime_tria.hh:39
unsigned int M()
Return the number of slabs in the triangulation.
The spacetime triangulation object with a fixed MPI parallel dibstributed spatial mesh across time.
Definition: fixed_tria.hh:36
void refine_global(const unsigned int times_space=1, const unsigned int times_time=1)
Do uniform mesh refinement in time and space.
void generate(std::shared_ptr< dealii::parallel::distributed::Triangulation< dim >> space_tria, unsigned int M, double t0=0., double T=1.)
Generate a list of M slab triangulations with matching temporal meshes pointing to the same spatial t...
Triangulation(dealii::types::global_cell_index max_N_intervals_per_slab=0)
Constructor that initializes the underlying list object.
Namespace for tensor product triangulations with a single fixed spatial mesh.
Definition: idealii.hh:109