Utilities::pow(fe_degree + 1, dim - 1) :
(dim > 1 ? Utilities::fixed_power<dim - 1>(data.fe_degree + 1) : 1);
- const unsigned int n_q_points =
- fe_degree > -1 ?
- Utilities::fixed_int_power<n_q_points_1d, dim - 1>::value :
- data.n_q_points_face;
+ const unsigned int n_q_points = fe_degree > -1 ?
+ Utilities::pow(n_q_points_1d, dim - 1) :
+ data.n_q_points_face;
if (integrate_grad == false)
for (unsigned int c = 0; c < n_components; ++c)
const unsigned int n_child_dofs_1d = 2 * degree_size - element_is_continuous;
const unsigned int n_scalar_cell_dofs =
Utilities::fixed_power<dim>(n_child_dofs_1d);
- const unsigned int three_to_dim = Utilities::fixed_int_power<3, dim>::value;
+ constexpr unsigned int three_to_dim = Utilities::pow(3, dim);
for (unsigned int cell = 0; cell < n_owned_level_cells[to_level - 1];
cell += vec_size)
const unsigned int n_child_dofs_1d = 2 * degree_size - element_is_continuous;
const unsigned int n_scalar_cell_dofs =
Utilities::fixed_power<dim>(n_child_dofs_1d);
- const unsigned int three_to_dim = Utilities::fixed_int_power<3, dim>::value;
+ constexpr unsigned int three_to_dim = Utilities::pow(3, dim);
for (unsigned int cell = 0; cell < n_owned_level_cells[from_level - 1];
cell += vec_size)
static const unsigned int n_dofs_1d = fe_degree + 1;
static const unsigned int n_local_dofs =
- dealii::Utilities::fixed_int_power<fe_degree + 1, dim>::value;
+ dealii::Utilities::pow(fe_degree + 1, dim);
static const unsigned int n_q_points =
- dealii::Utilities::fixed_int_power<n_q_points_1d, dim>::value;
+ dealii::Utilities::pow(n_q_points_1d, dim);
};
}
const unsigned int n_constraints =
Utilities::MPI::sum(n_local_constraints, MPI_COMM_WORLD);
- const unsigned int n_expected_constraints =
- Utilities::fixed_int_power<9, dim - 1>::value;
+ constexpr unsigned int n_expected_constraints = Utilities::pow(9, dim - 1);
if (myid == 0)
deallog << "n_constraints: " << n_constraints
<< " n_expected_constraints: " << n_expected_constraints