fe_values.reinit(cell);
for (unsigned int i = 0; i < dofs_per_cell; ++i)
for (unsigned int j = 0; j < dofs_per_cell; ++j)
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ fe_values.quadrature_point_indices())
{
const SymmetricTensor<2, dim>
eps_phi_i = get_strain(fe_values, i, q_point),
{
const unsigned int component_i =
fe.system_to_component_index(i).first;
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ fe_values.quadrature_point_indices())
{
const SymmetricTensor<2, dim> &old_stress =
local_quadrature_points_data[q_point].old_stress;
fe_values.reinit(cell);
for (unsigned int i = 0; i < dofs_per_cell; ++i)
for (unsigned int j = 0; j < dofs_per_cell; ++j)
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ fe_values.quadrature_point_indices())
{
const SymmetricTensor<2, dim>
eps_phi_i = get_strain(fe_values, i, q_point),
{
const unsigned int component_i =
fe.system_to_component_index(i).first;
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ fe_values.quadrature_point_indices())
{
const SymmetricTensor<2, dim> &old_stress =
local_quadrature_points_data[q_point].old_stress;
scratch.solution_total, scratch.solution_values_p_total);
scratch.fe_values_ref[J_fe].get_function_values(
scratch.solution_total, scratch.solution_values_J_total);
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ scratch.fe_values_ref.quadrature_point_indices())
lqph[q_point]->update_values(scratch.solution_grads_u_total[q_point],
scratch.solution_values_p_total[q_point],
scratch.solution_values_J_total[q_point]);
const std::vector<std::shared_ptr<const PointHistory<dim>>> lqph =
quadrature_point_history.get_data(cell);
Assert(lqph.size() == n_q_points, ExcInternalError());
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ fe_values_ref.quadrature_point_indices())
{
const double det_F_qp = lqph[q_point]->get_det_F();
const double JxW = fe_values_ref.JxW(q_point);
const std::vector<std::shared_ptr<const PointHistory<dim>>> lqph =
quadrature_point_history.get_data(cell);
Assert(lqph.size() == n_q_points, ExcInternalError());
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ fe_values_ref.quadrature_point_indices())
{
const double det_F_qp = lqph[q_point]->get_det_F();
const double J_tilde_qp = lqph[q_point]->get_J_tilde();
const std::vector<std::shared_ptr<const PointHistory<dim>>> lqph =
quadrature_point_history.get_data(cell);
Assert(lqph.size() == n_q_points, ExcInternalError());
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ scratch.fe_values_ref.quadrature_point_indices())
{
const Tensor<2, dim> F_inv = lqph[q_point]->get_F_inv();
for (unsigned int k = 0; k < dofs_per_cell; ++k)
Assert(k_group <= J_dof, ExcInternalError());
}
}
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ scratch.fe_values_ref.quadrature_point_indices())
{
const Tensor<2, dim> tau = lqph[q_point]->get_tau();
const SymmetricTensor<4, dim> Jc = lqph[q_point]->get_Jc();
const std::vector<std::shared_ptr<const PointHistory<dim>>> lqph =
quadrature_point_history.get_data(cell);
Assert(lqph.size() == n_q_points, ExcInternalError());
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ scratch.fe_values_ref.quadrature_point_indices())
{
const Tensor<2, dim> F_inv = lqph[q_point]->get_F_inv();
for (unsigned int k = 0; k < dofs_per_cell; ++k)
Assert(k_group <= J_dof, ExcInternalError());
}
}
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ scratch.fe_values_ref.quadrature_point_indices())
{
const SymmetricTensor<2, dim> tau = lqph[q_point]->get_tau();
const double det_F = lqph[q_point]->get_det_F();
cell->face(face)->boundary_id() == 6)
{
scratch.fe_face_values_ref.reinit(cell, face);
- for (unsigned int f_q_point = 0; f_q_point < n_q_points_f;
- ++f_q_point)
+ for (const unsigned int f_q_point :
+ scratch.fe_face_values_ref.quadrature_point_indices())
{
const Tensor<1, dim> &N =
scratch.fe_face_values_ref.normal_vector(f_q_point);
scratch.solution_total, scratch.solution_values_p_total);
scratch.fe_values_ref[J_fe].get_function_values(
scratch.solution_total, scratch.solution_values_J_total);
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ scratch.fe_values_ref.quadrature_point_indices())
lqph[q_point]->update_values(scratch.solution_grads_u_total[q_point],
scratch.solution_values_p_total[q_point],
scratch.solution_values_J_total[q_point]);
const std::vector<std::shared_ptr<const PointHistory<dim>>> lqph =
quadrature_point_history.get_data(cell);
Assert(lqph.size() == n_q_points, ExcInternalError());
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ fe_values_ref.quadrature_point_indices())
{
const double det_F_qp = lqph[q_point]->get_det_F();
const double JxW = fe_values_ref.JxW(q_point);
const std::vector<std::shared_ptr<const PointHistory<dim>>> lqph =
quadrature_point_history.get_data(cell);
Assert(lqph.size() == n_q_points, ExcInternalError());
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ fe_values_ref.quadrature_point_indices())
{
const double det_F_qp = lqph[q_point]->get_det_F();
const double J_tilde_qp = lqph[q_point]->get_J_tilde();
const std::vector<std::shared_ptr<const PointHistory<dim>>> lqph =
quadrature_point_history.get_data(cell);
Assert(lqph.size() == n_q_points, ExcInternalError());
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ scratch.fe_values_ref.quadrature_point_indices())
{
const Tensor<2, dim> F_inv = lqph[q_point]->get_F_inv();
for (unsigned int k = 0; k < dofs_per_cell; ++k)
Assert(k_group <= J_dof, ExcInternalError());
}
}
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ scratch.fe_values_ref.quadrature_point_indices())
{
const Tensor<2, dim> tau = lqph[q_point]->get_tau();
const SymmetricTensor<4, dim> Jc = lqph[q_point]->get_Jc();
const std::vector<std::shared_ptr<const PointHistory<dim>>> lqph =
quadrature_point_history.get_data(cell);
Assert(lqph.size() == n_q_points, ExcInternalError());
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ scratch.fe_values_ref.quadrature_point_indices())
{
const Tensor<2, dim> F_inv = lqph[q_point]->get_F_inv();
for (unsigned int k = 0; k < dofs_per_cell; ++k)
Assert(k_group <= J_dof, ExcInternalError());
}
}
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ scratch.fe_values_ref.quadrature_point_indices())
{
const SymmetricTensor<2, dim> tau = lqph[q_point]->get_tau();
const double det_F = lqph[q_point]->get_det_F();
cell->face(face)->boundary_id() == 6)
{
scratch.fe_face_values_ref.reinit(cell, face);
- for (unsigned int f_q_point = 0; f_q_point < n_q_points_f;
- ++f_q_point)
+ for (const unsigned int f_q_point :
+ scratch.fe_face_values_ref.quadrature_point_indices())
{
const Tensor<1, dim> &N =
scratch.fe_face_values_ref.normal_vector(f_q_point);
scratch.solution_total, scratch.solution_values_p_total);
scratch.fe_values_ref[J_fe].get_function_values(
scratch.solution_total, scratch.solution_values_J_total);
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ scratch.fe_values_ref.quadrature_point_indices())
lqph[q_point]->update_values(scratch.solution_grads_u_total[q_point],
scratch.solution_values_p_total[q_point],
scratch.solution_values_J_total[q_point]);
const std::vector<std::shared_ptr<const PointHistory<dim>>> lqph =
quadrature_point_history.get_data(cell);
Assert(lqph.size() == n_q_points, ExcInternalError());
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ fe_values_ref.quadrature_point_indices())
{
const double det_F_qp = lqph[q_point]->get_det_F();
const double JxW = fe_values_ref.JxW(q_point);
const std::vector<std::shared_ptr<const PointHistory<dim>>> lqph =
quadrature_point_history.get_data(cell);
Assert(lqph.size() == n_q_points, ExcInternalError());
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ fe_values_ref.quadrature_point_indices())
{
const double det_F_qp = lqph[q_point]->get_det_F();
const double J_tilde_qp = lqph[q_point]->get_J_tilde();
const std::vector<std::shared_ptr<const PointHistory<dim>>> lqph =
quadrature_point_history.get_data(cell);
Assert(lqph.size() == n_q_points, ExcInternalError());
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ scratch.fe_values_ref.quadrature_point_indices())
{
const Tensor<2, dim> F_inv = lqph[q_point]->get_F_inv();
for (unsigned int k = 0; k < dofs_per_cell; ++k)
Assert(k_group <= J_dof, ExcInternalError());
}
}
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ scratch.fe_values_ref.quadrature_point_indices())
{
const Tensor<2, dim> tau = lqph[q_point]->get_tau();
const SymmetricTensor<4, dim> Jc = lqph[q_point]->get_Jc();
const std::vector<std::shared_ptr<const PointHistory<dim>>> lqph =
quadrature_point_history.get_data(cell);
Assert(lqph.size() == n_q_points, ExcInternalError());
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ scratch.fe_values_ref.quadrature_point_indices())
{
const Tensor<2, dim> F_inv = lqph[q_point]->get_F_inv();
for (unsigned int k = 0; k < dofs_per_cell; ++k)
Assert(k_group <= J_dof, ExcInternalError());
}
}
- for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
+ for (const unsigned int q_point :
+ scratch.fe_values_ref.quadrature_point_indices())
{
const SymmetricTensor<2, dim> tau = lqph[q_point]->get_tau();
const double det_F = lqph[q_point]->get_det_F();
cell->face(face)->boundary_id() == 6)
{
scratch.fe_face_values_ref.reinit(cell, face);
- for (unsigned int f_q_point = 0; f_q_point < n_q_points_f;
- ++f_q_point)
+ for (const unsigned int f_q_point :
+ scratch.fe_face_values_ref.quadrature_point_indices())
{
const Tensor<1, dim> &N =
scratch.fe_face_values_ref.normal_vector(f_q_point);