Manages the family, order, etc. parameters for a given FE. More...
#include <fe_type.h>
Public Member Functions | |
FEType (const int o=1, const FEFamily f=LAGRANGE) | |
FEType (const int o=1, const FEFamily f=LAGRANGE, const int ro=THIRD, const FEFamily rf=JACOBI_20_00, const InfMapType im=CARTESIAN) | |
bool | operator== (const FEType &f2) const |
bool | operator!= (const FEType &f2) const |
bool | operator< (const FEType &f2) const |
Order | default_quadrature_order () const |
std::unique_ptr< QBase > | default_quadrature_rule (const unsigned int dim, const int extraorder=0) const |
Public Attributes | |
OrderWrapper | order |
FEFamily | family |
OrderWrapper | radial_order |
FEFamily | radial_family |
InfMapType | inf_map |
Manages the family, order, etc. parameters for a given FE.
class FEType hides (possibly multiple) FEFamily and approximation orders, thereby enabling specialized finite element families.
|
inline |
Constructor. Optionally takes the approximation Order
and the finite element family FEFamily
.
order
and base
order are the same, as with the family
and base_family
. It must be so, otherwise what we switch on would change when infinite elements are not compiled in. Definition at line 217 of file fe_type.h.
|
inline |
FEType
. The default quadrature order is calculated assuming a polynomial of degree order
and is based on integrating the mass matrix for such an element exactly. Definition at line 333 of file fe_type.h.
References libMesh::OrderWrapper::get_order(), and order.
Referenced by libMesh::FEGenericBase< FEOutputType< T >::type >::compute_periodic_constraints(), libMesh::FEGenericBase< FEOutputType< T >::type >::compute_proj_constraints(), default_quadrature_rule(), and libMesh::Elem::volume().
std::unique_ptr< QBase > libMesh::FEType::default_quadrature_rule | ( | const unsigned int | dim, |
const int | extraorder = 0 |
||
) | const |
FEType
. The default quadrature rule is based on integrating the mass matrix for such an element exactly. Higher or lower degree rules can be chosen by changing the extraorder parameter. Definition at line 31 of file fe_type.C.
References libMesh::CLOUGH, default_quadrature_order(), family, std::max(), and libMesh::SUBDIVISION.
Referenced by libMesh::ExactSolution::_compute_error(), libMesh::UniformRefinementEstimator::_estimate_error(), libMesh::System::calculate_norm(), libMesh::FEGenericBase< FEOutputType< T >::type >::coarsened_dof_values(), libMesh::ExactErrorEstimator::estimate_error(), libMesh::FEMContext::init_internal_data(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::operator()(), libMesh::WeightedPatchRecoveryErrorEstimator::EstimateError::operator()(), libMesh::PatchRecoveryErrorEstimator::EstimateError::operator()(), libMesh::BoundaryProjectSolution::operator()(), and libMesh::HPCoarsenTest::select_refinement().
|
inline |
|
inline |
An ordering to make FEType useful as a std::map key
Definition at line 288 of file fe_type.h.
References family, inf_map, order, radial_family, and radial_order.
|
inline |
Tests equality
Definition at line 265 of file fe_type.h.
References family, inf_map, order, radial_family, and radial_order.
FEFamily libMesh::FEType::family |
The type of finite element. Valid types are LAGRANGE
, HIERARCHIC
, etc...
The type of approximation in radial direction. Valid types are JACOBI_20_00
, JACOBI_30_00
, etc...
Definition at line 204 of file fe_type.h.
Referenced by libMesh::DofMap::_dof_indices(), libMesh::FEMSystem::assembly(), libMesh::FETransformationBase< OutputShape >::build(), libMesh::FEMap::build(), libMesh::FEAbstract::build(), libMesh::FEGenericBase< FEOutputType< T >::type >::build(), libMesh::FEMContext::build_new_fe(), libMesh::FEInterface::compute_constraints(), libMesh::GMVIO::copy_nodal_solution(), default_quadrature_rule(), libMesh::DofMap::distribute_dofs(), libMesh::DofMap::distribute_local_dofs_node_major(), libMesh::DofMap::distribute_local_dofs_var_major(), libMesh::DofMap::dof_indices(), libMesh::JumpErrorEstimator::estimate_error(), libMesh::FEInterface::extra_hanging_dofs(), libMesh::FEInterface::field_type(), libMesh::FEAbstract::get_family(), libMesh::System::get_info(), libMesh::FEMContext::init_internal_data(), libMesh::FEInterface::max_order(), libMesh::Variable::n_components(), libMesh::FEInterface::n_vec_dim(), libMesh::DofMap::old_dof_indices(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::operator()(), libMesh::BoundaryProjectSolution::operator()(), operator<(), operator==(), libMesh::System::read_header(), libMesh::System::read_parallel_data(), libMesh::System::read_serialized_vectors(), libMesh::DofMap::reinit(), libMesh::PetscDMWrapper::set_point_range_in_section(), libMesh::System::write_header(), libMesh::System::write_parallel_data(), libMesh::System::write_serialized_vector(), and libMesh::System::write_serialized_vectors().
InfMapType libMesh::FEType::inf_map |
The coordinate mapping type of the infinite element. When the infinite elements are defined over a surface with a separable coordinate system (sphere, spheroid, ellipsoid), the infinite elements may take advantage of this fact.
Definition at line 258 of file fe_type.h.
Referenced by libMesh::FEGenericBase< FEOutputType< T >::type >::build_InfFE(), libMesh::System::get_info(), libMesh::FEInterface::ifem_inverse_map(), libMesh::FEInterface::ifem_map(), libMesh::FEInterface::ifem_nodal_soln(), libMesh::InfFE< Dim, T_radial, T_map >::InfFE(), operator<(), operator==(), libMesh::System::read_header(), and libMesh::System::write_header().
OrderWrapper libMesh::FEType::order |
The approximation order of the element.
The approximation order in radial direction of the infinite element.
Definition at line 198 of file fe_type.h.
Referenced by libMesh::DofMap::_dof_indices(), libMesh::PetscDMWrapper::add_dofs_to_section(), libMesh::FEMContext::build_new_fe(), libMesh::FEGenericBase< FEOutputType< T >::type >::coarsened_dof_values(), libMesh::FEInterface::compute_data(), libMesh::FEGenericBase< FEOutputType< T >::type >::compute_proj_constraints(), libMesh::DofMap::constrain_p_dofs(), libMesh::GMVIO::copy_nodal_solution(), default_quadrature_order(), libMesh::DofMap::distribute_dofs(), libMesh::DofMap::distribute_local_dofs_node_major(), libMesh::DofMap::distribute_local_dofs_var_major(), libMesh::DofMap::dof_indices(), libMesh::FEInterface::dofs_on_edge(), libMesh::FEInterface::dofs_on_side(), libMesh::System::get_info(), libMesh::FEAbstract::get_order(), libMesh::FEMContext::init_internal_data(), libMesh::FESubdivision::init_shape_functions(), libMesh::Variable::n_components(), libMesh::FEInterface::n_dofs(), libMesh::FEInterface::n_dofs_at_node(), libMesh::FEInterface::n_dofs_per_elem(), libMesh::FEInterface::n_shape_functions(), libMesh::FEInterface::nodal_soln(), libMesh::DofMap::old_dof_indices(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::operator()(), libMesh::WeightedPatchRecoveryErrorEstimator::EstimateError::operator()(), libMesh::PatchRecoveryErrorEstimator::EstimateError::operator()(), operator<(), operator==(), libMesh::System::read_header(), libMesh::System::read_SCALAR_dofs(), libMesh::DofMap::reinit(), libMesh::DofMap::SCALAR_dof_indices(), libMesh::HPCoarsenTest::select_refinement(), libMesh::FEAbstract::set_fe_order(), libMesh::FEInterface::shape(), and libMesh::System::write_header().
FEFamily libMesh::FEType::radial_family |
For InfFE, family
contains the radial shape family, while base_family
contains the approximation type in circumferential direction. Valid types are LAGRANGE
, HIERARCHIC
, etc...
Definition at line 250 of file fe_type.h.
Referenced by libMesh::FEGenericBase< FEOutputType< T >::type >::build_InfFE(), libMesh::System::get_info(), libMesh::FEInterface::ifem_compute_data(), libMesh::FEInterface::ifem_nodal_soln(), libMesh::FEInterface::ifem_shape(), libMesh::InfFE< Dim, T_radial, T_map >::InfFE(), operator<(), operator==(), libMesh::System::read_header(), and libMesh::System::write_header().
OrderWrapper libMesh::FEType::radial_order |
The approximation order in the base of the infinite element.
Definition at line 237 of file fe_type.h.
Referenced by libMesh::InfFE< Dim, T_radial, T_map >::compute_data(), libMesh::InfFE< Dim, T_radial, T_map >::compute_shape_indices(), libMesh::System::get_info(), libMesh::InfFE< Dim, T_radial, T_map >::n_dofs(), libMesh::InfFE< Dim, T_radial, T_map >::n_dofs_at_node(), libMesh::InfFE< Dim, T_radial, T_map >::n_dofs_per_elem(), operator<(), operator==(), libMesh::System::read_header(), libMesh::InfFE< Dim, T_radial, T_map >::shape(), and libMesh::System::write_header().