// which vector components it should apply to; this is a vector of bools
// for each vector component and because we only want to restrict vertical
// motion, it has only its last component set:
- FEValuesExtractors::Scalar z_component(dim - 1);
+ const FEValuesExtractors::Scalar z_component(dim - 1);
std::map<types::global_dof_index, double> boundary_values;
VectorTools::interpolate_boundary_values(dof_handler,
0,
{
constraints.clear();
- FEValuesExtractors::Vector velocities(0);
+ const FEValuesExtractors::Vector velocities(0);
DoFTools::make_hanging_node_constraints(dof_handler, constraints);
VectorTools::interpolate_boundary_values(dof_handler,
1,
{
Vector<float> estimated_error_per_cell(triangulation.n_active_cells());
- FEValuesExtractors::Scalar pressure(dim);
+ const FEValuesExtractors::Scalar pressure(dim);
KellyErrorEstimator<dim>::estimate(
dof_handler,
QGauss<dim - 1>(degree + 1),
Amg_preconditioner = std::make_shared<TrilinosWrappers::PreconditionAMG>();
- std::vector<std::vector<bool>> constant_modes;
- FEValuesExtractors::Vector velocity_components(0);
+ std::vector<std::vector<bool>> constant_modes;
+ const FEValuesExtractors::Vector velocity_components(0);
DoFTools::extract_constant_modes(stokes_dof_handler,
stokes_fe.component_mask(
velocity_components),
DoFTools::make_hanging_node_constraints(stokes_dof_handler,
stokes_constraints);
- FEValuesExtractors::Vector velocity_components(0);
+ const FEValuesExtractors::Vector velocity_components(0);
VectorTools::interpolate_boundary_values(
stokes_dof_handler,
0,
assemble_stokes_preconditioner();
- std::vector<std::vector<bool>> constant_modes;
- FEValuesExtractors::Vector velocity_components(0);
+ std::vector<std::vector<bool>> constant_modes;
+ const FEValuesExtractors::Vector velocity_components(0);
DoFTools::extract_constant_modes(stokes_dof_handler,
stokes_fe.component_mask(
velocity_components),
{
darcy_preconditioner_constraints.clear();
- FEValuesExtractors::Scalar pressure(dim);
+ const FEValuesExtractors::Scalar pressure(dim);
DoFTools::make_hanging_node_constraints(darcy_dof_handler,
darcy_preconditioner_constraints);
constraints.clear();
constraints.reinit(locally_relevant_dofs);
- FEValuesExtractors::Vector velocities(0);
+ const FEValuesExtractors::Vector velocities(0);
DoFTools::make_hanging_node_constraints(dof_handler, constraints);
VectorTools::interpolate_boundary_values(mapping,
{
Vector<float> estimated_error_per_cell(triangulation.n_active_cells());
- FEValuesExtractors::Scalar pressure(dim);
+ const FEValuesExtractors::Scalar pressure(dim);
KellyErrorEstimator<dim>::estimate(
dof_handler,
QGauss<dim - 1>(degree + 1),
update_values | update_hessians |
update_quadrature_points | update_JxW_values);
- FEValuesExtractors::Scalar scalar(0);
- const unsigned int n_q_points = quadrature_formula.size();
+ const FEValuesExtractors::Scalar scalar(0);
+ const unsigned int n_q_points = quadrature_formula.size();
std::vector<SymmetricTensor<2, dim>> exact_hessians(n_q_points);
std::vector<Tensor<2, dim>> hessians(n_q_points);
scratch.fe_values_local.reinit(loc_cell);
scratch.fe_values.reinit(cell);
- FEValuesExtractors::Vector fluxes(0);
- FEValuesExtractors::Scalar scalar(dim);
+ const FEValuesExtractors::Vector fluxes(0);
+ const FEValuesExtractors::Scalar scalar(dim);
const unsigned int n_q_points = scratch.fe_values.get_quadrature().size();
const unsigned int dofs_per_cell = scratch.fe_values.dofs_per_cell;
Vector<float> estimated_error_per_cell(
triangulation.n_active_cells());
- FEValuesExtractors::Scalar scalar(dim);
+ const FEValuesExtractors::Scalar scalar(dim);
std::map<types::boundary_id, const Function<dim> *>
neumann_boundary;
KellyErrorEstimator<dim>::estimate(dof_handler_local,
{
constraints.reinit(locally_relevant_dofs);
- FEValuesExtractors::Vector velocities(0);
+ const FEValuesExtractors::Vector velocities(0);
DoFTools::make_hanging_node_constraints(dof_handler, constraints);
VectorTools::interpolate_boundary_values(dof_handler,
0,
// remain satisfied during Newton's iteration, zero boundary conditions are
// used for the update $\delta u^k$. Therefore we set up two different
// constraint objects.
- FEValuesExtractors::Vector velocities(0);
+ const FEValuesExtractors::Vector velocities(0);
{
nonzero_constraints.clear();
void StationaryNavierStokes<dim>::refine_mesh()
{
Vector<float> estimated_error_per_cell(triangulation.n_active_cells());
- FEValuesExtractors::Vector velocity(0);
+ const FEValuesExtractors::Vector velocity(0);
KellyErrorEstimator<dim>::estimate(
dof_handler,
QGauss<dim - 1>(degree + 1),
{
constraints.reinit(locally_relevant_dofs);
- FEValuesExtractors::Vector velocities(0);
+ const FEValuesExtractors::Vector velocities(0);
DoFTools::make_hanging_node_constraints(fluid_dh, constraints);
VectorTools::interpolate_boundary_values(
fluid_dh,