Doxygen API reference documentation for ideal.II
Public Member Functions | List of all members
idealii::spacetime::fixed::Triangulation< dim > Class Template Reference

The spacetime triangulation object with a fixed spatial mesh across time. More...

#include <fixed_tria.hh>

Inheritance diagram for idealii::spacetime::fixed::Triangulation< dim >:
Inheritance graph
[legend]
Collaboration diagram for idealii::spacetime::fixed::Triangulation< dim >:
Collaboration graph
[legend]

Public Member Functions

 Triangulation (dealii::types::global_cell_index max_N_intervals_per_slab=0)
 Constructor that initializes the underlying list object. More...
 
void generate (std::shared_ptr< dealii::Triangulation< dim >> space_tria, unsigned int M, double t0=0., double T=1.) override
 Generate a list of M slab triangulations with matching temporal meshes pointing to the same spatial triangulation. More...
 
void refine_global (const unsigned int times_space=1, const unsigned int times_time=1) override
 Do uniform mesh refinement in time and space. More...
 
- Public Member Functions inherited from idealii::spacetime::Triangulation< dim >
 Triangulation (dealii::types::global_cell_index max_N_intervals_per_slab=0)
 Constructor that initializes the underlying list object. More...
 
virtual void generate (std::shared_ptr< dealii::Triangulation< dim >> space_tria, unsigned int M, double t0=0., double T=1.)=0
 Generate a list of M slab triangulations with matching temporal meshes and space_tria. More...
 
unsigned int M ()
 Return the number of slabs in the triangulation.
 
slab::TriaIterator< dim > begin ()
 An iterator pointing to the first slab::Triangulation.
 
slab::TriaIterator< dim > end ()
 An iterator pointing behind the first slab::Triangulation.
 

Additional Inherited Members

- Protected Attributes inherited from idealii::spacetime::Triangulation< dim >
dealii::types::global_cell_index max_N_intervals_per_slab
 
std::list< slab::Triangulation< dim > > trias
 

Detailed Description

template<int dim>
class idealii::spacetime::fixed::Triangulation< dim >

The spacetime triangulation object with a fixed spatial mesh across time.

In practice all pointers in the list point to the same slab::Triangulation object.

Constructor & Destructor Documentation

◆ Triangulation()

template<int dim>
idealii::spacetime::fixed::Triangulation< dim >::Triangulation ( dealii::types::global_cell_index  max_N_intervals_per_slab = 0)

Constructor that initializes the underlying list object.

Parameters
max_N_intervals_per_slab.When to split a slab into two. (default 0 = never)

Member Function Documentation

◆ generate()

template<int dim>
void idealii::spacetime::fixed::Triangulation< dim >::generate ( std::shared_ptr< dealii::Triangulation< dim >>  space_tria,
unsigned int  M,
double  t0 = 0.,
double  T = 1. 
)
override

Generate a list of M slab triangulations with matching temporal meshes pointing to the same spatial triangulation.

Parameters
space_triaThe underlying spatial dealii::Triangulation to be used by all slabs.
MThe number of slabs to be created
t0The temporal startpoint. Defaults to 0.
TThe temporal endpoint. Defaults to 1.

◆ refine_global()

template<int dim>
void idealii::spacetime::fixed::Triangulation< dim >::refine_global ( const unsigned int  times_space = 1,
const unsigned int  times_time = 1 
)
overridevirtual

Do uniform mesh refinement in time and space.

Parameters
times_spaceNumber of times the spatial meshes are refined.
times_timeNumber of times the temporal meshes are refined.

Implements idealii::spacetime::Triangulation< dim >.


The documentation for this class was generated from the following file: