mapping_data->descriptor[active_quad_index].n_q_points);
Assert(
dof_info->start_components.back() == 1 ||
- (int)n_components_ <=
- (int)dof_info->start_components
- [dof_info->component_to_base_index[first_selected_component] + 1] -
+ static_cast<int>(n_components_) <=
+ static_cast<int>(
+ dof_info->start_components
+ [dof_info->component_to_base_index[first_selected_component] + 1]) -
first_selected_component,
ExcMessage(
"You tried to construct a vector-valued evaluator with " +
++j)
if (cell_t[j] > most_general_type)
most_general_type = cell_t[j];
- AssertIndexRange((unsigned int)most_general_type, 4U);
+ AssertIndexRange(most_general_type, 4U);
mapping_info.cell_type[cell] = most_general_type;
}
tasks += Threads::new_task(
&ExtractFaceHelper::compute_normal_times_jacobian<dim, Number>,
work_per_chunk * i,
- std::min(work_per_chunk * (i + 1), (unsigned int)faces.size()),
+ std::min<unsigned int>(work_per_chunk * (i + 1), faces.size()),
face_type,
faces,
face_data[my_q]);
ghost_indices.end());
compressed_set.subtract_set(
dof_info[no].vector_partitioner->locally_owned_range());
- const bool all_ghosts_equal = Utilities::MPI::min(
- (int)(compressed_set.n_elements() ==
- dof_info[no]
- .vector_partitioner->ghost_indices()
- .n_elements()),
- dof_info[no].vector_partitioner->get_mpi_communicator());
+ const bool all_ghosts_equal =
+ Utilities::MPI::min<int>(
+ compressed_set.n_elements() ==
+ dof_info[no].vector_partitioner->ghost_indices().n_elements(),
+ dof_info[no].vector_partitioner->get_mpi_communicator()) != 0;
if (all_ghosts_equal)
dof_info[no].vector_partitioner_face_variants[0] =
dof_info[no].vector_partitioner;
has_noncontiguous_cell = true;
}
has_noncontiguous_cell =
- Utilities::MPI::min((int)has_noncontiguous_cell,
- task_info.communicator);
+ Utilities::MPI::min<int>(has_noncontiguous_cell,
+ task_info.communicator) != 0;
std::sort(ghost_indices.begin(), ghost_indices.end());
ghost_indices.erase(std::unique(ghost_indices.begin(),
ghost_indices.end());
compressed_set.subtract_set(
dof_info[no].vector_partitioner->locally_owned_range());
- const bool all_ghosts_equal = Utilities::MPI::min(
- (int)(compressed_set.n_elements() ==
- dof_info[no]
- .vector_partitioner->ghost_indices()
- .n_elements()),
- dof_info[no].vector_partitioner->get_mpi_communicator());
+ const bool all_ghosts_equal =
+ Utilities::MPI::min<int>(
+ compressed_set.n_elements() ==
+ dof_info[no]
+ .vector_partitioner->ghost_indices()
+ .n_elements(),
+ dof_info[no].vector_partitioner->get_mpi_communicator()) !=
+ 0;
if (all_ghosts_equal || has_noncontiguous_cell)
dof_info[no].vector_partitioner_face_variants[1] =
dof_info[no].vector_partitioner;
ghost_indices.end());
compressed_set.subtract_set(
dof_info[no].vector_partitioner->locally_owned_range());
- const bool all_ghosts_equal = Utilities::MPI::min(
- (int)(compressed_set.n_elements() ==
- dof_info[no]
- .vector_partitioner->ghost_indices()
- .n_elements()),
- dof_info[no].vector_partitioner->get_mpi_communicator());
+ const bool all_ghosts_equal =
+ Utilities::MPI::min<int>(
+ compressed_set.n_elements() ==
+ dof_info[no]
+ .vector_partitioner->ghost_indices()
+ .n_elements(),
+ dof_info[no].vector_partitioner->get_mpi_communicator()) !=
+ 0;
if (all_ghosts_equal)
dof_info[no].vector_partitioner_face_variants[2] =
dof_info[no].vector_partitioner;