91 const unsigned int face_no = 0;
96 for (
unsigned int i = 0; i < GeometryInfo<dim>::max_children_per_face; ++i)
106 unsigned int target_row = 0;
107 for (
unsigned int d = 0; d < GeometryInfo<dim>::max_children_per_face; ++d)
108 for (
unsigned int i = 0; i < face_embeddings[d].
m(); ++i)
110 for (
unsigned int j = 0; j < face_embeddings[d].
n(); ++j)
137 std::ostringstream namebuf;
138 namebuf <<
"FE_RaviartThomas<" << dim <<
">(" << this->
degree - 1 <<
")";
140 return namebuf.str();
145std::unique_ptr<FiniteElement<dim, dim>>
148 return std::make_unique<FE_RaviartThomas<dim>>(*this);
162 const unsigned int n_interior_points = (deg > 0) ? cell_quadrature.size() : 0;
167 const unsigned int face_no = 0;
169 unsigned int n_face_points = (dim > 1) ? 1 : 0;
171 for (
unsigned int d = 1; d < dim; ++d)
172 n_face_points *= deg + 1;
180 unsigned int current = 0;
184 const QGauss<dim - 1> face_points(deg + 1);
190 for (
unsigned int k = 0; k < n_face_points; ++k)
193 face_points.point(k);
197 for (
unsigned int i = 0; i < legendre.n(); ++i)
200 face_points.weight(k) *
201 legendre.compute_value(i, face_points.point(k));
208 for (; current < GeometryInfo<dim>::faces_per_cell * n_face_points;
226 std::unique_ptr<AnisotropicPolynomials<dim>> polynomials[dim];
227 for (
unsigned int dd = 0; dd < dim; ++dd)
229 std::vector<std::vector<Polynomials::Polynomial<double>>> poly(dim);
230 for (
unsigned int d = 0; d < dim; ++d)
234 polynomials[dd] = std::make_unique<AnisotropicPolynomials<dim>>(poly);
240 for (
unsigned int k = 0; k < cell_quadrature.size(); ++k)
243 for (
unsigned int i = 0; i < polynomials[0]->n(); ++i)
244 for (
unsigned int d = 0; d < dim; ++d)
246 cell_quadrature.weight(k) *
247 polynomials[d]->compute_value(i, cell_quadrature.point(k));
271 const unsigned int face_no = 0;
334 for (
unsigned int local_face_dof = 0;
339 unsigned int i = local_face_dof % n;
340 unsigned int j = local_face_dof / n;
345 for (
const bool face_orientation : {
false,
true})
346 for (
const bool face_flip : {
false,
true})
347 for (
const bool face_rotation : {
false,
true})
354 if (((!face_orientation) && (!face_rotation)) ||
355 ((face_orientation) && (face_rotation)))
360 ->adjust_quad_dof_index_for_face_orientation_table[face_no](
361 local_face_dof, case_no) = j + i * n - local_face_dof;
367 ->adjust_quad_dof_index_for_face_orientation_table[face_no](
368 local_face_dof, case_no) = 0;
372 const unsigned int new_local_face_dof =
375 local_face_dof, case_no);
377 i = new_local_face_dof % n;
378 j = new_local_face_dof / n;
385 if (!face_flip && face_rotation)
388 ->adjust_quad_dof_sign_for_face_orientation_table[face_no](
389 local_face_dof, case_no) = ((j % 2) == 1);
392 else if (face_flip && !face_rotation)
397 ->adjust_quad_dof_sign_for_face_orientation_table[face_no](
398 local_face_dof, case_no) =
399 ((j % 2) == 1) != ((i % 2) == 1);
402 else if (face_flip && face_rotation)
405 ->adjust_quad_dof_sign_for_face_orientation_table[face_no](
406 local_face_dof, case_no) = ((i % 2) == 1);
416 if (!face_orientation)
418 local_face_dof, case_no) =
421 local_face_dof, case_no);
434 for (
unsigned int i = 0; i < GeometryInfo<1>::max_children_per_cell; ++i)
457 const unsigned int n_face_points = q_base.size();
473 for (
unsigned int k = 0; k < q_face.
size(); ++k)
478 for (
unsigned int sub = 0; sub < GeometryInfo<dim>::max_children_per_face;
502 for (
unsigned int k = 0; k < n_face_points; ++k)
503 for (
unsigned int i_child = 0; i_child < this->n_dofs_per_cell();
505 for (
unsigned int i_face = 0;
515 face * this->n_dofs_per_face(face) + i_face, i_child) +=
517 cached_values_on_face(i_child, k) *
519 face * this->n_dofs_per_face(face) + i_face,
531 std::unique_ptr<AnisotropicPolynomials<dim>> polynomials[dim];
532 for (
unsigned int dd = 0; dd < dim; ++dd)
534 std::vector<std::vector<Polynomials::Polynomial<double>>> poly(dim);
535 for (
unsigned int d = 0; d < dim; ++d)
541 polynomials[dd] = std::make_unique<AnisotropicPolynomials<dim>>(poly);
547 const unsigned int face_no = 0;
550 const unsigned int start_cell_dofs =
559 for (
unsigned int k = 0; k < q_cell.size(); ++k)
561 for (
unsigned int d = 0; d < dim; ++d)
562 cached_values_on_cell(i, k, d) =
565 for (
unsigned int child = 0; child < GeometryInfo<dim>::max_children_per_cell;
573 for (
unsigned int k = 0; k < q_sub.
size(); ++k)
574 for (
unsigned int i_child = 0; i_child < this->n_dofs_per_cell();
576 for (
unsigned int d = 0; d < dim; ++d)
577 for (
unsigned int i_weight = 0; i_weight < polynomials[d]->n();
580 this->
restriction[iso][child](start_cell_dofs + i_weight * dim +
583 q_sub.
weight(k) * cached_values_on_cell(i_child, k, d) *
584 polynomials[d]->compute_value(i_weight, q_sub.
point(k));
592std::vector<unsigned int>
598 for (
unsigned int d = 1; d < dim; ++d)
602 const unsigned int interior_dofs = dim * deg *
dofs_per_face;
604 std::vector<unsigned int> dpo(dim + 1);
606 dpo[dim] = interior_dofs;
614std::pair<Table<2, bool>, std::vector<unsigned int>>
618 for (
unsigned int d = 0; d < dim; ++d)
620 constant_modes(d, i) =
true;
622 for (
unsigned int d = 0; d < dim; ++d)
624 return std::pair<Table<2, bool>, std::vector<unsigned int>>(constant_modes,
638 const unsigned int face_index)
const
659 return (face_index !=
681 std::vector<double> &nodal_values)
const
683 Assert(support_point_values.size() == this->generalized_support_points.size(),
685 this->generalized_support_points.size()));
686 Assert(nodal_values.size() == this->n_dofs_per_cell(),
692 std::fill(nodal_values.begin(), nodal_values.end(), 0.);
696 for (
unsigned int k = 0; k < n_face_points; ++k)
701 support_point_values[face * n_face_points + k](
708 const unsigned int face_no = 0;
710 const unsigned int start_cell_dofs =
712 const unsigned int start_cell_points =
717 for (
unsigned int d = 0; d < dim; ++d)
718 nodal_values[start_cell_dofs + i * dim + d] +=
720 support_point_values[k + start_cell_points](d);
736#include "fe_raviart_thomas.inst"
std::vector< Table< 2, bool > > adjust_quad_dof_sign_for_face_orientation_table
FullMatrix< double > inverse_node_matrix
virtual double shape_value_component(const unsigned int i, const Point< dim > &p, const unsigned int component) const override
std::vector< MappingKind > mapping_kind
FE_PolyTensor(const TensorPolynomialsBase< dim > &polynomials, const FiniteElementData< dim > &fe_data, const std::vector< bool > &restriction_is_additive_flags, const std::vector< ComponentMask > &nonzero_components)
virtual std::size_t memory_consumption() const override
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
virtual bool has_support_on_face(const unsigned int shape_index, const unsigned int face_index) const override
void initialize_restriction()
Table< 3, double > interior_weights
virtual std::pair< Table< 2, bool >, std::vector< unsigned int > > get_constant_modes() const override
Table< 2, double > boundary_weights
void initialize_quad_dof_index_permutation_and_sign_change()
virtual std::unique_ptr< FiniteElement< dim, dim > > clone() const override
friend class FE_RaviartThomas
void initialize_support_points(const unsigned int rt_degree)
static std::vector< unsigned int > get_dpo_vector(const unsigned int degree)
virtual std::string get_name() const override
const unsigned int components
const unsigned int degree
unsigned int n_dofs_per_cell() const
const unsigned int dofs_per_face
unsigned int n_dofs_per_face(unsigned int face_no=0, unsigned int child=0) const
unsigned int tensor_degree() const
unsigned int n_components() const
ReferenceCell reference_cell() const
unsigned int n_unique_faces() const
unsigned int n_dofs_per_quad(unsigned int face_no=0) const
FiniteElementData(const std::vector< unsigned int > &dofs_per_object, const unsigned int n_components, const unsigned int degree, const Conformity conformity=unknown, const BlockIndices &block_indices=BlockIndices())
std::vector< std::vector< FullMatrix< double > > > restriction
std::vector< Table< 2, int > > adjust_quad_dof_index_for_face_orientation_table
void reinit_restriction_and_prolongation_matrices(const bool isotropic_restriction_only=false, const bool isotropic_prolongation_only=false)
std::vector< std::vector< Point< dim - 1 > > > generalized_face_support_points
FullMatrix< double > interface_constraints
std::vector< Point< dim > > generalized_support_points
std::vector< std::vector< FullMatrix< double > > > prolongation
static std::vector< Polynomial< double > > generate_complete_basis(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_child(const ReferenceCell &reference_cell, const Quadrature< dim > &quadrature, const unsigned int child_no)
static Quadrature< dim > project_to_all_faces(const ReferenceCell &reference_cell, const hp::QCollection< dim - 1 > &quadrature)
static void project_to_subface(const ReferenceCell &reference_cell, const SubQuadrature &quadrature, const unsigned int face_no, const unsigned int subface_no, std::vector< Point< dim > > &q_points, const RefinementCase< dim - 1 > &ref_case=RefinementCase< dim - 1 >::isotropic_refinement)
static void project_to_face(const ReferenceCell &reference_cell, const SubQuadrature &quadrature, const unsigned int face_no, std::vector< Point< dim > > &q_points)
const Point< dim > & point(const unsigned int i) const
double weight(const unsigned int i) const
unsigned int size() const
static constexpr unsigned char default_combined_face_orientation()
#define DEAL_II_NAMESPACE_OPEN
#define DEAL_II_NAMESPACE_CLOSE
#define Assert(cond, exc)
static ::ExceptionBase & ExcImpossibleInDim(int arg1)
#define AssertDimension(dim1, dim2)
#define AssertIndexRange(index, range)
static ::ExceptionBase & ExcInternalError()
static ::ExceptionBase & ExcDimensionMismatch(std::size_t arg1, std::size_t arg2)
#define DEAL_II_NOT_IMPLEMENTED()
constexpr T fixed_power(const T t)
unsigned char combined_face_orientation(const bool face_orientation, const bool face_rotation, const bool face_flip)
static unsigned int child_cell_on_face(const RefinementCase< dim > &ref_case, const unsigned int face, const unsigned int subface, const bool face_orientation=true, const bool face_flip=false, const bool face_rotation=false, const RefinementCase< dim - 1 > &face_refinement_case=RefinementCase< dim - 1 >::isotropic_refinement)
static constexpr unsigned int max_children_per_face
static constexpr unsigned int faces_per_cell
static std_cxx20::ranges::iota_view< unsigned int, unsigned int > face_indices()
static constexpr std::array< unsigned int, faces_per_cell > unit_normal_direction
static constexpr std::array< unsigned int, faces_per_cell > opposite_face