40template <
int dim,
int spacedim>
47template <
int dim,
int spacedim>
56template <
int dim,
int spacedim>
59 const std::vector<bool> &r_i_a_f,
60 const std::vector<ComponentMask> &nonzero_c)
65 std::make_pair(
std::make_pair(0
U, 0
U), 0
U))
75 nonzero_c.
size() == 1 ?
82 return n_components != 1U;
83 }) == n_nonzero_components_table.end())
85 Assert(restriction_is_additive_flags.size() == this->n_dofs_per_cell(),
87 this->n_dofs_per_cell()));
89 for (
unsigned int i = 0; i < nonzero_components.size(); ++i)
91 Assert(nonzero_components[i].
size() == this->n_components(),
93 Assert(nonzero_components[i].n_selected_components() >= 1,
96 Assert(n_nonzero_components_table[i] <= this->n_components(),
103 if (this->is_primitive())
105 system_to_component_table.resize(this->n_dofs_per_cell());
106 for (
unsigned int j = 0; j < this->n_dofs_per_cell(); ++j)
107 system_to_component_table[j] = std::pair<unsigned, unsigned>(0, j);
109 face_system_to_component_table.resize(this->n_unique_faces());
110 for (
unsigned int f = 0; f < this->n_unique_faces(); ++f)
112 face_system_to_component_table[f].resize(this->n_dofs_per_face(f));
113 for (
unsigned int j = 0; j < this->n_dofs_per_face(f); ++j)
114 face_system_to_component_table[f][j] =
115 std::pair<unsigned, unsigned>(0, j);
119 for (
unsigned int j = 0; j < this->n_dofs_per_cell(); ++j)
120 system_to_base_table[j] = std::make_pair(std::make_pair(0U, 0U), j);
122 face_system_to_base_table.resize(this->n_unique_faces());
123 for (
unsigned int f = 0; f < this->n_unique_faces(); ++f)
125 face_system_to_base_table[f].resize(this->n_dofs_per_face(f));
126 for (
unsigned int j = 0; j < this->n_dofs_per_face(f); ++j)
127 face_system_to_base_table[f][j] =
128 std::make_pair(std::make_pair(0U, 0U), j);
132 base_to_block_indices.reinit(1, 1);
138 for (
const unsigned int ref_case :
142 prolongation[ref_case - 1].resize(this->
reference_cell().n_children(
145 restriction[ref_case - 1].resize(this->
reference_cell().n_children(
153 adjust_quad_dof_index_for_face_orientation_table.resize(
154 this->n_unique_2d_subobjects());
156 for (
unsigned int f = 0; f < this->n_unique_2d_subobjects(); ++f)
158 adjust_quad_dof_index_for_face_orientation_table[f] =
161 adjust_quad_dof_index_for_face_orientation_table[f].fill(0);
165 unit_face_support_points.resize(this->n_unique_faces());
166 generalized_face_support_points.resize(this->n_unique_faces());
171template <
int dim,
int spacedim>
172std::pair<std::unique_ptr<FiniteElement<dim, spacedim>>,
unsigned int>
175 return {this->clone(), multiplicity};
180template <
int dim,
int spacedim>
185 AssertThrow(
false, ExcUnitShapeValuesDoNotExist());
191template <
int dim,
int spacedim>
195 const unsigned int)
const
197 AssertThrow(
false, ExcUnitShapeValuesDoNotExist());
203template <
int dim,
int spacedim>
208 AssertThrow(
false, ExcUnitShapeValuesDoNotExist());
214template <
int dim,
int spacedim>
218 const unsigned int)
const
220 AssertThrow(
false, ExcUnitShapeValuesDoNotExist());
226template <
int dim,
int spacedim>
231 AssertThrow(
false, ExcUnitShapeValuesDoNotExist());
237template <
int dim,
int spacedim>
242 const unsigned int)
const
244 AssertThrow(
false, ExcUnitShapeValuesDoNotExist());
250template <
int dim,
int spacedim>
255 AssertThrow(
false, ExcUnitShapeValuesDoNotExist());
261template <
int dim,
int spacedim>
266 const unsigned int)
const
268 AssertThrow(
false, ExcUnitShapeValuesDoNotExist());
274template <
int dim,
int spacedim>
279 AssertThrow(
false, ExcUnitShapeValuesDoNotExist());
285template <
int dim,
int spacedim>
290 const unsigned int)
const
292 AssertThrow(
false, ExcUnitShapeValuesDoNotExist());
297template <
int dim,
int spacedim>
300 const bool isotropic_restriction_only,
301 const bool isotropic_prolongation_only)
303 for (
const unsigned int ref_case :
307 const unsigned int nc =
310 for (
unsigned int i = 0; i < nc; ++i)
312 if (this->restriction[ref_case - 1][i].m() !=
313 this->n_dofs_per_cell() &&
314 (!isotropic_restriction_only ||
316 this->restriction[ref_case - 1][i].reinit(
317 this->n_dofs_per_cell(), this->n_dofs_per_cell());
318 if (this->prolongation[ref_case - 1][i].m() !=
319 this->n_dofs_per_cell() &&
320 (!isotropic_prolongation_only ||
322 this->prolongation[ref_case - 1][i].reinit(
323 this->n_dofs_per_cell(), this->n_dofs_per_cell());
329template <
int dim,
int spacedim>
332 const unsigned int child,
339 "Restriction matrices are only available for refined cells!"));
346 Assert(restriction[refinement_case - 1][child].n() == this->n_dofs_per_cell(),
347 ExcProjectionVoid());
348 return restriction[refinement_case - 1][child];
353template <
int dim,
int spacedim>
356 const unsigned int child,
363 "Prolongation matrices are only available for refined cells!"));
372 Assert(prolongation[refinement_case - 1][child].n() ==
373 this->n_dofs_per_cell(),
375 return prolongation[refinement_case - 1][child];
380template <
int dim,
int spacedim>
383 const unsigned int index)
const
387 return first_block_of_base(component_to_base_table[index].
first.first) +
388 component_to_base_table[
index].second;
392template <
int dim,
int spacedim>
404 std::vector<bool>
mask(this->n_components(),
false);
410template <
int dim,
int spacedim>
416 this->n_components());
423 std::vector<bool>
mask(this->n_components(),
false);
432template <
int dim,
int spacedim>
439 this->n_components());
446 std::vector<bool>
mask(this->n_components(),
false);
457template <
int dim,
int spacedim>
468 std::vector<bool> component_mask(this->n_components(),
false);
469 for (
unsigned int c = 0; c < this->n_components(); ++c)
470 if (block_mask[component_to_block_index(c)] ==
true)
471 component_mask[c] =
true;
478template <
int dim,
int spacedim>
485 return block_mask(component_mask(scalar));
489template <
int dim,
int spacedim>
496 return block_mask(component_mask(vector));
500template <
int dim,
int spacedim>
507 return block_mask(component_mask(sym_tensor));
512template <
int dim,
int spacedim>
533 std::vector<bool> block_mask(this->
n_blocks(),
false);
534 for (
unsigned int c = 0; c < this->n_components();)
536 const unsigned int block = component_to_block_index(c);
537 if (component_mask[c] ==
true)
538 block_mask[block] =
true;
544 while ((c < this->n_components()) &&
545 (component_to_block_index(c) == block))
547 Assert(component_mask[c] == block_mask[block],
549 "The component mask argument given to this function "
550 "is not a mask where the individual components belonging "
551 "to one block of the finite element are either all "
552 "selected or not selected. You can't call this function "
553 "with a component mask that splits blocks."));
564template <
int dim,
int spacedim>
567 const unsigned int face_index,
568 const unsigned int face,
579 Assert((this->n_dofs_per_line() <= 1) && (this->n_dofs_per_quad(face) <= 1),
581 "The function in this base class can not handle this case. "
582 "Rather, the derived class you are using must provide "
583 "an overloaded version but apparently hasn't done so. See "
584 "the documentation of this function for more information."));
588 if (face_index < this->get_first_face_line_index(face))
593 const unsigned int face_vertex = face_index / this->n_dofs_per_vertex();
594 const unsigned int dof_index_on_vertex =
595 face_index % this->n_dofs_per_vertex();
600 face, face_vertex, combined_orientation) *
601 this->n_dofs_per_vertex() +
602 dof_index_on_vertex);
604 else if (face_index < this->get_first_face_quad_index(face))
609 const unsigned int index =
610 face_index - this->get_first_face_line_index(face);
612 const unsigned int face_line =
index / this->n_dofs_per_line();
613 const unsigned int dof_index_on_line =
index % this->n_dofs_per_line();
615 return (this->get_first_line_index() +
618 combined_orientation) *
619 this->n_dofs_per_line() +
628 const unsigned int index =
629 face_index - this->get_first_face_quad_index(face);
631 return (this->get_first_quad_index(face) + index);
637template <
int dim,
int spacedim>
640 const unsigned int index,
641 const unsigned int face,
662 const auto table_n = this->n_unique_2d_subobjects() == 1 ? 0 : face;
664 adjust_quad_dof_index_for_face_orientation_table[table_n].n_elements() ==
666 this->n_dofs_per_quad(face),
668 return index + adjust_quad_dof_index_for_face_orientation_table[table_n](
669 index, combined_orientation);
674template <
int dim,
int spacedim>
677 const unsigned int index,
685 Assert(adjust_line_dof_index_for_line_orientation_table.size() ==
686 this->n_dofs_per_line(),
691 return index + adjust_line_dof_index_for_line_orientation_table[
index];
696template <
int dim,
int spacedim>
700 for (
const unsigned int ref_case :
703 for (unsigned
int c = 0;
709 Assert((prolongation[ref_case - 1][c].m() ==
710 this->n_dofs_per_cell()) ||
711 (prolongation[ref_case - 1][c].m() == 0),
713 Assert((prolongation[ref_case - 1][c].n() ==
714 this->n_dofs_per_cell()) ||
715 (prolongation[ref_case - 1][c].n() == 0),
717 if ((prolongation[ref_case - 1][c].m() == 0) ||
718 (prolongation[ref_case - 1][c].n() == 0))
726template <
int dim,
int spacedim>
730 for (
const unsigned int ref_case :
733 for (unsigned
int c = 0;
739 Assert((restriction[ref_case - 1][c].m() ==
740 this->n_dofs_per_cell()) ||
741 (restriction[ref_case - 1][c].m() == 0),
743 Assert((restriction[ref_case - 1][c].n() ==
744 this->n_dofs_per_cell()) ||
745 (restriction[ref_case - 1][c].n() == 0),
747 if ((restriction[ref_case - 1][c].m() == 0) ||
748 (restriction[ref_case - 1][c].n() == 0))
756template <
int dim,
int spacedim>
763 for (
unsigned int c = 0;
769 Assert((prolongation[ref_case - 1][c].m() == this->n_dofs_per_cell()) ||
770 (prolongation[ref_case - 1][c].m() == 0),
772 Assert((prolongation[ref_case - 1][c].n() == this->n_dofs_per_cell()) ||
773 (prolongation[ref_case - 1][c].n() == 0),
775 if ((prolongation[ref_case - 1][c].m() == 0) ||
776 (prolongation[ref_case - 1][c].n() == 0))
784template <
int dim,
int spacedim>
791 for (
unsigned int c = 0;
797 Assert((restriction[ref_case - 1][c].m() == this->n_dofs_per_cell()) ||
798 (restriction[ref_case - 1][c].m() == 0),
800 Assert((restriction[ref_case - 1][c].n() == this->n_dofs_per_cell()) ||
801 (restriction[ref_case - 1][c].n() == 0),
803 if ((restriction[ref_case - 1][c].m() == 0) ||
804 (restriction[ref_case - 1][c].n() == 0))
812template <
int dim,
int spacedim>
819 unsigned int n_dofs_on_faces = 0;
822 n_dofs_on_faces += this->n_dofs_per_face(face_no);
824 return (n_dofs_on_faces == 0) || (interface_constraints.m() != 0);
832template <
int dim,
int spacedim>
841template <
int dim,
int spacedim>
849 [[maybe_unused]]
const unsigned int face_no = 0;
852 ExcMessage(
"Constraints for this element are only implemented "
853 "for the case that faces are refined isotropically "
854 "(which is always the case in 2d, and in 3d requires "
855 "that the neighboring cell of a coarse cell presents "
856 "exactly four children on the common face)."));
857 Assert((this->n_dofs_per_face(face_no) == 0) ||
858 (interface_constraints.m() != 0),
859 ExcMessage(
"The finite element for which you try to obtain "
860 "hanging node constraints does not appear to "
864 Assert((interface_constraints.m() == 0) && (interface_constraints.n() == 0),
865 ExcWrongInterfaceMatrixSize(interface_constraints.m(),
866 interface_constraints.n()));
868 return interface_constraints;
873template <
int dim,
int spacedim>
880 const unsigned int face_no = 0;
891 return {this->n_dofs_per_vertex() + 2 * this->n_dofs_per_line(),
892 this->n_dofs_per_face(face_no)};
901 5 * this->n_dofs_per_vertex() +
903 12 * this->n_dofs_per_line() +
905 4 * this->n_dofs_per_quad(face_no),
906 this->n_dofs_per_face(face_no)};
910 3 * this->n_dofs_per_vertex() +
911 9 * this->n_dofs_per_line() +
913 4 * this->n_dofs_per_quad(face_no),
914 this->n_dofs_per_face(face_no)};
926template <
int dim,
int spacedim>
942template <
int dim,
int spacedim>
947 const unsigned int)
const
959template <
int dim,
int spacedim>
965 const unsigned int)
const
977template <
int dim,
int spacedim>
978std::vector<std::pair<unsigned int, unsigned int>>
983 return std::vector<std::pair<unsigned int, unsigned int>>();
988template <
int dim,
int spacedim>
989std::vector<std::pair<unsigned int, unsigned int>>
994 return std::vector<std::pair<unsigned int, unsigned int>>();
999template <
int dim,
int spacedim>
1000std::vector<std::pair<unsigned int, unsigned int>>
1003 const unsigned int)
const
1006 return std::vector<std::pair<unsigned int, unsigned int>>();
1011template <
int dim,
int spacedim>
1015 const unsigned int)
const
1023template <
int dim,
int spacedim>
1030 return ((
typeid(*
this) ==
typeid(f)) && (this->get_name() == f.
get_name()) &&
1038template <
int dim,
int spacedim>
1043 return !(*
this == f);
1048template <
int dim,
int spacedim>
1049const std::vector<Point<dim>> &
1064template <
int dim,
int spacedim>
1068 if (this->dofs_per_cell > 0)
1084template <
int dim,
int spacedim>
1085const std::vector<Point<dim>> &
1090 return ((generalized_support_points.empty()) ? unit_support_points :
1091 generalized_support_points);
1096template <
int dim,
int spacedim>
1100 if (this->dofs_per_cell > 0)
1101 return (get_generalized_support_points().
size() != 0);
1115template <
int dim,
int spacedim>
1121 ExcFEHasNoSupportPoints());
1127template <
int dim,
int spacedim>
1128const std::vector<
Point<dim - 1>> &
1130 const unsigned int face_no)
const
1136 Assert((unit_face_support_points[this->n_unique_faces() == 1 ? 0 : face_no]
1138 (unit_face_support_points[this->n_unique_faces() == 1 ? 0 : face_no]
1139 .
size() == this->n_dofs_per_face(face_no)),
1141 return unit_face_support_points[this->n_unique_faces() == 1 ? 0 : face_no];
1146template <
int dim,
int spacedim>
1149 const unsigned int face_no)
const
1151 const unsigned int face_index = this->n_unique_faces() == 1 ? 0 : face_no;
1152 if (this->n_dofs_per_face(face_index) > 0)
1153 return (unit_face_support_points[face_index].
size() != 0);
1167template <
int dim,
int spacedim>
1170 const unsigned int index,
1171 const unsigned int face_no)
const
1174 Assert(unit_face_support_points[this->n_unique_faces() == 1 ? 0 : face_no]
1175 .
size() == this->n_dofs_per_face(face_no),
1176 ExcFEHasNoSupportPoints());
1177 return unit_face_support_points[this->n_unique_faces() == 1 ? 0 : face_no]
1183template <
int dim,
int spacedim>
1186 const unsigned int)
const
1193template <
int dim,
int spacedim>
1199 const unsigned int n_total_components = this->n_components();
1200 Assert((n_total_components ==
mask.size()) || (
mask.size() == 0),
1201 ExcMessage(
"The given ComponentMask has the wrong size."));
1203 const unsigned int n_selected =
1204 mask.n_selected_components(n_total_components);
1206 ExcMessage(
"You need at least one selected component."));
1208 const unsigned int first_selected =
1209 mask.first_selected_component(n_total_components);
1214 for (
unsigned int c = 0; c < n_total_components; ++c)
1215 Assert((c < first_selected && (!mask[c])) ||
1216 (c >= first_selected && c < first_selected + n_selected &&
1218 (c >= first_selected + n_selected && !mask[c]),
1219 ExcMessage(
"Error: the given ComponentMask is not contiguous!"));
1222 return get_sub_fe(first_selected, n_selected);
1227template <
int dim,
int spacedim>
1230 const unsigned int first_component,
1231 const unsigned int n_selected_components)
const
1235 Assert(first_component == 0 && n_selected_components == this->n_components(),
1237 "You can only select a whole FiniteElement, not a part of one."));
1244template <
int dim,
int spacedim>
1245std::pair<Table<2, bool>, std::vector<unsigned int>>
1249 return std::pair<Table<2, bool>, std::vector<unsigned int>>(
1251 std::vector<unsigned int>(this->n_components()));
1256template <
int dim,
int spacedim>
1261 std::vector<double> &)
const
1263 Assert(has_generalized_support_points(),
1264 ExcMessage(
"The element for which you are calling the current "
1265 "function does not have generalized support points (see "
1266 "the glossary for a definition of generalized support "
1267 "points). Consequently, the current function can not "
1268 "be defined and is not implemented by the element."));
1274template <
int dim,
int spacedim>
1295template <
int dim,
int spacedim>
1296std::vector<unsigned int>
1298 const std::vector<ComponentMask> &nonzero_components)
1300 std::vector<unsigned int> retval(nonzero_components.size());
1301 for (
unsigned int i = 0; i < nonzero_components.size(); ++i)
1302 retval[i] = nonzero_components[i].n_selected_components();
1311template <
int dim,
int spacedim>
1312std::unique_ptr<typename FiniteElement<dim, spacedim>::InternalDataBase>
1321 return get_data(flags,
1330template <
int dim,
int spacedim>
1331std::unique_ptr<typename FiniteElement<dim, spacedim>::InternalDataBase>
1340 return get_data(flags,
1349template <
int dim,
int spacedim>
1353 const unsigned int face_no,
1366 fill_fe_face_values(cell,
1378template <
int dim,
int spacedim>
1382 const unsigned int ,
1396 ExcMessage(
"Use of a deprecated interface, please implement "
1397 "fill_fe_face_values taking a hp::QCollection argument"));
1403template <
int dim,
int spacedim>
1404std::unique_ptr<typename FiniteElement<dim, spacedim>::InternalDataBase>
1413 return get_data(flags,
1422template <
int dim,
int spacedim>
1436#include "fe/fe.inst"
bool represents_the_all_selected_mask() const
unsigned int size() const
bool represents_the_all_selected_mask() const
unsigned int size() const
const unsigned int components
unsigned int n_dofs_per_cell() const
unsigned int n_dofs_per_line() const
unsigned int n_components() const
virtual std::size_t memory_consumption() const
bool constraints_are_implemented(const ::internal::SubfaceCase< dim > &subface_case=::internal::SubfaceCase< dim >::case_isotropic) const
bool isotropic_prolongation_is_implemented() const
virtual std::string get_name() const =0
virtual Point< dim > unit_support_point(const unsigned int index) const
virtual FiniteElementDomination::Domination compare_for_domination(const FiniteElement< dim, spacedim > &fe_other, const unsigned int codim=0) const
const std::vector< unsigned int > n_nonzero_components_table
virtual const FullMatrix< double > & get_restriction_matrix(const unsigned int child, const RefinementCase< dim > &refinement_case=RefinementCase< dim >::isotropic_refinement) const
bool prolongation_is_implemented() const
virtual std::pair< Table< 2, bool >, std::vector< unsigned int > > get_constant_modes() const
virtual const FiniteElement< dim, spacedim > & base_element(const unsigned int index) const
virtual Tensor< 1, dim > shape_grad(const unsigned int i, const Point< dim > &p) const
virtual std::unique_ptr< InternalDataBase > get_face_data(const UpdateFlags update_flags, const Mapping< dim, spacedim > &mapping, const hp::QCollection< dim - 1 > &quadrature, ::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &output_data) const
virtual Point< dim - 1 > unit_face_support_point(const unsigned int index, const unsigned int face_no=0) const
static std::vector< unsigned int > compute_n_nonzero_components(const std::vector< ComponentMask > &nonzero_components)
virtual std::unique_ptr< InternalDataBase > get_subface_data(const UpdateFlags update_flags, const Mapping< dim, spacedim > &mapping, const Quadrature< dim - 1 > &quadrature, ::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &output_data) const
bool has_face_support_points(const unsigned int face_no=0) const
const bool cached_primitivity
virtual 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
ComponentMask component_mask(const FEValuesExtractors::Scalar &scalar) const
bool operator!=(const FiniteElement< dim, spacedim > &) const
bool has_support_points() const
bool has_generalized_support_points() const
virtual Tensor< 2, dim > shape_grad_grad(const unsigned int i, const Point< dim > &p) const
virtual bool operator==(const FiniteElement< dim, spacedim > &fe) const
const std::vector< Point< dim > > & get_unit_support_points() const
virtual void fill_fe_face_values(const typename Triangulation< dim, spacedim >::cell_iterator &cell, const unsigned int face_no, const hp::QCollection< dim - 1 > &quadrature, const Mapping< dim, spacedim > &mapping, const typename Mapping< dim, spacedim >::InternalDataBase &mapping_internal, const internal::FEValuesImplementation::MappingRelatedData< dim, spacedim > &mapping_data, const InternalDataBase &fe_internal, ::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &output_data) const
void reinit_restriction_and_prolongation_matrices(const bool isotropic_restriction_only=false, const bool isotropic_prolongation_only=false)
const std::vector< Point< dim - 1 > > & get_unit_face_support_points(const unsigned int face_no=0) const
bool isotropic_restriction_is_implemented() const
std::vector< int > adjust_line_dof_index_for_line_orientation_table
virtual bool has_support_on_face(const unsigned int shape_index, const unsigned int face_index) const
const FiniteElement< dim, spacedim > & get_sub_fe(const ComponentMask &mask) const
virtual Tensor< 4, dim > shape_4th_derivative_component(const unsigned int i, const Point< dim > &p, const unsigned int component) const
virtual double shape_value_component(const unsigned int i, const Point< dim > &p, const unsigned int component) const
unsigned int adjust_quad_dof_index_for_face_orientation(const unsigned int index, const unsigned int face_no, const types::geometric_orientation combined_orientation) const
virtual void get_subface_interpolation_matrix(const FiniteElement< dim, spacedim > &source, const unsigned int subface, FullMatrix< double > &matrix, const unsigned int face_no=0) const
unsigned int component_to_block_index(const unsigned int component) const
BlockMask block_mask(const FEValuesExtractors::Scalar &scalar) const
virtual void get_interpolation_matrix(const FiniteElement< dim, spacedim > &source, FullMatrix< double > &matrix) const
virtual Tensor< 3, dim > shape_3rd_derivative(const unsigned int i, const Point< dim > &p) const
std::vector< std::pair< std::pair< unsigned int, unsigned int >, unsigned int > > system_to_base_table
virtual std::vector< std::pair< unsigned int, unsigned int > > hp_line_dof_identities(const FiniteElement< dim, spacedim > &fe_other) const
virtual void convert_generalized_support_point_values_to_dof_values(const std::vector< Vector< double > > &support_point_values, std::vector< double > &nodal_values) const
FiniteElement(const FiniteElementData< dim > &fe_data, const std::vector< bool > &restriction_is_additive_flags, const std::vector< ComponentMask > &nonzero_components)
virtual Tensor< 3, dim > shape_3rd_derivative_component(const unsigned int i, const Point< dim > &p, const unsigned int component) const
const FullMatrix< double > & constraints(const ::internal::SubfaceCase< dim > &subface_case=::internal::SubfaceCase< dim >::case_isotropic) const
std::pair< std::unique_ptr< FiniteElement< dim, spacedim > >, unsigned int > operator^(const unsigned int multiplicity) const
unsigned int adjust_line_dof_index_for_line_orientation(const unsigned int index, const types::geometric_orientation combined_orientation) const
const std::vector< bool > restriction_is_additive_flags
virtual unsigned int face_to_cell_index(const unsigned int face_dof_index, const unsigned int face, const types::geometric_orientation combined_orientation=numbers::default_geometric_orientation) const
std::vector< std::pair< std::pair< unsigned int, unsigned int >, unsigned int > > component_to_base_table
TableIndices< 2 > interface_constraints_size() const
virtual Tensor< 1, dim > shape_grad_component(const unsigned int i, const Point< dim > &p, const unsigned int component) const
bool restriction_is_implemented() const
FullMatrix< double > interface_constraints
const std::vector< Point< dim > > & get_generalized_support_points() const
virtual Tensor< 2, dim > shape_grad_grad_component(const unsigned int i, const Point< dim > &p, const unsigned int component) const
virtual const FullMatrix< double > & get_prolongation_matrix(const unsigned int child, const RefinementCase< dim > &refinement_case=RefinementCase< dim >::isotropic_refinement) const
virtual double shape_value(const unsigned int i, const Point< dim > &p) const
virtual void get_face_interpolation_matrix(const FiniteElement< dim, spacedim > &source, FullMatrix< double > &matrix, const unsigned int face_no=0) const
virtual std::size_t memory_consumption() const
virtual Tensor< 4, dim > shape_4th_derivative(const unsigned int i, const Point< dim > &p) const
const std::vector< ComponentMask > nonzero_components
virtual std::vector< std::pair< unsigned int, unsigned int > > hp_vertex_dof_identities(const FiniteElement< dim, spacedim > &fe_other) const
virtual bool hp_constraints_are_implemented() const
Abstract base class for mapping classes.
Class which transforms dim - 1-dimensional quadrature rules to dim-dimensional face quadratures.
unsigned int size() const
#define DEAL_II_NAMESPACE_OPEN
constexpr bool running_in_debug_mode()
#define DEAL_II_NAMESPACE_CLOSE
#define DEAL_II_ASSERT_UNREACHABLE()
#define DEAL_II_NOT_IMPLEMENTED()
#define Assert(cond, exc)
#define AssertDimension(dim1, dim2)
#define AssertIndexRange(index, range)
static ::ExceptionBase & ExcInternalError()
static ::ExceptionBase & ExcDimensionMismatch(std::size_t arg1, std::size_t arg2)
static ::ExceptionBase & ExcMessage(std::string arg1)
#define AssertThrow(cond, exc)
@ update_default
No update.
@ neither_element_dominates
void reference_cell(Triangulation< dim, spacedim > &tria, const ReferenceCell &reference_cell)
std::enable_if_t< IsBlockVector< VectorType >::value, unsigned int > n_blocks(const VectorType &vector)
std::enable_if_t< std::is_fundamental_v< T >, std::size_t > memory_consumption(const T &t)
constexpr ReferenceCell Triangle
constexpr ReferenceCell Quadrilateral
VectorType::value_type * end(VectorType &V)
VectorType::value_type * begin(VectorType &V)
std::vector< Point< dim > > unit_support_points(const std::vector< Point< 1 > > &line_support_points, const std::vector< unsigned int > &renumbering)
constexpr unsigned int invalid_unsigned_int
constexpr types::geometric_orientation reverse_line_orientation
constexpr types::geometric_orientation default_geometric_orientation
unsigned char geometric_orientation