37 get_dpo_vector_fe_pyramid_p(
const unsigned int degree)
46 dpo.
first_object_index_on_face = {{}, {4, 3, 3, 3, 3}, {4, 3, 3, 3, 3}};
60 get_dpo_vector_fe_pyramid_dgp(
const unsigned int degree)
62 unsigned int n_dofs = 0;
74template <
int dim,
int spacedim>
76 const unsigned int degree,
101 this->reference_cell().template vertex<dim>(i));
107 const auto face_reference_cell =
110 for (
const auto i : face_reference_cell.vertex_indices())
112 face_reference_cell.template vertex<dim - 1>(i));
121template <
int dim,
int spacedim>
126 std::vector<double> &nodal_values)
const
129 this->get_unit_support_points().size());
133 for (
unsigned int i = 0; i < this->dofs_per_cell; ++i)
137 nodal_values[i] = support_point_values[i](0);
143template <
int dim,
int spacedim>
146 get_dpo_vector_fe_pyramid_p(degree),
152template <
int dim,
int spacedim>
153std::unique_ptr<FiniteElement<dim, spacedim>>
156 return std::make_unique<FE_PyramidP<dim, spacedim>>(*this);
161template <
int dim,
int spacedim>
165 std::ostringstream namebuf;
167 << this->degree <<
")";
169 return namebuf.str();
174template <
int dim,
int spacedim>
178 const unsigned int codim)
const
199 if (this->degree < fe_pp_other->degree)
201 else if (this->degree == fe_pp_other->degree)
209 if (this->degree < fe_p_other->degree)
211 else if (this->degree == fe_p_other->degree)
219 if (this->degree < fe_q_other->degree)
221 else if (this->degree == fe_q_other->degree)
229 if (fe_nothing->is_dominating())
244template <
int dim,
int spacedim>
245std::vector<std::pair<unsigned int, unsigned int>>
260template <
int dim,
int spacedim>
261std::vector<std::pair<unsigned int, unsigned int>>
271 std::vector<std::pair<unsigned int, unsigned int>> result;
273 for (
unsigned int i = 0; i < this->degree - 1; ++i)
274 result.emplace_back(i, i);
281template <
int dim,
int spacedim>
282std::vector<std::pair<unsigned int, unsigned int>>
285 const unsigned int face_no)
const
303 std::vector<std::pair<unsigned int, unsigned int>> result;
305 for (
unsigned int i = 0; i < this->n_dofs_per_quad(face_no); ++i)
306 result.emplace_back(i, i);
313template <
int dim,
int spacedim>
316 get_dpo_vector_fe_pyramid_dgp(degree),
322template <
int dim,
int spacedim>
323std::unique_ptr<FiniteElement<dim, spacedim>>
326 return std::make_unique<FE_PyramidDGP<dim, spacedim>>(*this);
331template <
int dim,
int spacedim>
335 std::ostringstream namebuf;
337 << this->degree <<
")";
339 return namebuf.str();
343#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)
virtual void convert_generalized_support_point_values_to_dof_values(const std::vector< Vector< double > > &support_point_values, std::vector< double > &nodal_values) const override
const unsigned int degree
ReferenceCell reference_cell() const
std::vector< std::vector< Point< dim - 1 > > > unit_face_support_points
std::vector< Point< dim > > unit_support_points
std_cxx20::ranges::iota_view< unsigned int, unsigned int > vertex_indices() const
unsigned int n_faces() const
ReferenceCell face_reference_cell(const unsigned int face_no) const
std_cxx20::ranges::iota_view< unsigned int, unsigned int > face_indices() const
#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)
#define DEAL_II_NOT_IMPLEMENTED()
@ either_element_can_dominate
@ other_element_dominates
@ neither_element_dominates
constexpr const ReferenceCell Pyramid
std::string dim_string(const int dim, const int spacedim)
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