std::array<const unsigned int *, n_face_orientations> orientation = {};
if (dim == 3 && n_face_orientations == n_lanes && !all_faces_are_same &&
- fe_eval.get_is_interior_face() == 0)
+ fe_eval.is_interior_face() == 0)
for (unsigned int v = 0; v < n_lanes; ++v)
{
// the loop breaks once an invalid_unsigned_int is hit for
if (fe_eval.get_dof_access_index() ==
MatrixFreeFunctions::DoFInfo::dof_access_cell &&
- fe_eval.get_is_interior_face() == false)
+ fe_eval.is_interior_face() == false)
fe_face_evaluation_process_and_io<VectorizedArrayType::size()>(
p, n_components, evaluation_flag, src_ptr, sm_ptr, fe_eval, temp);
else
{
if (fe_eval.get_dof_access_index() ==
MatrixFreeFunctions::DoFInfo::dof_access_cell &&
- fe_eval.get_is_interior_face() == false)
+ fe_eval.is_interior_face() == false)
{
for (unsigned int v = 0; v < VectorizedArrayType::size(); ++v)
{
{
if (fe_eval.get_dof_access_index() ==
MatrixFreeFunctions::DoFInfo::dof_access_cell &&
- fe_eval.get_is_interior_face() == false)
+ fe_eval.is_interior_face() == false)
for (unsigned int v = 0; v < VectorizedArrayType::size(); ++v)
{
// the loop breaks once an invalid_unsigned_int is hit for
if (fe_eval.get_dof_access_index() ==
MatrixFreeFunctions::DoFInfo::dof_access_cell &&
- fe_eval.get_is_interior_face() == false)
+ fe_eval.is_interior_face() == false)
fe_face_evaluation_process_and_io<VectorizedArrayType::size()>(
p, n_components, integration_flag, dst_ptr, sm_ptr, fe_eval, temp);
else
!(is_face &&
this->dof_access_index ==
internal::MatrixFreeFunctions::DoFInfo::dof_access_cell &&
- this->is_interior_face == false) &&
- !(!is_face && !this->is_interior_face))
+ this->is_interior_face() == false) &&
+ !(!is_face && !this->is_interior_face()))
{
const unsigned int dof_index =
dof_indices_cont[this->cell * VectorizedArrayType::size()] +
const bool is_ecl =
(this->dof_access_index ==
internal::MatrixFreeFunctions::DoFInfo::dof_access_cell &&
- this->is_interior_face == false) ||
- (!is_face && !this->is_interior_face);
+ this->is_interior_face() == false) ||
+ (!is_face && !this->is_interior_face());
if (vectors_sm[0] != nullptr)
{
this->cell = face_index;
this->dof_access_index =
- this->is_interior_face ?
+ this->is_interior_face() ?
internal::MatrixFreeFunctions::DoFInfo::dof_access_face_interior :
internal::MatrixFreeFunctions::DoFInfo::dof_access_face_exterior;
Assert(this->mapping_data != nullptr, ExcNotInitialized());
this->matrix_free->get_task_info().face_partition_data.back() &&
face_index <
this->matrix_free->get_task_info().boundary_partition_data.back())
- Assert(this->is_interior_face,
+ Assert(this->is_interior_face(),
ExcMessage(
"Boundary faces do not have a neighbor. When looping over "
"boundary faces use FEFaceEvaluation with the parameter "
this->J_value = &this->mapping_data->JxW_values[offsets];
this->normal_vectors = &this->mapping_data->normal_vectors[offsets];
this->jacobian =
- &this->mapping_data->jacobians[!this->is_interior_face][offsets];
+ &this->mapping_data->jacobians[!this->is_interior_face()][offsets];
this->normal_x_jacobian =
&this->mapping_data
- ->normals_times_jacobians[!this->is_interior_face][offsets];
+ ->normals_times_jacobians[!this->is_interior_face()][offsets];
this->jacobian_gradients =
- this->mapping_data->jacobian_gradients[!this->is_interior_face].data() +
+ this->mapping_data->jacobian_gradients[!this->is_interior_face()].data() +
offsets;
if (this->mapping_data->quadrature_point_offsets.empty() == false)
constexpr unsigned int n_lanes = VectorizedArrayType::size();
- if (this->is_interior_face == false)
+ if (this->is_interior_face() == false)
{
// for this case, we need to look into the FaceInfo field that collects
// information from both sides of a face once for the global mesh, and
.normal_vectors[offsets];
this->jacobian = &this->matrix_free->get_mapping_info()
.face_data_by_cells[this->quad_no]
- .jacobians[!this->is_interior_face][offsets];
+ .jacobians[!this->is_interior_face()][offsets];
this->normal_x_jacobian =
&this->matrix_free->get_mapping_info()
.face_data_by_cells[this->quad_no]
- .normals_times_jacobians[!this->is_interior_face][offsets];
+ .normals_times_jacobians[!this->is_interior_face()][offsets];
this->jacobian_gradients =
- this->mapping_data->jacobian_gradients[!this->is_interior_face].data() +
+ this->mapping_data->jacobian_gradients[!this->is_interior_face()].data() +
offsets;
if (this->matrix_free->get_mapping_info()
{
Assert((this->dof_access_index ==
internal::MatrixFreeFunctions::DoFInfo::dof_access_cell &&
- this->is_interior_face == false) == false,
+ this->is_interior_face() == false) == false,
ExcNotImplemented());
const auto shared_vector_data = internal::get_shared_vector_data(
* internal use.
*/
bool
- get_is_interior_face() const;
+ is_interior_face() const;
/**
* Return the id of the cells this FEEvaluation or FEFaceEvaluation is
* the dof values should be read from the actual cell corresponding to the
* interior face or the neighboring cell corresponding to the exterior face.
*/
- bool is_interior_face;
+ bool interior_face;
/**
* Stores the index an FEFaceEvaluation object is currently pointing into
, gradients_quad_submitted(false)
# endif
, cell(numbers::invalid_unsigned_int)
- , is_interior_face(is_interior_face)
+ , interior_face(is_interior_face)
, dof_access_index(
is_face ?
(is_interior_face ?
, quadrature_weights(nullptr)
, cell(0)
, cell_type(internal::MatrixFreeFunctions::general)
- , is_interior_face(true)
+ , interior_face(true)
, dof_access_index(internal::MatrixFreeFunctions::DoFInfo::dof_access_cell)
, mapped_geometry(mapped_geometry)
, is_reinitialized(false)
gradients_quad_submitted = false;
# endif
- cell = numbers::invalid_unsigned_int;
- is_interior_face = other.is_interior_face;
+ cell = numbers::invalid_unsigned_int;
+ interior_face = other.is_interior_face();
dof_access_index =
is_face ?
- (is_interior_face ?
+ (is_interior_face() ?
internal::MatrixFreeFunctions::DoFInfo::dof_access_face_interior :
internal::MatrixFreeFunctions::DoFInfo::dof_access_face_exterior) :
internal::MatrixFreeFunctions::DoFInfo::dof_access_cell;
ExcMessage("Faces can only be set if the is_face template parameter "
"is true"));
face_numbers[0] =
- (is_interior_face ? face.interior_face_no : face.exterior_face_no);
- subface_index = is_interior_face == true ?
+ (is_interior_face() ? face.interior_face_no : face.exterior_face_no);
+ subface_index = is_interior_face() == true ?
GeometryInfo<dim>::max_children_per_cell :
face.subface_index;
// standard-orientation else copy the first three bits
// (which is equivalent to modulo 8). See also the documentation of
// internal::MatrixFreeFunctions::FaceToCellTopology::face_orientation.
- face_orientations[0] = (is_interior_face == (face.face_orientation >= 8)) ?
+ face_orientations[0] = (is_interior_face() == (face.face_orientation >= 8)) ?
(face.face_orientation % 8) :
0;
- if (is_interior_face)
+ if (is_interior_face())
cell_ids = face.cells_interior;
else
cell_ids = face.cells_exterior;
Assert(v == 0 || (cell != numbers::invalid_unsigned_int &&
dof_access_index ==
internal::MatrixFreeFunctions::DoFInfo::dof_access_cell &&
- is_interior_face == false),
+ is_interior_face() == false),
ExcMessage("All face numbers can only be queried for ECL at exterior "
"faces. Use get_face_no() in other cases."));
Assert(v == 0 || (cell != numbers::invalid_unsigned_int &&
dof_access_index ==
internal::MatrixFreeFunctions::DoFInfo::dof_access_cell &&
- is_interior_face == false),
+ is_interior_face() == false),
ExcMessage("All face numbers can only be queried for ECL at exterior "
"faces. Use get_face_no() in other cases."));
template <int dim, typename Number, bool is_face>
inline bool
-FEEvaluationData<dim, Number, is_face>::get_is_interior_face() const
+FEEvaluationData<dim, Number, is_face>::is_interior_face() const
{
- return is_interior_face;
+ return interior_face;
}