void LaplaceProblem<dim>::run()
{
{
- const unsigned int n_vect_doubles =
- VectorizedArray<double>::n_array_elements;
- const unsigned int n_vect_bits = 8 * sizeof(double) * n_vect_doubles;
+ const unsigned int n_vect_doubles = VectorizedArray<double>::size();
+ const unsigned int n_vect_bits = 8 * sizeof(double) * n_vect_doubles;
pcout << "Vectorization over " << n_vect_doubles
<< " doubles = " << n_vect_bits << " bits ("
<< Utilities::MPI::n_mpi_processes(MPI_COMM_WORLD) << std::endl;
pcout << "Number of threads on each rank: "
<< MultithreadInfo::n_threads() << std::endl;
- const unsigned int n_vect_doubles =
- VectorizedArray<double>::n_array_elements;
- const unsigned int n_vect_bits = 8 * sizeof(double) * n_vect_doubles;
+ const unsigned int n_vect_doubles = VectorizedArray<double>::size();
+ const unsigned int n_vect_bits = 8 * sizeof(double) * n_vect_doubles;
pcout << "Vectorization over " << n_vect_doubles
<< " doubles = " << n_vect_bits << " bits ("
<< Utilities::System::get_current_vectorization_level()
for (unsigned int d = 0; d < dim; ++d)
for (unsigned int e = 0; e < dim; ++e)
if (d != e)
- for (unsigned int v = 0;
- v < VectorizedArray<number>::n_array_elements;
- ++v)
+ for (unsigned int v = 0; v < VectorizedArray<number>::size(); ++v)
AssertThrow(inverse_jacobian[d][e][v] == 0.,
ExcNotImplemented());
VectorizedArray<double> rhs_val = VectorizedArray<double>();
Point<dim, VectorizedArray<double>> point_batch =
phi.quadrature_point(q);
- for (unsigned int v = 0;
- v < VectorizedArray<double>::n_array_elements;
- ++v)
+ for (unsigned int v = 0; v < VectorizedArray<double>::size(); ++v)
{
Point<dim> single_point;
for (unsigned int d = 0; d < dim; ++d)
Point<dim, VectorizedArray<double>> point_batch =
phi_face.quadrature_point(q);
- for (unsigned int v = 0;
- v < VectorizedArray<double>::n_array_elements;
- ++v)
+ for (unsigned int v = 0; v < VectorizedArray<double>::size(); ++v)
{
Point<dim> single_point;
for (unsigned int d = 0; d < dim; ++d)