Reference documentation for deal.II version 9.1.1
|
#include <deal.II/fe/fe_tools.h>
Public Member Functions | |
virtual std::unique_ptr< FiniteElement< FE::dimension, FE::space_dimension > > | get (const unsigned int degree) const override |
virtual std::unique_ptr< FiniteElement< FE::dimension, FE::space_dimension > > | get (const Quadrature< 1 > &quad) const override |
Public Member Functions inherited from FETools::FEFactoryBase< FE::dimension, FE::space_dimension > | |
virtual | ~FEFactoryBase () override=default |
Public Member Functions inherited from Subscriptor | |
Subscriptor () | |
Subscriptor (const Subscriptor &) | |
Subscriptor (Subscriptor &&) noexcept | |
virtual | ~Subscriptor () |
Subscriptor & | operator= (const Subscriptor &) |
Subscriptor & | operator= (Subscriptor &&) noexcept |
void | subscribe (std::atomic< bool > *const validity, const std::string &identifier="") const |
void | unsubscribe (std::atomic< bool > *const validity, const std::string &identifier="") const |
unsigned int | n_subscriptions () const |
template<typename StreamType > | |
void | list_subscribers (StreamType &stream) const |
void | list_subscribers () const |
template<class Archive > | |
void | serialize (Archive &ar, const unsigned int version) |
Additional Inherited Members | |
Static Public Member Functions inherited from Subscriptor | |
static ::ExceptionBase & | ExcInUse (int arg1, std::string arg2, std::string arg3) |
static ::ExceptionBase & | ExcNoSubscriber (std::string arg1, std::string arg2) |
A concrete class for factory objects creating finite elements of a given degree.
The class's get() function generates a finite element object of the type given as template argument, and with the degree (however the finite element class wishes to interpret this number) given as argument to get().
Definition at line 124 of file fe_tools.h.
|
overridevirtual |
Create a FiniteElement and return a pointer to it.
Implements FETools::FEFactoryBase< FE::dimension, FE::space_dimension >.
|
overridevirtual |
Create a FiniteElement from a quadrature formula (currently only implemented for FE_Q) and return a pointer to it.
Implements FETools::FEFactoryBase< FE::dimension, FE::space_dimension >.