15#ifndef dealii_geometry_info_h
16#define dealii_geometry_info_h
37 namespace GeometryInfoHelper
45 struct Initializers<1>
47 static constexpr std::array<unsigned int, 2>
53 static constexpr std::array<unsigned int, 2>
54 unit_normal_direction()
59 static constexpr std::array<int, 2>
60 unit_normal_orientation()
65 static constexpr std::array<Tensor<1, 1>, 2>
71 static constexpr ::ndarray<Tensor<1, 1>, 2, 0>
72 unit_tangential_vectors()
74 return {{{{}}, {{}}}};
77 static constexpr std::array<unsigned int, 2>
83 static constexpr std::array<unsigned int, 2>
89 static constexpr ::ndarray<unsigned int, 2, 1>
92 return {{{{0}}, {{1}}}};
97 struct Initializers<2>
99 static constexpr std::array<unsigned int, 4>
102 return {{0, 1, 3, 2}};
105 static constexpr std::array<unsigned int, 4>
106 unit_normal_direction()
108 return {{0, 0, 1, 1}};
111 static constexpr std::array<int, 4>
112 unit_normal_orientation()
114 return {{-1, 1, -1, 1}};
117 static constexpr std::array<Tensor<1, 2>, 4>
126 static constexpr ::ndarray<Tensor<1, 2>, 4, 1>
127 unit_tangential_vectors()
135 static constexpr std::array<unsigned int, 4>
138 return {{1, 0, 3, 2}};
141 static constexpr std::array<unsigned int, 4>
144 return {{0, 2, 1, 3}};
147 static constexpr ::ndarray<unsigned int, 4, 2>
150 return {{{{0, 2}}, {{1, 2}}, {{0, 3}}, {{1, 3}}}};
155 struct Initializers<3>
157 static constexpr std::array<unsigned int, 8>
160 return {{0, 4, 5, 1, 2, 6, 7, 3}};
163 static constexpr std::array<unsigned int, 6>
164 unit_normal_direction()
166 return {{0, 0, 1, 1, 2, 2}};
169 static constexpr std::array<int, 6>
170 unit_normal_orientation()
172 return {{-1, 1, -1, 1, -1, 1}};
175 static constexpr std::array<Tensor<1, 3>, 6>
186 static constexpr ::ndarray<Tensor<1, 3>, 6, 2>
187 unit_tangential_vectors()
197 static constexpr std::array<unsigned int, 6>
200 return {{1, 0, 3, 2, 5, 4}};
203 static constexpr std::array<unsigned int, 8>
206 return {{0, 4, 2, 6, 1, 5, 3, 7}};
209 static constexpr ::ndarray<unsigned int, 8, 3>
212 return {{{{0, 2, 4}},
224 struct Initializers<4>
226 static constexpr std::array<unsigned int, 16>
247 static constexpr std::array<unsigned int, 8>
248 unit_normal_direction()
250 return {{0, 0, 1, 1, 2, 2, 3, 3}};
253 static constexpr std::array<int, 8>
254 unit_normal_orientation()
256 return {{-1, 1, -1, 1, -1, 1, -1, 1}};
259 static constexpr std::array<Tensor<1, 4>, 8>
272 static constexpr ::ndarray<Tensor<1, 4>, 8, 3>
273 unit_tangential_vectors()
301 static constexpr std::array<unsigned int, 8>
304 return {{1, 0, 3, 2, 5, 4, 7, 6}};
307 static constexpr std::array<unsigned int, 16>
328 static constexpr ::ndarray<unsigned int, 16, 4>
463 operator unsigned int()
const;
670 cut_xy = cut_x | cut_y,
743 cut_xy = cut_x | cut_y,
751 cut_xz = cut_x | cut_z,
755 cut_yz = cut_y | cut_z,
759 cut_xyz = cut_x | cut_y | cut_z,
818 operator std::uint8_t()
const;
875 template <
class Archive>
885 <<
"The refinement flags given (" << arg1
886 <<
") contain set bits that do not "
887 <<
"make sense for the space dimension of the object to which they are applied.");
894 std::uint8_t
value : (dim > 0 ? dim : 1);
1167 subface_possibility);
1180 operator std::uint8_t()
const;
1185 static constexpr std::size_t
1194 <<
"The subface case given (" << arg1 <<
") does not make sense "
1195 <<
"for the space dimension of the object to which they are applied.");
1202 std::uint8_t
value : (dim == 3 ? 4 : 1);
1266 static std::array<unsigned int, 0>
1309 static std::array<unsigned int, vertices_per_cell>
1337 const unsigned int vertex,
1338 const bool face_orientation =
true,
1339 const bool face_flip =
false,
1340 const bool face_rotation =
false);
1358 const unsigned int line,
1359 const bool face_orientation =
true,
1360 const bool face_flip =
false,
1361 const bool face_rotation =
false);
1413 static const std::array<unsigned int, vertices_per_cell>
ucd_to_deal;
1428 static const std::array<unsigned int, vertices_per_cell>
dx_to_deal;
2099 static constexpr std::array<unsigned int, vertices_per_cell>
ucd_to_deal =
2100 internal::GeometryInfoHelper::Initializers<dim>::ucd_to_deal();
2115 static constexpr std::array<unsigned int, vertices_per_cell>
dx_to_deal =
2116 internal::GeometryInfoHelper::Initializers<dim>::dx_to_deal();
2130 internal::GeometryInfoHelper::Initializers<dim>::vertex_to_face();
2157 const unsigned int subface_no);
2166 const unsigned int face_no,
2167 const bool face_orientation =
true,
2168 const bool face_flip =
false,
2169 const bool face_rotation =
false);
2179 const unsigned int face_no,
2180 const bool face_orientation =
true,
2181 const bool face_flip =
false,
2182 const bool face_rotation =
false);
2190 const unsigned int line_no);
2247 const unsigned int face,
2248 const unsigned int subface,
2249 const bool face_orientation =
true,
2250 const bool face_flip =
false,
2251 const bool face_rotation =
false,
2293 const unsigned int vertex,
2294 const bool face_orientation =
true,
2295 const bool face_flip =
false,
2296 const bool face_rotation =
false);
2311 const unsigned int line,
2312 const bool face_orientation =
true,
2313 const bool face_flip =
false,
2314 const bool face_rotation =
false);
2327 const bool face_orientation =
true,
2328 const bool face_flip =
false,
2329 const bool face_rotation =
false);
2342 const bool face_orientation =
true,
2343 const bool face_flip =
false,
2344 const bool face_rotation =
false);
2357 const bool face_orientation =
true,
2358 const bool face_flip =
false,
2359 const bool face_rotation =
false);
2368 const bool line_orientation =
true);
2377 static std::array<unsigned int, 2>
2387 static std::array<unsigned int, 2>
2397 static std::array<unsigned int, 2>
2411 const bool face_orientation =
true,
2412 const bool face_flip =
false,
2413 const bool face_rotation =
false);
2444 const unsigned int child_index,
2455 const unsigned int child_index,
2484 template <
typename Number =
double>
2561 template <
int spacedim>
2564#ifndef DEAL_II_CXX14_CONSTEXPR_BUG
2580 static constexpr std::array<unsigned int, faces_per_cell>
2582 internal::GeometryInfoHelper::Initializers<dim>::unit_normal_direction();
2601 internal::GeometryInfoHelper::Initializers<dim>::unit_normal_orientation();
2615 internal::GeometryInfoHelper::Initializers<dim>::unit_normal_vector();
2640 internal::GeometryInfoHelper::Initializers<dim>::opposite_face();
2648 <<
"The coordinates must satisfy 0 <= x_i <= 1, "
2649 <<
"but here we have x_i=" << arg1);
2658 <<
"RefinementCase<dim> " << arg1 <<
": face " << arg2
2659 <<
" has no subface " << arg3);
2673 const unsigned int i);
2677 const unsigned int i);
2681 const unsigned int i);
2695 : object(static_cast<Object>(object_dimension))
2699inline GeometryPrimitive::operator
unsigned int()
const
2701 return static_cast<unsigned int>(object);
2711 :
value(subface_possibility)
2716 inline SubfaceCase<dim>::operator std::uint8_t()
const
2730 return static_cast<std::uint8_t
>(-1);
2774inline std::array<RefinementCase<1>, 2>
2784inline std::array<RefinementCase<2>, 4>
2796inline std::array<RefinementCase<3>, 8>
2821 :
value(refinement_case)
2827 Assert((refinement_case &
2830 ExcInvalidRefinementCase(refinement_case));
2837 :
value(refinement_case)
2843 Assert((refinement_case &
2846 ExcInvalidRefinementCase(refinement_case));
2897template <
class Archive>
2903 std::uint8_t uchar_value =
value;
2905 value = uchar_value;
2916 return Point<1>(
static_cast<double>(vertex));
2927 return {
static_cast<double>(vertex % 2),
static_cast<double>(vertex / 2)};
2938 return {
static_cast<double>(vertex % 2),
2939 static_cast<double>(vertex / 2 % 2),
2940 static_cast<double>(vertex / 4)};
2945inline std::array<unsigned int, 0>
2953inline std::array<unsigned int, 1>
2966 0U, faces_per_cell);
2976 0U, vertices_per_cell);
2996 Assert((p[0] >= 0) && (p[0] <= 1), ExcInvalidCoordinate(p[0]));
2998 return (p[0] <= 0.5 ? 0 : 1);
3007 Assert((p[0] >= 0) && (p[0] <= 1), ExcInvalidCoordinate(p[0]));
3008 Assert((p[1] >= 0) && (p[1] <= 1), ExcInvalidCoordinate(p[1]));
3010 return (p[0] <= 0.5 ? (p[1] <= 0.5 ? 0 : 2) : (p[1] <= 0.5 ? 1 : 3));
3019 Assert((p[0] >= 0) && (p[0] <= 1), ExcInvalidCoordinate(p[0]));
3020 Assert((p[1] >= 0) && (p[1] <= 1), ExcInvalidCoordinate(p[1]));
3021 Assert((p[2] >= 0) && (p[2] <= 1), ExcInvalidCoordinate(p[2]));
3023 return (p[0] <= 0.5 ?
3024 (p[1] <= 0.5 ? (p[2] <= 0.5 ? 0 : 4) : (p[2] <= 0.5 ? 2 : 6)) :
3025 (p[1] <= 0.5 ? (p[2] <= 0.5 ? 1 : 5) : (p[2] <= 0.5 ? 3 : 7)));
3043 const unsigned int child_index,
3051 return Point<1>(p * 2.0 - unit_cell_vertex(child_index));
3059 const unsigned int child_index,
3066 switch (refine_case)
3070 if (child_index == 1)
3075 if (child_index == 1)
3080 point -= unit_cell_vertex(child_index);
3094 const unsigned int child_index,
3106 switch (refine_case)
3110 if (child_index == 1)
3115 if (child_index == 1)
3120 if (child_index == 1)
3126 if (child_index % 2 == 1)
3128 if (child_index / 2 == 1)
3138 if (child_index / 2 == 1)
3140 if (child_index % 2 == 1)
3146 if (child_index % 2 == 1)
3148 if (child_index / 2 == 1)
3153 point -= unit_cell_vertex(child_index);
3168 const unsigned int ,
3181 const unsigned int child_index,
3189 return (p + unit_cell_vertex(child_index)) * 0.5;
3197 const unsigned int child_index,
3209 switch (refine_case)
3212 if (child_index == 1)
3217 if (child_index == 1)
3222 if (child_index == 1)
3227 if (child_index % 2 == 1)
3229 if (child_index / 2 == 1)
3239 if (child_index / 2 == 1)
3241 if (child_index % 2 == 1)
3247 if (child_index % 2 == 1)
3249 if (child_index / 2 == 1)
3255 point += unit_cell_vertex(child_index);
3270 const unsigned int child_index,
3276 switch (refine_case)
3279 if (child_index == 1)
3284 if (child_index == 1)
3289 point += unit_cell_vertex(child_index);
3305 const unsigned int ,
3326 return (p[0] >= 0.) && (p[0] <= 1.);
3335 return (p[0] >= 0.) && (p[0] <= 1.) && (p[1] >= 0.) && (p[1] <= 1.);
3344 return (p[0] >= 0.) && (p[0] <= 1.) && (p[1] >= 0.) && (p[1] <= 1.) &&
3345 (p[2] >= 0.) && (p[2] <= 1.);
3362 return (p[0] >= -eps) && (p[0] <= 1. +
eps);
3371 const double l = -
eps, u = 1 +
eps;
3372 return (p[0] >= l) && (p[0] <= u) && (p[1] >= l) && (p[1] <= u);
3381 const double l = -
eps, u = 1.0 +
eps;
3382 return (p[0] >= l) && (p[0] <= u) && (p[1] >= l) && (p[1] <= u) &&
3383 (p[2] >= l) && (p[2] <= u);
3391 const unsigned int vertex)
3404 const unsigned int vertex)
3406 constexpr unsigned int cell_vertices[4][2] = {{0, 2}, {1, 3}, {0, 1}, {2, 3}};
3407 return cell_vertices[line][vertex];
3415 const unsigned int vertex)
3420 constexpr unsigned vertices[lines_per_cell][2] = {{0, 2},
3433 return vertices[line][vertex];
3448 const bool face_orientation,
3449 const bool face_flip,
3450 const bool face_rotation)
3472 constexpr unsigned int vertex_translation[4][2][2][2] = {
3494 return vertex_translation[vertex][face_orientation][face_flip][face_rotation];
3516 0, 2, 2, 4, 2, 4, 4, 8};
3518 return n_children[ref_case];
3553 0, 2, 3, 3, 4, 2, 3, 3, 4, 4};
3554 return nsubs[subface_case];
3583 switch (subface_case)
3620 const unsigned int subface_no)
3623 switch (subface_case)
3658 if (subface_no == 0)
3705 const unsigned int face_no,
3710 const unsigned int dim = 2;
3732 return ref_cases[cell_refinement_case][face_no / 2];
3740 const unsigned int face_no,
3741 const bool face_orientation,
3743 const bool face_rotation)
3745 const unsigned int dim = 3;
3791 ref_cases[cell_refinement_case][face_no / 2];
3811 return (face_orientation == face_rotation) ? flip[ref_case] : ref_case;
3829 const unsigned int line_no)
3832 const unsigned int dim = 1;
3838 return cell_refinement_case;
3846 const unsigned int line_no)
3849 return face_refinement_case(cell_refinement_case, line_no);
3857 const unsigned int line_no)
3859 const unsigned int dim = 3;
3880 const unsigned int direction[lines_per_cell] = {
3881 1, 1, 0, 0, 1, 1, 0, 0, 2, 2, 2, 2};
3883 return ((cell_refinement_case & cut_one[direction[line_no]]) ?
3913 const unsigned int dim = 1;
3924 const unsigned int face_no,
3929 const unsigned int dim = 2;
3946 const unsigned int face_no,
3947 const bool face_orientation,
3949 const bool face_rotation)
3951 const unsigned int dim = 3;
3975 (face_orientation == face_rotation) ? flip[face_refinement_case] :
3976 face_refinement_case;
3995 return face_to_cell[face_no / 2][std_face_ref];
4013 const unsigned int line_no)
4025 const unsigned int line_no)
4027 const unsigned int dim = 2;
4039 const unsigned int line_no)
4041 const unsigned int dim = 3;
4052 return ref_cases[line_no / 2];
4060 const bool face_orientation,
4061 const bool face_flip,
4062 const bool face_rotation)
4084 const unsigned int vertex_translation[4][2][2][2] = {
4106 return vertex_translation[vertex][face_orientation][face_flip][face_rotation];
4128 const bool face_orientation,
4129 const bool face_flip,
4130 const bool face_rotation)
4152 const unsigned int line_translation[4][2][2][2] = {
4174 return line_translation[line][face_orientation][face_flip][face_rotation];
4195 const bool line_orientation)
4197 return line_orientation ? vertex : (1 - vertex);
4214inline std::array<unsigned int, 2>
4216 const unsigned int vertex)
4218 return {{vertex % 2, vertex / 2}};
4224inline std::array<unsigned int, 2>
4226 const unsigned int vertex)
4236inline std::array<unsigned int, 2>
4260 return {{lookup_table[i][0], lookup_table[i][1]}};
4266inline std::array<unsigned int, 2>
4277inline std::array<unsigned int, 2>
4279 const unsigned int vertex)
4286 return {{4 + vertex / 4, vertex % 4}};
4292inline std::array<unsigned int, 2>
4294 const unsigned int vertex)
4306 const bool face_orientation,
4307 const bool face_flip,
4308 const bool face_rotation)
4330 const unsigned int line_translation[4][2][2][2] = {
4352 return line_translation[line][face_orientation][face_flip][face_rotation];
4373 const unsigned int face,
4374 const unsigned int subface,
4392 const unsigned int face,
4393 const unsigned int subface,
4394 const bool face_orientation,
4409 constexpr unsigned int
4415 {{0, 0}, {1, 1}, {1, 0}, {1, 0}},
4416 {{1, 0}, {1, 0}, {0, 0}, {1, 1}},
4417 {{2, 0}, {3, 1}, {1, 0}, {3, 2}}
4421 {{0, 0}, {1, 1}, {0, 1}, {0, 1}},
4422 {{0, 1}, {0, 1}, {0, 0}, {1, 1}},
4423 {{0, 2}, {1, 3}, {0, 1}, {2, 3}}
4426 return subcells[face_orientation][ref_case - 1][face][subface];
4434 const unsigned int face,
4435 const unsigned int subface,
4436 const bool face_orientation,
4437 const bool face_flip,
4438 const bool face_rotation,
4441 const unsigned int dim = 3;
4446 if (!(subface == 0 &&
4484 (face_orientation == face_rotation) ? flip[face_ref_case] : face_ref_case;
4496 const unsigned int subface_exchange[4][2][2][2][4] = {
4499 {{{{0,
e,
e,
e}, {0,
e,
e,
e}}, {{0,
e,
e,
e}, {0,
e,
e,
e}}},
4500 {{{0,
e,
e,
e}, {0,
e,
e,
e}}, {{0,
e,
e,
e}, {0,
e,
e,
e}}}},
4514 {{{{0, 1,
e,
e}, {0, 1,
e,
e}}, {{1, 0,
e,
e}, {1, 0,
e,
e}}},
4515 {{{0, 1,
e,
e}, {0, 1,
e,
e}}, {{1, 0,
e,
e}, {1, 0,
e,
e}}}},
4518 {{{{0, 1,
e,
e}, {1, 0,
e,
e}}, {{1, 0,
e,
e}, {0, 1,
e,
e}}},
4519 {{{0, 1,
e,
e}, {1, 0,
e,
e}}, {{1, 0,
e,
e}, {0, 1,
e,
e}}}},
4541 const unsigned int std_subface =
4542 subface_exchange[face_ref_case][face_orientation][face_flip][face_rotation]
4554 [max_children_per_face] = {
4616 if ((std_face_ref & face_refinement_case(ref_case, face)) ==
4617 face_refinement_case(ref_case, face))
4626 const unsigned int equivalent_iso_subface[4][4] = {
4632 const unsigned int equ_std_subface =
4633 equivalent_iso_subface[std_face_ref][std_subface];
4636 return iso_children[ref_case - 1][face][equ_std_subface];
4643 ExcMessage(
"The face RefineCase is too coarse "
4644 "for the given cell RefineCase."));
4671 const unsigned int line,
4689 const unsigned int line,
4690 const bool face_orientation,
4691 const bool face_flip,
4692 const bool face_rotation)
4697 const unsigned lines[faces_per_cell][lines_per_face] = {
4704 return lines[face][real_to_standard_face_line(
4705 line, face_orientation, face_flip, face_rotation)];
4740 const unsigned int vertex,
4741 const bool face_orientation,
4742 const bool face_flip,
4743 const bool face_rotation)
4769template <
typename Number>
4774 for (
unsigned int i = 0; i < dim; ++i)
4786 double result = 0.0;
4788 for (
unsigned int i = 0; i < dim; ++i)
4791 result =
std::max(result, p[i] - 1.);
4802 const unsigned int i)
4810 const double x = xi[0];
4823 const double x = xi[0];
4824 const double y = xi[1];
4828 return (1 - x) * (1 - y);
4841 const double x = xi[0];
4842 const double y = xi[1];
4843 const double z = xi[2];
4847 return (1 - x) * (1 - y) * (1 - z);
4849 return x * (1 - y) * (1 - z);
4851 return (1 - x) * y * (1 - z);
4853 return x * y * (1 - z);
4855 return (1 - x) * (1 - y) * z;
4857 return x * (1 - y) * z;
4859 return (1 - x) * y * z;
4877 const unsigned int i)
4897 const unsigned int i)
4901 const double x = xi[0];
4902 const double y = xi[1];
4906 return Point<2>(-(1 - y), -(1 - x));
4922 const unsigned int i)
4926 const double x = xi[0];
4927 const double y = xi[1];
4928 const double z = xi[2];
4932 return Point<3>(-(1 - y) * (1 - z),
4934 -(1 - x) * (1 - y));
4936 return Point<3>((1 - y) * (1 - z), -x * (1 - z), -x * (1 - y));
4938 return Point<3>(-y * (1 - z), (1 - x) * (1 - z), -(1 - x) * y);
4940 return Point<3>(y * (1 - z), x * (1 - z), -x * y);
4942 return Point<3>(-(1 - y) * z, -(1 - x) * z, (1 - x) * (1 - y));
4944 return Point<3>((1 - y) * z, -x * z, x * (1 - y));
4946 return Point<3>(-y * z, (1 - x) * z, (1 - x) * y);
4948 return Point<3>(y * z, x * z, x * y);
4974 namespace GeometryInfoHelper
4984 result[0] = derivative[0][1];
4985 result[1] = -derivative[0][0];
4996 return cross_product_3d(derivative[0], derivative[1]);
5008 for (
unsigned int i = 0; i < dim; ++i)
5009 jacobian[i] = derivative[i];
5018template <
int spacedim>
5021# ifndef DEAL_II_CXX14_CONSTEXPR_BUG
5023 Tensor<spacedim - dim, spacedim> (&forms)[vertices_per_cell])
5057 for (
unsigned int i = 0; i < vertices_per_cell; ++i)
5061 for (
unsigned int j = 0; j < vertices_per_cell; ++j)
5064 d_linear_shape_function_gradient(unit_cell_vertex(i), j);
5065 for (
unsigned int l = 0;
l < dim; ++
l)
5066 derivatives[l] += vertices[j] * grad_phi_j[l];
5069 forms[i] = internal::GeometryInfoHelper::wedge_product(derivatives);
GeometryPrimitive(const unsigned int object_dimension)
GeometryPrimitive(const Object object)
RefinementCase operator|(const RefinementCase &r) const
static std::size_t memory_consumption()
RefinementCase operator~() const
RefinementCase operator&(const RefinementCase &r) const
RefinementCase(const typename RefinementPossibilities< dim >::Possibilities refinement_case)
static constexpr unsigned int n_refinement_cases
static RefinementCase cut_axis(const unsigned int i)
static std::array< RefinementCase< dim >, n_refinement_cases > all_refinement_cases()
void serialize(Archive &ar, const unsigned int version)
RefinementCase(const std::uint8_t refinement_case)
static constexpr std::size_t memory_consumption()
SubfaceCase(const typename SubfacePossibilities< dim >::Possibilities subface_possibility)
#define DEAL_II_NAMESPACE_OPEN
#define DEAL_II_HOST_DEVICE
#define DEAL_II_NAMESPACE_CLOSE
#define DEAL_II_ASSERT_UNREACHABLE()
#define DEAL_II_NOT_IMPLEMENTED()
#define Assert(cond, exc)
static ::ExceptionBase & ExcImpossibleInDim(int arg1)
static ::ExceptionBase & ExcInvalidCoordinate(double arg1)
static ::ExceptionBase & ExcInvalidSubface(int arg1, int arg2, int arg3)
static ::ExceptionBase & ExcInvalidRefinementCase(int arg1)
#define AssertIndexRange(index, range)
static ::ExceptionBase & ExcInternalError()
#define DeclException3(Exception3, type1, type2, type3, outsequence)
#define DeclException1(Exception1, type1, outsequence)
static ::ExceptionBase & ExcMessage(std::string arg1)
static ::ExceptionBase & ExcInvalidSubfaceCase(int arg1)
Point< spacedim > point(const gp_Pnt &p, const double tolerance=1e-10)
SymmetricTensor< 2, dim, Number > e(const Tensor< 2, dim, Number > &F)
Tensor< 2, dim, Number > l(const Tensor< 2, dim, Number > &F, const Tensor< 2, dim, Number > &dF_dt)
constexpr unsigned int invalid_unsigned_int
boost::integer_range< IncrementableType > iota_view
::VectorizedArray< Number, width > min(const ::VectorizedArray< Number, width > &, const ::VectorizedArray< Number, width > &)
::VectorizedArray< Number, width > max(const ::VectorizedArray< Number, width > &, const ::VectorizedArray< Number, width > &)
typename internal::ndarray::HelperArray< T, Ns... >::type ndarray
static unsigned int n_children(const RefinementCase< 0 > &refinement_case)
static unsigned int face_to_cell_vertices(const unsigned int face, const unsigned int vertex, const bool face_orientation=true, const bool face_flip=false, const bool face_rotation=false)
static std::array< unsigned int, 0 > face_indices()
static std::array< unsigned int, vertices_per_cell > vertex_indices()
static unsigned int face_to_cell_lines(const unsigned int face, const unsigned int line, const bool face_orientation=true, const bool face_flip=false, const bool face_rotation=false)
static unsigned int child_cell_from_point(const Point< dim > &p)
static unsigned int standard_to_real_line_vertex(const unsigned int vertex, const bool line_orientation=true)
static constexpr std::array< unsigned int, vertices_per_cell > ucd_to_deal
static constexpr ndarray< Tensor< 1, dim >, faces_per_cell, dim - 1 > unit_tangential_vectors
static bool is_inside_unit_cell(const Point< dim > &p, const double eps)
static double distance_to_unit_cell(const Point< dim > &p)
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 quads_per_face
static RefinementCase< dim - 1 > face_refinement_case(const RefinementCase< dim > &cell_refinement_case, const unsigned int face_no, const bool face_orientation=true, const bool face_flip=false, const bool face_rotation=false)
static unsigned int standard_to_real_face_vertex(const unsigned int vertex, const bool face_orientation=true, const bool face_flip=false, const bool face_rotation=false)
static RefinementCase< dim > min_cell_refinement_case_for_line_refinement(const unsigned int line_no)
static constexpr std::array< unsigned int, faces_per_cell > opposite_face
static constexpr unsigned int max_children_per_face
static unsigned int face_to_cell_vertices(const unsigned int face, const unsigned int vertex, const bool face_orientation=true, const bool face_flip=false, const bool face_rotation=false)
static constexpr unsigned int vertices_per_cell
static constexpr std::array< unsigned int, vertices_per_cell > dx_to_deal
static constexpr unsigned int lines_per_cell
static constexpr std::array< unsigned int, faces_per_cell > unit_normal_direction
static std::array< unsigned int, 2 > standard_hex_line_to_quad_line_index(const unsigned int line)
static constexpr unsigned int faces_per_cell
static unsigned int standard_to_real_face_line(const unsigned int line, const bool face_orientation=true, const bool face_flip=false, const bool face_rotation=false)
static std_cxx20::ranges::iota_view< unsigned int, unsigned int > face_indices()
static double subface_ratio(const internal::SubfaceCase< dim > &subface_case, const unsigned int subface_no)
static constexpr unsigned int hexes_per_cell
static Point< dim, Number > project_to_unit_cell(const Point< dim, Number > &p)
static RefinementCase< 1 > line_refinement_case(const RefinementCase< dim > &cell_refinement_case, const unsigned int line_no)
static std::array< unsigned int, 2 > standard_hex_vertex_to_quad_vertex_index(const unsigned int vertex)
static std::array< unsigned int, 2 > standard_quad_vertex_to_line_vertex_index(const unsigned int vertex)
static double d_linear_shape_function(const Point< dim > &xi, const unsigned int i)
static constexpr std::array< Tensor< 1, dim >, faces_per_cell > unit_normal_vector
static constexpr unsigned int vertices_per_face
static unsigned int real_to_standard_face_line(const unsigned int line, const bool face_orientation=true, const bool face_flip=false, const bool face_rotation=false)
static unsigned int line_to_cell_vertices(const unsigned int line, const unsigned int vertex)
static std_cxx20::ranges::iota_view< unsigned int, unsigned int > vertex_indices()
static bool is_inside_unit_cell(const Point< dim > &p)
static RefinementCase< dim > min_cell_refinement_case_for_face_refinement(const RefinementCase< dim - 1 > &face_refinement_case, const unsigned int face_no, const bool face_orientation=true, const bool face_flip=false, const bool face_rotation=false)
static unsigned int n_children(const RefinementCase< dim > &refinement_case)
static unsigned int real_to_standard_face_vertex(const unsigned int vertex, const bool face_orientation=true, const bool face_flip=false, const bool face_rotation=false)
static unsigned int face_to_cell_lines(const unsigned int face, const unsigned int line, const bool face_orientation=true, const bool face_flip=false, const bool face_rotation=false)
static Point< dim > cell_to_child_coordinates(const Point< dim > &p, const unsigned int child_index, const RefinementCase< dim > refine_case=RefinementCase< dim >::isotropic_refinement)
static constexpr ndarray< unsigned int, vertices_per_cell, dim > vertex_to_face
static Tensor< 1, dim > d_linear_shape_function_gradient(const Point< dim > &xi, const unsigned int i)
static void alternating_form_at_vertices(const Point< spacedim >(&vertices)[vertices_per_cell], Tensor< spacedim - dim, spacedim >(&forms)[vertices_per_cell])
static Point< dim > unit_cell_vertex(const unsigned int vertex)
static constexpr std::array< int, faces_per_cell > unit_normal_orientation
static constexpr unsigned int quads_per_cell
static Point< dim > child_to_cell_coordinates(const Point< dim > &p, const unsigned int child_index, const RefinementCase< dim > refine_case=RefinementCase< dim >::isotropic_refinement)
static constexpr unsigned int max_children_per_cell
static unsigned int n_subfaces(const internal::SubfaceCase< dim > &subface_case)
static constexpr unsigned int lines_per_face
DEAL_II_HOST constexpr Number determinant(const SymmetricTensor< 2, dim, Number > &)