From e815753723e46e72ed4138a6046f1c37579c8934 Mon Sep 17 00:00:00 2001 From: Peter Munch Date: Mon, 31 Jan 2022 08:59:26 +0100 Subject: [PATCH] FEEval: rename get_is_interior_face() to is_interior_face() --- .../deal.II/matrix_free/evaluation_kernels.h | 10 +++---- include/deal.II/matrix_free/fe_evaluation.h | 28 ++++++++--------- .../deal.II/matrix_free/fe_evaluation_data.h | 30 +++++++++---------- 3 files changed, 34 insertions(+), 34 deletions(-) diff --git a/include/deal.II/matrix_free/evaluation_kernels.h b/include/deal.II/matrix_free/evaluation_kernels.h index 25b2120a0c..d095c03ce2 100644 --- a/include/deal.II/matrix_free/evaluation_kernels.h +++ b/include/deal.II/matrix_free/evaluation_kernels.h @@ -3206,7 +3206,7 @@ namespace internal std::array 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 @@ -3749,7 +3749,7 @@ namespace internal 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( p, n_components, evaluation_flag, src_ptr, sm_ptr, fe_eval, temp); else @@ -3794,7 +3794,7 @@ namespace internal { 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) { @@ -3972,7 +3972,7 @@ namespace internal { 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 @@ -4047,7 +4047,7 @@ namespace internal 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( p, n_components, integration_flag, dst_ptr, sm_ptr, fe_eval, temp); else diff --git a/include/deal.II/matrix_free/fe_evaluation.h b/include/deal.II/matrix_free/fe_evaluation.h index 1e2c7760a2..0c899d8719 100644 --- a/include/deal.II/matrix_free/fe_evaluation.h +++ b/include/deal.II/matrix_free/fe_evaluation.h @@ -3874,8 +3874,8 @@ FEEvaluationBase:: !(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()] + @@ -3910,8 +3910,8 @@ FEEvaluationBase:: 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) { @@ -7563,7 +7563,7 @@ FEFaceEvaluationcell = 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()); @@ -7572,7 +7572,7 @@ FEFaceEvaluationmatrix_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 " @@ -7593,12 +7593,12 @@ FEFaceEvaluationJ_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) @@ -7659,7 +7659,7 @@ FEFaceEvaluationis_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 @@ -7741,13 +7741,13 @@ FEFaceEvaluationjacobian = &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() @@ -8198,7 +8198,7 @@ FEFaceEvaluationdof_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( diff --git a/include/deal.II/matrix_free/fe_evaluation_data.h b/include/deal.II/matrix_free/fe_evaluation_data.h index 7de101a44f..7ff407e8e1 100644 --- a/include/deal.II/matrix_free/fe_evaluation_data.h +++ b/include/deal.II/matrix_free/fe_evaluation_data.h @@ -469,7 +469,7 @@ public: * internal use. */ bool - get_is_interior_face() const; + is_interior_face() const; /** * Return the id of the cells this FEEvaluation or FEFaceEvaluation is @@ -800,7 +800,7 @@ protected: * 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 @@ -940,7 +940,7 @@ inline FEEvaluationData::FEEvaluationData( , 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 ? @@ -980,7 +980,7 @@ inline FEEvaluationData::FEEvaluationData( , 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) @@ -1029,11 +1029,11 @@ FEEvaluationData::operator=(const FEEvaluationData &other) 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; @@ -1097,8 +1097,8 @@ FEEvaluationData::reinit_face( 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::max_children_per_cell : face.subface_index; @@ -1107,11 +1107,11 @@ FEEvaluationData::reinit_face( // 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; @@ -1431,7 +1431,7 @@ FEEvaluationData::get_face_no(const unsigned int v) const 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.")); @@ -1458,7 +1458,7 @@ FEEvaluationData::get_face_orientation( 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.")); @@ -1478,9 +1478,9 @@ FEEvaluationData::get_dof_access_index() const template inline bool -FEEvaluationData::get_is_interior_face() const +FEEvaluationData::is_interior_face() const { - return is_interior_face; + return interior_face; } -- 2.39.5