56 "Lowest order RT_Bubbles element is degree 1, but you requested for degree 0"));
70 for (
const unsigned int ref_case :
74 const unsigned int nc = this->
reference_cell().template n_children<dim>(
77 for (
unsigned int i = 0; i < nc; ++i)
78 this->
prolongation[ref_case - 1][i].reinit(n_dofs, n_dofs);
84 const unsigned int face_no = 0;
90 for (
unsigned int i = 0; i < GeometryInfo<dim>::max_children_per_face; ++i)
93 FETools::compute_face_embedding_matrices<dim, double>(*
this,
100 unsigned int target_row = 0;
101 for (
unsigned int d = 0; d < GeometryInfo<dim>::max_children_per_face; ++d)
102 for (
unsigned int i = 0; i < face_embeddings[d].
m(); ++i)
104 for (
unsigned int j = 0; j < face_embeddings[d].
n(); ++j)
135 std::ostringstream namebuf;
136 namebuf <<
"FE_RT_Bubbles<" << dim <<
">(" << this->degree <<
")";
138 return namebuf.str();
144std::unique_ptr<FiniteElement<dim, dim>>
147 return std::make_unique<FE_RT_Bubbles<dim>>(*this);
164 const unsigned int face_no = 0;
166 this->generalized_support_points.resize(this->n_dofs_per_cell());
167 this->generalized_face_support_points[face_no].resize(
168 this->n_dofs_per_face(face_no));
171 unsigned int current = 0;
179 Assert(face_points.size() == this->n_dofs_per_face(face_no),
181 for (
unsigned int k = 0; k < this->n_dofs_per_face(face_no); ++k)
182 this->generalized_face_support_points[face_no][k] =
183 face_points.point(k);
187 for (
unsigned int face_no = 0;
188 face_no < GeometryInfo<dim>::faces_per_cell;
192 this->reference_cell(),
196 for (
unsigned int face_point = 0; face_point < face_points.size();
200 this->generalized_support_points[current] =
201 faces.
point(offset + face_point);
213 std::vector<Point<1>> pts = high.get_points();
216 pts.erase(pts.begin());
217 pts.erase(pts.end() - 1);
220 std::vector<double> wts(pts.size(), 1);
223 for (
unsigned int d = 0; d < dim; ++d)
225 std::unique_ptr<QAnisotropic<dim>> quadrature;
229 quadrature = std::make_unique<QAnisotropic<dim>>(high);
233 std::make_unique<QAnisotropic<dim>>(((d == 0) ? low : high),
234 ((d == 1) ? low : high));
238 std::make_unique<QAnisotropic<dim>>(((d == 0) ? low : high),
239 ((d == 1) ? low : high),
240 ((d == 2) ? low : high));
246 for (
unsigned int k = 0; k < quadrature->size(); ++k)
247 this->generalized_support_points[current++] = quadrature->point(k);
255std::vector<unsigned int>
259 unsigned int dofs_per_face = 1;
260 for (
unsigned int d = 1; d < dim; ++d)
261 dofs_per_face *= deg + 1;
264 const unsigned int interior_dofs =
267 std::vector<unsigned int> dpo(dim + 1);
268 dpo[dim - 1] = dofs_per_face;
269 dpo[dim] = interior_dofs;
281 return std::vector<bool>();
290 const unsigned int dofs_per_cell =
292 unsigned int dofs_per_face = deg + 1;
293 for (
unsigned int d = 2; d < dim; ++d)
294 dofs_per_face *= deg + 1;
298 std::vector<bool> ret_val(dofs_per_cell,
false);
313 std::vector<double> &nodal_values)
const
315 Assert(support_point_values.size() == this->generalized_support_points.size(),
317 this->generalized_support_points.size()));
318 Assert(nodal_values.size() == this->n_dofs_per_cell(),
320 Assert(support_point_values[0].
size() == this->n_components(),
322 this->n_components()));
326 unsigned int fbase = 0;
328 for (; f < GeometryInfo<dim>::faces_per_cell;
329 ++f, fbase += this->n_dofs_per_face(f))
331 for (
unsigned int i = 0; i < this->n_dofs_per_face(f); ++i)
333 nodal_values[fbase + i] = support_point_values[fbase + i](
339 const unsigned int istep = (this->n_dofs_per_cell() - fbase) / dim;
343 while (fbase < this->n_dofs_per_cell())
345 for (
unsigned int i = 0; i < istep; ++i)
347 nodal_values[fbase + i] = support_point_values[fbase + i](f);
358#include "fe/fe_rt_bubbles.inst"
FullMatrix< double > inverse_node_matrix
std::vector< MappingKind > mapping_kind
FE_RT_Bubbles(const unsigned int k)
virtual std::string get_name() const override
virtual std::unique_ptr< FiniteElement< dim, dim > > clone() const override
void initialize_support_points(const unsigned int rt_degree)
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
static std::vector< unsigned int > get_dpo_vector(const unsigned int degree)
static std::vector< bool > get_ria_vector(const unsigned int degree)
void initialize_quad_dof_index_permutation_and_sign_change()
unsigned int n_dofs_per_cell() const
unsigned int n_dofs_per_face(unsigned int face_no=0, unsigned int child=0) const
ReferenceCell reference_cell() const
unsigned int n_unique_faces() const
FullMatrix< double > interface_constraints
std::vector< std::vector< FullMatrix< double > > > prolongation
void invert(const FullMatrix< number2 > &M)
static unsigned int n_polynomials(const unsigned int degree)
static DataSetDescriptor face(const ReferenceCell &reference_cell, const unsigned int face_no, const bool face_orientation, const bool face_flip, const bool face_rotation, const unsigned int n_quadrature_points)
static Quadrature< dim > project_to_all_faces(const ReferenceCell &reference_cell, const hp::QCollection< dim - 1 > &quadrature)
const Point< dim > & point(const unsigned int i) const
static std::array< RefinementCase< dim >, n_refinement_cases > all_refinement_cases()
#define DEAL_II_NAMESPACE_OPEN
#define DEAL_II_NAMESPACE_CLOSE
#define DEAL_II_NOT_IMPLEMENTED()
#define Assert(cond, exc)
static ::ExceptionBase & ExcImpossibleInDim(int arg1)
#define AssertDimension(dim1, dim2)
static ::ExceptionBase & ExcInternalError()
static ::ExceptionBase & ExcDimensionMismatch(std::size_t arg1, std::size_t arg2)
static ::ExceptionBase & ExcMessage(std::string arg1)
constexpr T pow(const T base, const int iexp)
constexpr types::geometric_orientation default_geometric_orientation