*/
static const unsigned int n_cell_types = 1U<<n_cell_type_bits;
+ /**
+ * An abbreviation for the length of vector lines of the current data type.
+ */
+ static const unsigned int n_vector_elements = VectorizedArray<Number>::n_array_elements;
+
/**
* Empty constructor.
*/
/**
* Contains all the stuff that depends on the quadrature formula
-
*/
std::vector<MappingInfoDependent> mapping_data_gen;
const std::pair<unsigned int,unsigned int> *cells,
const unsigned int cell,
const unsigned int my_q,
- CellType (&cell_t_prev)[VectorizedArray<Number>::n_array_elements],
- CellType (&cell_t)[VectorizedArray<Number>::n_array_elements],
+ CellType (&cell_t_prev)[n_vector_elements],
+ CellType (&cell_t)[n_vector_elements],
FEValues<dim,dim> &fe_values,
CellData &cell_data) const;
};
const std::pair<unsigned int,unsigned int> *cells,
const unsigned int cell,
const unsigned int my_q,
- CellType (&cell_t_prev)[VectorizedArray<Number>::n_array_elements],
- CellType (&cell_t)[VectorizedArray<Number>::n_array_elements],
+ CellType (&cell_t_prev)[n_vector_elements],
+ CellType (&cell_t)[n_vector_elements],
FEValues<dim,dim> &fe_val,
CellData &data) const
{
- const unsigned int vectorization_length =
- VectorizedArray<Number>::n_array_elements;
const unsigned int n_q_points = fe_val.n_quadrature_points;
const UpdateFlags update_flags = fe_val.get_update_flags();
// not have that field here)
const double zero_tolerance_double = data.jac_size *
std::numeric_limits<double>::epsilon() * 1024.;
- for (unsigned int j=0; j<vectorization_length; ++j)
+ for (unsigned int j=0; j<n_vector_elements; ++j)
{
typename dealii::Triangulation<dim>::cell_iterator
cell_it (&tria, cells[j].first, cells[j].second);
if (j==0)
{
Assert (cell>0, ExcInternalError());
- cell_t[j] = cell_t_prev[vectorization_length-1];
+ cell_t[j] = cell_t_prev[n_vector_elements-1];
}
else
cell_t[j] = cell_t[j-1];
data.general_jac_grad[q][d][e][f][j] = jacobian_grad[d][e][f];
}
}
- } // end loop over all entries in vectorization (vectorization_length
+ } // end loop over all entries in vectorization (n_vector_elements
// cells)
// set information for next cell
- for (unsigned int j=0; j<vectorization_length; ++j)
+ for (unsigned int j=0; j<n_vector_elements; ++j)
cell_t_prev[j] = cell_t[j];
}