dune-pdelab  2.7-git
Public Types | Public Member Functions | Static Public Member Functions | Static Public Attributes | List of all members
Dune::PDELab::VariableOPBLocalFiniteElementMap< M, D, R, d, ComputationFieldType, maxP, bt > Class Template Reference

#include <dune/pdelab/finiteelementmap/variableopbfem.hh>

Public Types

typedef FiniteElementMapTraits< FiniteElementType > Traits
 

Public Member Functions

 VariableOPBLocalFiniteElementMap (const M &m, unsigned int defaultP)
 
template<class EntityType >
const Traits::FiniteElementTypefind (const EntityType &e) const
 get local basis functions for entity More...
 
const Traits::FiniteElementTypegetFEM (unsigned int p) const
 get local basis functions for a given polynomial order More...
 
const Traits::FiniteElementTypegetFEM () const
 get local basis functions for the default order More...
 
template<class EntityType >
void setOrder (const EntityType &e, unsigned int p)
 
template<class EntityType >
unsigned int getOrder (const EntityType &e) const
 
std::size_t size (GeometryType gt) const
 
std::size_t maxLocalSize () const
 

Static Public Member Functions

static constexpr bool fixedSize ()
 
static constexpr bool hasDOFs (int codim)
 

Static Public Attributes

static constexpr int dimension = d
 The dimension of the finite elements returned by this map. More...
 

Detailed Description

template<class M, class D, class R, int d, typename ComputationFieldType = R, int maxP = 6, Dune::GeometryType::BasicType bt = Dune::GeometryType::cube>
class Dune::PDELab::VariableOPBLocalFiniteElementMap< M, D, R, d, ComputationFieldType, maxP, bt >

FiniteElementMap which provides MonomialLocalFiniteElement instances, depending on the local polynomial degree

Member Typedef Documentation

◆ Traits

template<class M , class D , class R , int d, typename ComputationFieldType = R, int maxP = 6, Dune::GeometryType::BasicType bt = Dune::GeometryType::cube>
typedef FiniteElementMapTraits<FiniteElementType> Dune::PDELab::VariableOPBLocalFiniteElementMap< M, D, R, d, ComputationFieldType, maxP, bt >::Traits

Constructor & Destructor Documentation

◆ VariableOPBLocalFiniteElementMap()

template<class M , class D , class R , int d, typename ComputationFieldType = R, int maxP = 6, Dune::GeometryType::BasicType bt = Dune::GeometryType::cube>
Dune::PDELab::VariableOPBLocalFiniteElementMap< M, D, R, d, ComputationFieldType, maxP, bt >::VariableOPBLocalFiniteElementMap ( const M &  m,
unsigned int  defaultP 
)
inline

Member Function Documentation

◆ find()

template<class M , class D , class R , int d, typename ComputationFieldType = R, int maxP = 6, Dune::GeometryType::BasicType bt = Dune::GeometryType::cube>
template<class EntityType >
const Traits::FiniteElementType& Dune::PDELab::VariableOPBLocalFiniteElementMap< M, D, R, d, ComputationFieldType, maxP, bt >::find ( const EntityType &  e) const
inline

get local basis functions for entity

◆ fixedSize()

template<class M , class D , class R , int d, typename ComputationFieldType = R, int maxP = 6, Dune::GeometryType::BasicType bt = Dune::GeometryType::cube>
static constexpr bool Dune::PDELab::VariableOPBLocalFiniteElementMap< M, D, R, d, ComputationFieldType, maxP, bt >::fixedSize ( )
inlinestaticconstexpr

◆ getFEM() [1/2]

template<class M , class D , class R , int d, typename ComputationFieldType = R, int maxP = 6, Dune::GeometryType::BasicType bt = Dune::GeometryType::cube>
const Traits::FiniteElementType& Dune::PDELab::VariableOPBLocalFiniteElementMap< M, D, R, d, ComputationFieldType, maxP, bt >::getFEM ( ) const
inline

get local basis functions for the default order

◆ getFEM() [2/2]

template<class M , class D , class R , int d, typename ComputationFieldType = R, int maxP = 6, Dune::GeometryType::BasicType bt = Dune::GeometryType::cube>
const Traits::FiniteElementType& Dune::PDELab::VariableOPBLocalFiniteElementMap< M, D, R, d, ComputationFieldType, maxP, bt >::getFEM ( unsigned int  p) const
inline

get local basis functions for a given polynomial order

◆ getOrder()

template<class M , class D , class R , int d, typename ComputationFieldType = R, int maxP = 6, Dune::GeometryType::BasicType bt = Dune::GeometryType::cube>
template<class EntityType >
unsigned int Dune::PDELab::VariableOPBLocalFiniteElementMap< M, D, R, d, ComputationFieldType, maxP, bt >::getOrder ( const EntityType &  e) const
inline

◆ hasDOFs()

template<class M , class D , class R , int d, typename ComputationFieldType = R, int maxP = 6, Dune::GeometryType::BasicType bt = Dune::GeometryType::cube>
static constexpr bool Dune::PDELab::VariableOPBLocalFiniteElementMap< M, D, R, d, ComputationFieldType, maxP, bt >::hasDOFs ( int  codim)
inlinestaticconstexpr

◆ maxLocalSize()

template<class M , class D , class R , int d, typename ComputationFieldType = R, int maxP = 6, Dune::GeometryType::BasicType bt = Dune::GeometryType::cube>
std::size_t Dune::PDELab::VariableOPBLocalFiniteElementMap< M, D, R, d, ComputationFieldType, maxP, bt >::maxLocalSize ( ) const
inline

◆ setOrder()

template<class M , class D , class R , int d, typename ComputationFieldType = R, int maxP = 6, Dune::GeometryType::BasicType bt = Dune::GeometryType::cube>
template<class EntityType >
void Dune::PDELab::VariableOPBLocalFiniteElementMap< M, D, R, d, ComputationFieldType, maxP, bt >::setOrder ( const EntityType &  e,
unsigned int  p 
)
inline

◆ size()

template<class M , class D , class R , int d, typename ComputationFieldType = R, int maxP = 6, Dune::GeometryType::BasicType bt = Dune::GeometryType::cube>
std::size_t Dune::PDELab::VariableOPBLocalFiniteElementMap< M, D, R, d, ComputationFieldType, maxP, bt >::size ( GeometryType  gt) const
inline

Member Data Documentation

◆ dimension

template<class M , class D , class R , int d, typename ComputationFieldType = R, int maxP = 6, Dune::GeometryType::BasicType bt = Dune::GeometryType::cube>
constexpr int Dune::PDELab::VariableOPBLocalFiniteElementMap< M, D, R, d, ComputationFieldType, maxP, bt >::dimension = d
staticconstexpr

The dimension of the finite elements returned by this map.


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