std::vector<FaceToCellTopology<vectorization_width>> &faces_out,
const std::vector<unsigned int> & active_fe_indices)
{
- FaceToCellTopology<vectorization_width> macro_face;
+ FaceToCellTopology<vectorization_width> face_batch;
std::vector<std::vector<unsigned int>> faces_type;
unsigned int face_start = face_partition_data[0],
new_faces(face_comparator);
for (const auto &face_type : faces_type)
{
- macro_face.face_type = faces_in[face_type[0]].face_type;
- macro_face.interior_face_no =
+ face_batch.face_type = faces_in[face_type[0]].face_type;
+ face_batch.interior_face_no =
faces_in[face_type[0]].interior_face_no;
- macro_face.exterior_face_no =
+ face_batch.exterior_face_no =
faces_in[face_type[0]].exterior_face_no;
- macro_face.subface_index = faces_in[face_type[0]].subface_index;
- macro_face.face_orientation =
+ face_batch.subface_index = faces_in[face_type[0]].subface_index;
+ face_batch.face_orientation =
faces_in[face_type[0]].face_orientation;
unsigned int no_faces = face_type.size();
std::vector<unsigned char> touched(no_faces, 0);
vectorization_width + 1);
for (unsigned int v = 0; v < vectorization_width; ++v)
{
- macro_face.cells_interior[v] =
+ face_batch.cells_interior[v] =
faces_in[face_type[f + v]].cells_interior[0];
- macro_face.cells_exterior[v] =
+ face_batch.cells_exterior[v] =
faces_in[face_type[f + v]].cells_exterior[0];
touched[f + v] = 1;
}
- new_faces.insert(macro_face);
+ new_faces.insert(face_batch);
f += vectorization_width - 1;
n_vectorized += vectorization_width;
}
unsigned int v = 0;
for (const auto f : untouched)
{
- macro_face.cells_interior[v] =
+ face_batch.cells_interior[v] =
faces_in[face_type[f]].cells_interior[0];
- macro_face.cells_exterior[v] =
+ face_batch.cells_exterior[v] =
faces_in[face_type[f]].cells_exterior[0];
++v;
if (v == vectorization_width)
{
- new_faces.insert(macro_face);
+ new_faces.insert(face_batch);
v = 0;
}
}
for (; v < vectorization_width; ++v)
{
// Dummy cell, not used
- macro_face.cells_interior[v] =
+ face_batch.cells_interior[v] =
numbers::invalid_unsigned_int;
- macro_face.cells_exterior[v] =
+ face_batch.cells_exterior[v] =
numbers::invalid_unsigned_int;
}
- new_faces.insert(macro_face);
+ new_faces.insert(face_batch);
}
else
{
* indicating a boundary face.
*/
types::boundary_id
- get_boundary_id(const unsigned int macro_face) const;
+ get_boundary_id(const unsigned int face_batch_index) const;
/**
* Return the boundary ids for the faces within a cell, using the cells'
* faces.
*/
std::pair<unsigned int, unsigned int>
- get_face_category(const unsigned int macro_face) const;
+ get_face_category(const unsigned int face_batch_index) const;
/**
* Queries whether or not the indexation has been set.
template <int dim, typename Number, typename VectorizedArrayType>
inline types::boundary_id
MatrixFree<dim, Number, VectorizedArrayType>::get_boundary_id(
- const unsigned int macro_face) const
+ const unsigned int face_batch_index) const
{
- Assert(macro_face >= task_info.boundary_partition_data[0] &&
- macro_face < task_info.boundary_partition_data.back(),
- ExcIndexRange(macro_face,
+ Assert(face_batch_index >= task_info.boundary_partition_data[0] &&
+ face_batch_index < task_info.boundary_partition_data.back(),
+ ExcIndexRange(face_batch_index,
task_info.boundary_partition_data[0],
task_info.boundary_partition_data.back()));
- return types::boundary_id(face_info.faces[macro_face].exterior_face_no);
+ return types::boundary_id(face_info.faces[face_batch_index].exterior_face_no);
}
inline const internal::MatrixFreeFunctions::FaceToCellTopology<
VectorizedArrayType::size()> &
MatrixFree<dim, Number, VectorizedArrayType>::get_face_info(
- const unsigned int macro_face) const
+ const unsigned int face_batch_index) const
{
- AssertIndexRange(macro_face, face_info.faces.size());
- return face_info.faces[macro_face];
+ AssertIndexRange(face_batch_index, face_info.faces.size());
+ return face_info.faces[face_batch_index];
}
template <int dim, typename Number, typename VectorizedArrayType>
inline std::pair<unsigned int, unsigned int>
MatrixFree<dim, Number, VectorizedArrayType>::get_face_category(
- const unsigned int macro_face) const
+ const unsigned int face_batch_index) const
{
- AssertIndexRange(macro_face, face_info.faces.size());
+ AssertIndexRange(face_batch_index, face_info.faces.size());
if (dof_info[0].cell_active_fe_index.empty())
return std::make_pair(0U, 0U);
std::pair<unsigned int, unsigned int> result;
- for (unsigned int v = 0; v < VectorizedArrayType::size() &&
- face_info.faces[macro_face].cells_interior[v] !=
- numbers::invalid_unsigned_int;
+ for (unsigned int v = 0;
+ v < VectorizedArrayType::size() &&
+ face_info.faces[face_batch_index].cells_interior[v] !=
+ numbers::invalid_unsigned_int;
++v)
result.first = std::max(
result.first,
- dof_info[0]
- .cell_active_fe_index[face_info.faces[macro_face].cells_interior[v]]);
- if (face_info.faces[macro_face].cells_exterior[0] !=
+ dof_info[0].cell_active_fe_index[face_info.faces[face_batch_index]
+ .cells_interior[v]]);
+ if (face_info.faces[face_batch_index].cells_exterior[0] !=
numbers::invalid_unsigned_int)
- for (unsigned int v = 0; v < VectorizedArrayType::size() &&
- face_info.faces[macro_face].cells_exterior[v] !=
- numbers::invalid_unsigned_int;
+ for (unsigned int v = 0;
+ v < VectorizedArrayType::size() &&
+ face_info.faces[face_batch_index].cells_exterior[v] !=
+ numbers::invalid_unsigned_int;
++v)
result.second = std::max(
result.first,
- dof_info[0]
- .cell_active_fe_index[face_info.faces[macro_face].cells_exterior[v]]);
+ dof_info[0].cell_active_fe_index[face_info.faces[face_batch_index]
+ .cells_exterior[v]]);
else
result.second = numbers::invalid_unsigned_int;
return result;