38 get_dpo_vector_fe_pyramid_p(
const unsigned int degree)
47 dpo.
first_object_index_on_face = {{}, {4, 3, 3, 3, 3}, {4, 3, 3, 3, 3}};
61 get_dpo_vector_fe_pyramid_dgp(
const unsigned int degree)
63 unsigned int n_dofs = 0;
75template <
int dim,
int spacedim>
77 const unsigned int degree,
111template <
int dim,
int spacedim>
114 get_dpo_vector_fe_pyramid_p(degree),
120template <
int dim,
int spacedim>
121std::unique_ptr<FiniteElement<dim, spacedim>>
124 return std::make_unique<FE_PyramidP<dim, spacedim>>(*this);
129template <
int dim,
int spacedim>
133 std::ostringstream namebuf;
134 namebuf <<
"FE_PyramidP<" << dim <<
">(" << this->degree <<
")";
136 return namebuf.str();
141template <
int dim,
int spacedim>
145 const unsigned int codim)
const
166 if (this->degree < fe_pp_other->degree)
168 else if (this->degree == fe_pp_other->degree)
176 if (this->degree < fe_p_other->degree)
178 else if (this->degree == fe_p_other->degree)
186 if (this->degree < fe_q_other->degree)
188 else if (this->degree == fe_q_other->degree)
196 if (fe_nothing->is_dominating())
211template <
int dim,
int spacedim>
212std::vector<std::pair<unsigned int, unsigned int>>
227template <
int dim,
int spacedim>
228std::vector<std::pair<unsigned int, unsigned int>>
238 std::vector<std::pair<unsigned int, unsigned int>> result;
240 for (
unsigned int i = 0; i < this->degree - 1; ++i)
241 result.emplace_back(i, i);
248template <
int dim,
int spacedim>
249std::vector<std::pair<unsigned int, unsigned int>>
252 const unsigned int face_no)
const
270 std::vector<std::pair<unsigned int, unsigned int>> result;
272 for (
unsigned int i = 0; i < this->n_dofs_per_quad(face_no); ++i)
273 result.emplace_back(i, i);
280template <
int dim,
int spacedim>
283 get_dpo_vector_fe_pyramid_dgp(degree),
289template <
int dim,
int spacedim>
290std::unique_ptr<FiniteElement<dim, spacedim>>
293 return std::make_unique<FE_PyramidDGP<dim, spacedim>>(*this);
298template <
int dim,
int spacedim>
302 std::ostringstream namebuf;
303 namebuf <<
"FE_PyramidDGP<" << dim <<
">(" << this->degree <<
")";
305 return namebuf.str();
309#include "fe_pyramid_p.inst"
std::string get_name() const override
FE_PyramidDGP(const unsigned int degree)
std::unique_ptr< FiniteElement< dim, spacedim > > clone() const override
FE_PyramidP(const unsigned int degree)
std::unique_ptr< FiniteElement< dim, spacedim > > clone() const override
std::vector< std::pair< unsigned int, unsigned int > > hp_line_dof_identities(const FiniteElement< dim, spacedim > &fe_other) const override
std::vector< std::pair< unsigned int, unsigned int > > hp_vertex_dof_identities(const FiniteElement< dim, spacedim > &fe_other) const override
std::vector< std::pair< unsigned int, unsigned int > > hp_quad_dof_identities(const FiniteElement< dim, spacedim > &fe_other, const unsigned int face_no=0) const override
std::string get_name() const override
FiniteElementDomination::Domination compare_for_domination(const FiniteElement< dim, spacedim > &fe_other, const unsigned int codim) const override
FE_PyramidPoly(const unsigned int degree, const internal::GenericDoFsPerObject &dpos, const typename FiniteElementData< dim >::Conformity conformity)
const unsigned int degree
std::vector< Point< dim > > unit_support_points
#define DEAL_II_NAMESPACE_OPEN
#define DEAL_II_NAMESPACE_CLOSE
static ::ExceptionBase & ExcNotImplemented()
#define Assert(cond, exc)
static ::ExceptionBase & ExcImpossibleInDim(int arg1)
#define AssertDimension(dim1, dim2)
#define AssertIndexRange(index, range)
@ either_element_can_dominate
@ other_element_dominates
@ neither_element_dominates
void L2(Vector< number > &result, const FEValuesBase< dim > &fe, const std::vector< double > &input, const double factor=1.)
constexpr const ReferenceCell Pyramid
internal::GenericDoFsPerObject expand(const unsigned int dim, const std::vector< unsigned int > &dofs_per_object, const ::ReferenceCell reference_cell)
std::vector< std::vector< unsigned int > > object_index
std::vector< std::vector< unsigned int > > first_object_index_on_face
std::vector< std::vector< unsigned int > > dofs_per_object_inclusive
std::vector< std::vector< unsigned int > > dofs_per_object_exclusive