// DoFRenumbering::component_wise(dof_handler);
deallog << "Number of dofs: " << dof_handler.n_dofs() << std::endl;
- AffineConstraints<double> constraints;
- FEValuesExtractors::Vector velocities(1);
- ComponentMask mask = fe.component_mask(velocities);
+ AffineConstraints<double> constraints;
+ const FEValuesExtractors::Vector velocities(1);
+ ComponentMask mask = fe.component_mask(velocities);
deallog << "ComponentMask " << mask[0] << mask[1] << mask[2] << std::endl;
DoFTools::make_zero_boundary_constraints(dof_handler, constraints, mask);
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;
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;
dof_handler,
support_points);
- FEValuesExtractors::Vector v(0);
- FEValuesExtractors::Scalar v_1(0);
- FEValuesExtractors::Scalar v_2(1);
- FEValuesExtractors::Scalar v_3(2);
- FEValuesExtractors::Scalar pressure(3);
+ const FEValuesExtractors::Vector v(0);
+ const FEValuesExtractors::Scalar v_1(0);
+ const FEValuesExtractors::Scalar v_2(1);
+ const FEValuesExtractors::Scalar v_3(2);
+ const FEValuesExtractors::Scalar pressure(3);
ComponentMask velocity_mask;
if (constrain_only_velocity)
dof_handler,
support_points);
- FEValuesExtractors::Vector v(0);
- FEValuesExtractors::Scalar v_1(0);
- FEValuesExtractors::Scalar v_2(1);
- FEValuesExtractors::Scalar v_3(2);
- FEValuesExtractors::Scalar pressure(3);
+ const FEValuesExtractors::Vector v(0);
+ const FEValuesExtractors::Scalar v_1(0);
+ const FEValuesExtractors::Scalar v_2(1);
+ const FEValuesExtractors::Scalar v_3(2);
+ const FEValuesExtractors::Scalar pressure(3);
ComponentMask velocity_mask;
if (constrain_only_velocity)
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
{
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
{
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
{
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
{
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
{
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
{
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
{
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
{
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
{
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
{
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
{
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
{
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
{
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
{
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
{
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
{
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
{
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
{
{
initlog();
- FEValuesExtractors::Scalar scalar(0);
- FEValuesExtractors::Vector vector(1);
- FEValuesExtractors::Tensor<2> tensor(3);
- FEValuesExtractors::SymmetricTensor<2> symmetric_tensor(4);
+ const FEValuesExtractors::Scalar scalar(0);
+ const FEValuesExtractors::Vector vector(1);
+ const FEValuesExtractors::Tensor<2> tensor(3);
+ const FEValuesExtractors::SymmetricTensor<2> symmetric_tensor(4);
deallog << scalar.get_name() << std::endl
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
for (const auto q : fe_values.quadrature_point_indices())
// 'c'
if (c + dim <= fe.n_components())
{
- FEValuesExtractors::Vector vec_components(c);
+ const FEValuesExtractors::Vector vec_components(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
for (const auto q : fe_values.quadrature_point_indices())
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
for (const auto q : fe_values.quadrature_point_indices())
// 'c'
if (c + dim <= fe.n_components())
{
- FEValuesExtractors::Vector vec_components(c);
+ const FEValuesExtractors::Vector vec_components(c);
for (unsigned int i = 0; i < fe_values.dofs_per_cell; ++i)
for (const auto q : fe_values.quadrature_point_indices())
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
fe_values[single_component].get_function_values(fe_function,
scalar_values);
deallog << "component=" << c << std::endl;
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
fe_values[single_component].get_function_gradients(fe_function,
scalar_values);
deallog << "component=" << c << std::endl;
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
fe_values[single_component].get_function_hessians(fe_function,
scalar_values);
deallog << "component=" << c << std::endl;
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
fe_values[single_component].get_function_values(fe_function,
scalar_values);
deallog << "component=" << c << std::endl;
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
fe_values[single_component].get_function_gradients(fe_function,
scalar_values);
deallog << "component=" << c << std::endl;
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
fe_values[single_component].get_function_hessians(fe_function,
scalar_values);
deallog << "component=" << c << std::endl;
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
fe_values[single_component].get_function_hessians(fe_function,
scalar_values);
deallog << "component=" << c << std::endl;
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
fe_values[single_component].get_function_hessians(fe_function,
scalar_values);
deallog << "component=" << c << std::endl;
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
fe_values[single_component].get_function_hessians(fe_function,
scalar_values);
deallog << "component=" << c << std::endl;
// 'c'
if (c + dim <= fe.n_components())
{
- FEValuesExtractors::Vector vector_components(c);
+ const FEValuesExtractors::Vector vector_components(c);
fe_values[vector_components].get_function_values(
fe_function, selected_vector_values);
deallog << "component=" << c << std::endl;
// 'c'
if (c + dim <= fe.n_components())
{
- FEValuesExtractors::Vector vector_components(c);
+ const FEValuesExtractors::Vector vector_components(c);
fe_values[vector_components].get_function_gradients(
fe_function, selected_vector_values);
deallog << "component=" << c << std::endl;
// 'c'
if (c + dim <= fe.n_components())
{
- FEValuesExtractors::Vector vector_components(c);
+ const FEValuesExtractors::Vector vector_components(c);
fe_values[vector_components].get_function_hessians(
fe_function, selected_vector_values);
deallog << "component=" << c << std::endl;
// 'c'
if (c + dim <= fe.n_components())
{
- FEValuesExtractors::Vector vector_components(c);
+ const FEValuesExtractors::Vector vector_components(c);
fe_values[vector_components].get_function_values(
fe_function, selected_vector_values);
deallog << "component=" << c << std::endl;
// 'c'
if (c + dim <= fe.n_components())
{
- FEValuesExtractors::Vector vector_components(c);
+ const FEValuesExtractors::Vector vector_components(c);
fe_values[vector_components].get_function_gradients(
fe_function, selected_vector_values);
deallog << "component=" << c << std::endl;
// 'c'
if (c + dim <= fe.n_components())
{
- FEValuesExtractors::Vector vector_components(c);
+ const FEValuesExtractors::Vector vector_components(c);
fe_values[vector_components].get_function_hessians(
fe_function, selected_vector_values);
deallog << "component=" << c << std::endl;
// 'c'
if (c + dim <= fe.n_components())
{
- FEValuesExtractors::Vector vector_components(c);
+ const FEValuesExtractors::Vector vector_components(c);
fe_values[vector_components].get_function_symmetric_gradients(
fe_function, selected_vector_values);
deallog << "component=" << c << std::endl;
// 'c'
if (c + dim <= fe.n_components())
{
- FEValuesExtractors::Vector vector_components(c);
+ const FEValuesExtractors::Vector vector_components(c);
fe_values[vector_components].get_function_symmetric_gradients(
fe_function, selected_vector_values);
deallog << "component=" << c << std::endl;
// 'c'
if (c + dim <= fe.n_components())
{
- FEValuesExtractors::Vector vector_components(c);
+ const FEValuesExtractors::Vector vector_components(c);
fe_values[vector_components].get_function_divergences(
fe_function, selected_vector_values);
deallog << "component=" << c << std::endl;
// 'c'
if (c + dim <= fe.n_components())
{
- FEValuesExtractors::Vector vector_components(c);
+ const FEValuesExtractors::Vector vector_components(c);
fe_values[vector_components].get_function_divergences(
fe_function, selected_vector_values);
deallog << "component=" << c << std::endl;
// let the FEValues object compute the
// divergences at quadrature points
- std::vector<Tensor<1, dim>> divergences(quadrature.size());
- FEValuesExtractors::SymmetricTensor<2> extractor(0);
+ std::vector<Tensor<1, dim>> divergences(quadrature.size());
+ const FEValuesExtractors::SymmetricTensor<2> extractor(0);
fe_values[extractor].get_function_divergences(fe_function, divergences);
// now do the same "by hand"
// let the FEValues object compute the
// divergences at quadrature points
- std::vector<Tensor<1, dim>> divergences(quadrature.size());
- FEValuesExtractors::Tensor<2> extractor(0);
+ std::vector<Tensor<1, dim>> divergences(quadrature.size());
+ const FEValuesExtractors::Tensor<2> extractor(0);
fe_values[extractor].get_function_divergences(fe_function, divergences);
// now do the same "by hand"
// let the FEValues object compute the
// divergences at quadrature points
- std::vector<Tensor<1, dim>> divergences(quadrature.size());
- FEValuesExtractors::SymmetricTensor<2> extractor(0);
+ std::vector<Tensor<1, dim>> divergences(quadrature.size());
+ const FEValuesExtractors::SymmetricTensor<2> extractor(0);
fe_values[extractor].get_function_divergences(fe_function, divergences);
// now do the same "by hand"
// let the FEValues object compute the
// divergences at quadrature points
- std::vector<Tensor<1, dim>> divergences(quadrature.size());
- FEValuesExtractors::Tensor<2> extractor(0);
+ std::vector<Tensor<1, dim>> divergences(quadrature.size());
+ const FEValuesExtractors::Tensor<2> extractor(0);
fe_values[extractor].get_function_divergences(fe_function, divergences);
for (unsigned int i = 0; i < fe.dofs_per_cell; ++i)
// let the FEValues object compute the
// divergences at quadrature points
- std::vector<Tensor<1, dim>> divergences(quadrature.size());
- FEValuesExtractors::SymmetricTensor<2> extractor(0);
+ std::vector<Tensor<1, dim>> divergences(quadrature.size());
+ const FEValuesExtractors::SymmetricTensor<2> extractor(0);
fe_values[extractor].get_function_divergences(fe_function, divergences);
// now do the same "by hand"
// let the FEValues object compute the
// divergences at quadrature points
- std::vector<Tensor<1, dim>> divergences(quadrature.size());
- FEValuesExtractors::Tensor<2> extractor(0);
+ std::vector<Tensor<1, dim>> divergences(quadrature.size());
+ const FEValuesExtractors::Tensor<2> extractor(0);
fe_values[extractor].get_function_divergences(fe_function, divergences);
// now do the same "by hand"
// let the FEValues object compute the
// divergences at quadrature points
- FEValuesExtractors::Tensor<2> extractor(0);
+ const FEValuesExtractors::Tensor<2> extractor(0);
// also compare get_function_values/gradients/divergences
// the manual evaluation
// divergences at quadrature points
std::vector<typename dealii::internal::CurlType<dim>::type> curls(
quadrature.size());
- std::vector<Tensor<2, dim>> grads(quadrature.size());
- FEValuesExtractors::Vector extractor(0);
+ std::vector<Tensor<2, dim>> grads(quadrature.size());
+ const FEValuesExtractors::Vector extractor(0);
fe_values[extractor].get_function_curls(fe_function, curls);
fe_values[extractor].get_function_gradients(fe_function, grads);
// divergences at quadrature points
std::vector<typename dealii::internal::CurlType<dim>::type> curls(
quadrature.size());
- std::vector<Tensor<2, dim>> grads(quadrature.size());
- FEValuesExtractors::Vector extractor(0);
+ std::vector<Tensor<2, dim>> grads(quadrature.size());
+ const FEValuesExtractors::Vector extractor(0);
fe_values[extractor].get_function_curls(fe_function, curls);
fe_values[extractor].get_function_gradients(fe_function, grads);
// divergences at quadrature points
std::vector<typename dealii::internal::CurlType<dim>::type> curls(
quadrature.size());
- std::vector<Tensor<2, dim>> grads(quadrature.size());
- FEValuesExtractors::Vector extractor(0);
+ std::vector<Tensor<2, dim>> grads(quadrature.size());
+ const FEValuesExtractors::Vector extractor(0);
fe_values[extractor].get_function_curls(fe_function, curls);
fe_values[extractor].get_function_gradients(fe_function, grads);
// divergences at quadrature points
std::vector<typename dealii::internal::CurlType<dim>::type> curls(
quadrature.size());
- std::vector<Tensor<2, dim>> grads(quadrature.size());
- FEValuesExtractors::Vector extractor(0);
+ std::vector<Tensor<2, dim>> grads(quadrature.size());
+ const FEValuesExtractors::Vector extractor(0);
fe_values[extractor].get_function_curls(fe_function, curls);
fe_values[extractor].get_function_gradients(fe_function, grads);
// 'c'
if (c + dim <= fe.n_components())
{
- FEValuesExtractors::Vector vector_components(c);
+ const FEValuesExtractors::Vector vector_components(c);
fe_values[vector_components].get_function_third_derivatives(
function_vals, selected_vector_values);
deallog << "component=" << c << std::endl;
deallog.push("Scalar");
{
- FE_Q<dim> fe(degree);
- FEValuesExtractors::Scalar extractor(0);
+ FE_Q<dim> fe(degree);
+ const FEValuesExtractors::Scalar extractor(0);
test_extractor<NumberType, dim>(fe, extractor);
}
deallog.pop();
deallog.push("Vector");
{
- FESystem<dim> fe(FE_Q<dim>(degree), dim);
- FEValuesExtractors::Vector extractor(0);
+ FESystem<dim> fe(FE_Q<dim>(degree), dim);
+ const FEValuesExtractors::Vector extractor(0);
test_extractor<NumberType, dim>(fe, extractor);
}
deallog.pop();
deallog.push("SymmetricTensor");
{
- FESystem<dim> fe(FE_Q<dim>(degree),
+ FESystem<dim> fe(FE_Q<dim>(degree),
SymmetricTensor<2, dim>::n_independent_components);
- FEValuesExtractors::SymmetricTensor<2> extractor(0);
+ const FEValuesExtractors::SymmetricTensor<2> extractor(0);
test_extractor<NumberType, dim>(fe, extractor);
}
deallog.pop();
deallog.push("Tensor");
{
- FESystem<dim> fe(FE_Q<dim>(degree),
+ FESystem<dim> fe(FE_Q<dim>(degree),
Tensor<2, dim>::n_independent_components);
- FEValuesExtractors::Tensor<2> extractor(0);
+ const FEValuesExtractors::Tensor<2> extractor(0);
test_extractor<NumberType, dim>(fe, extractor);
}
deallog.pop();
deallog.push("Scalar");
{
- FE_Q<dim> fe(degree);
- FEValuesExtractors::Scalar extractor(0);
+ FE_Q<dim> fe(degree);
+ const FEValuesExtractors::Scalar extractor(0);
test_extractor<NumberType, dim>(fe, extractor);
}
deallog.pop();
deallog.push("Vector");
{
- FESystem<dim> fe(FE_Q<dim>(degree), dim);
- FEValuesExtractors::Vector extractor(0);
+ FESystem<dim> fe(FE_Q<dim>(degree), dim);
+ const FEValuesExtractors::Vector extractor(0);
test_extractor<NumberType, dim>(fe, extractor);
}
deallog.pop();
deallog.push("SymmetricTensor");
{
- FESystem<dim> fe(FE_Q<dim>(degree),
+ FESystem<dim> fe(FE_Q<dim>(degree),
SymmetricTensor<2, dim>::n_independent_components);
- FEValuesExtractors::SymmetricTensor<2> extractor(0);
+ const FEValuesExtractors::SymmetricTensor<2> extractor(0);
test_extractor<NumberType, dim>(fe, extractor);
}
deallog.pop();
deallog.push("Tensor");
{
- FESystem<dim> fe(FE_Q<dim>(degree),
+ FESystem<dim> fe(FE_Q<dim>(degree),
Tensor<2, dim>::n_independent_components);
- FEValuesExtractors::Tensor<2> extractor(0);
+ const FEValuesExtractors::Tensor<2> extractor(0);
test_extractor<NumberType, dim>(fe, extractor);
}
deallog.pop();
FEValues<dim> fe_values(fe, quadrature, update_values);
fe_values.reinit(dof.begin_active());
- FEValuesExtractors::Scalar extr; // invalid object
+ const FEValuesExtractors::Scalar extr; // invalid object
try
{
fe_values[extr]; // invalid access
FEValues<dim> fe_values(fe, quadrature, update_values);
fe_values.reinit(dof.begin_active());
- FEValuesExtractors::Vector extr; // invalid object
+ const FEValuesExtractors::Vector extr; // invalid object
try
{
fe_values[extr]; // invalid access
FEValues<dim> fe_values(fe, quadrature, update_values);
fe_values.reinit(dof.begin_active());
- FEValuesExtractors::SymmetricTensor<2> extr; // invalid object
+ const FEValuesExtractors::SymmetricTensor<2> extr; // invalid object
try
{
fe_values[extr]; // invalid access
FEValues<dim> fe_values(fe, quadrature, update_values);
fe_values.reinit(dof.begin_active());
- FEValuesExtractors::Tensor<2> extr; // invalid object
+ const FEValuesExtractors::Tensor<2> extr; // invalid object
try
{
fe_values[extr]; // invalid access
{
initlog();
- FEValuesExtractors::Scalar scalar(0);
- FEValuesExtractors::Vector vector(1);
- FEValuesExtractors::Tensor<2> tensor(2);
+ const FEValuesExtractors::Scalar scalar(0);
+ const FEValuesExtractors::Vector vector(1);
+ const FEValuesExtractors::Tensor<2> tensor(2);
test<1, 1>(scalar);
test<1, 1>(vector);
<< "n_coupling_dofs = " << fcv.n_coupling_dofs() << std::endl;
FullMatrix<double> matrix(fcv.n_coupling_dofs(), fcv.n_coupling_dofs());
- FEValuesExtractors::Scalar scalar(0);
+ const FEValuesExtractors::Scalar scalar(0);
const auto first = fcv.get_first_extractor(scalar);
const auto second = fcv.get_second_extractor(scalar);
QuadratureCouplingType::reorder);
FullMatrix<double> matrix(fcv.n_coupling_dofs(), fcv.n_coupling_dofs());
- FEValuesExtractors::Scalar scalar(0);
+ const FEValuesExtractors::Scalar scalar(0);
const auto bulk = fcv.get_first_extractor(scalar);
const auto surface = fcv.get_second_extractor(scalar);
QuadratureCouplingType::matching);
FullMatrix<double> matrix(fcv.n_coupling_dofs(), fcv.n_coupling_dofs());
- FEValuesExtractors::Scalar scalar(0);
+ const FEValuesExtractors::Scalar scalar(0);
const auto bulk = fcv.get_first_extractor(scalar);
const auto surface = fcv.get_second_extractor(scalar);
void
test()
{
- FESystem<dim> fe(FE_DGP<dim>(4), 1);
- FEValuesExtractors::Scalar extractor(0);
+ FESystem<dim> fe(FE_DGP<dim>(4), 1);
+ const FEValuesExtractors::Scalar extractor(0);
Triangulation<dim> tria;
DoFHandler<dim> dof_handler(tria);
for (unsigned int c = 0; c < fe.n_components(); ++c)
{
- FEValuesExtractors::Scalar single_component(c);
+ const FEValuesExtractors::Scalar single_component(c);
for (unsigned int i = 0; i < n_dofs_face; ++i)
for (unsigned int q = 0; q < n_q_points; ++q)
{
// 'c'
if (c + dim <= fe.n_components())
{
- FEValuesExtractors::Vector vec_components(c);
+ const FEValuesExtractors::Vector vec_components(c);
for (unsigned int i = 0; i < n_dofs_face; ++i)
for (unsigned int q = 0; q < n_q_points; ++q)
{
void
test_jump_function()
{
- FE_DGP<dim> fe(0);
- FEValuesExtractors::Scalar extractor(0);
+ FE_DGP<dim> fe(0);
+ const FEValuesExtractors::Scalar extractor(0);
Triangulation<dim> tria;
DoFHandler<dim> dof_handler(tria);
deallog.push("FEInterfaceViews Scalar");
{
- FE_Q<dim> fe(degree);
- FEValuesExtractors::Scalar extractor(0);
+ FE_Q<dim> fe(degree);
+ const FEValuesExtractors::Scalar extractor(0);
test_feiv_extractor<NumberType, dim>(fe, extractor);
}
deallog.pop();
deallog.push("FEInterfaceViews Vector");
{
- FESystem<dim> fe(FE_Q<dim>(degree), dim);
- FEValuesExtractors::Vector extractor(0);
+ FESystem<dim> fe(FE_Q<dim>(degree), dim);
+ const FEValuesExtractors::Vector extractor(0);
test_feiv_extractor<NumberType, dim>(fe, extractor);
}
deallog.pop();
deallog.push("FEInterfaceViews Scalar");
{
- FE_Q<dim> fe(degree);
- FEValuesExtractors::Scalar extractor(0);
+ FE_Q<dim> fe(degree);
+ const FEValuesExtractors::Scalar extractor(0);
test_feiv_extractor<NumberType, dim>(fe, extractor);
}
deallog.pop();
deallog.push("FEInterfaceViews Vector");
{
- FESystem<dim> fe(FE_Q<dim>(degree), dim);
- FEValuesExtractors::Vector extractor(0);
+ FESystem<dim> fe(FE_Q<dim>(degree), dim);
+ const FEValuesExtractors::Vector extractor(0);
test_feiv_extractor<NumberType, dim>(fe, extractor);
}
deallog.pop();
DoFHandler<dim> dof_handler(triangulation);
dof_handler.distribute_dofs(fe);
- FEValues<dim> fe_values(fe, QGauss<dim>(2), update_values);
- FEValuesExtractors::Scalar nothing(1);
+ FEValues<dim> fe_values(fe, QGauss<dim>(2), update_values);
+ const FEValuesExtractors::Scalar nothing(1);
fe_values.reinit(dof_handler.begin_active());
for (unsigned int i = 0; i < fe.dofs_per_cell; ++i)
for (unsigned int q = 0; q < fe_values.n_quadrature_points; ++q)
DoFHandler<dim> dof_handler(triangulation);
dof_handler.distribute_dofs(fe);
- QGauss<dim - 1> q(2);
- FEFaceValues<dim> fe_values(fe, q, update_values);
- FEValuesExtractors::Scalar nothing(1);
+ QGauss<dim - 1> q(2);
+ FEFaceValues<dim> fe_values(fe, q, update_values);
+ const FEValuesExtractors::Scalar nothing(1);
fe_values.reinit(dof_handler.begin_active(), 0);
// the following (second) call to reinit
DoFRenumbering::component_wise(dof_handler, block_component);
{
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,
StokesProblem<dim>::refine_mesh()
{
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),
std::vector<Tensor<1, dim>> function_values(unit_points.size());
std::vector<Tensor<2, dim>> function_gradients(unit_points.size());
- FEValuesExtractors::Vector extractor(0);
+ const FEValuesExtractors::Vector extractor(0);
for (const auto &cell : dof_handler.active_cell_iterators())
{
std::vector<double> function_values_scalar(unit_points.size());
std::vector<Tensor<1, dim>> function_gradients_scalar(unit_points.size());
- FEValuesExtractors::Vector extractor(0);
- FEValuesExtractors::Scalar extractor_s(dim);
+ const FEValuesExtractors::Vector extractor(0);
+ const FEValuesExtractors::Scalar extractor_s(dim);
for (const auto &cell : dof_handler.active_cell_iterators())
{
std::vector<Tensor<1, dim>> function_values(unit_points.size());
std::vector<Tensor<2, dim>> function_gradients(unit_points.size());
- FEValuesExtractors::Vector extractor(0);
+ const FEValuesExtractors::Vector extractor(0);
for (const auto &cell : dof_handler.active_cell_iterators())
{
std::vector<double> function_values_scalar(unit_points.size());
std::vector<Tensor<1, dim>> function_gradients_scalar(unit_points.size());
- FEValuesExtractors::Vector extractor(0);
- FEValuesExtractors::Scalar extractor_s(dim);
+ const FEValuesExtractors::Vector extractor(0);
+ const FEValuesExtractors::Scalar extractor_s(dim);
for (const auto &cell : dof_handler.active_cell_iterators())
{
std::vector<Tensor<1, dim>> function_values(unit_points.size());
std::vector<Tensor<2, dim>> function_gradients(unit_points.size());
- FEValuesExtractors::Vector extractor(0);
+ const FEValuesExtractors::Vector extractor(0);
for (const auto &cell : dof_handler.active_cell_iterators())
{
std::vector<double> function_values(unit_points.size());
std::vector<Tensor<1, dim>> function_gradients(unit_points.size());
- FEValuesExtractors::Scalar extractor(1);
+ const FEValuesExtractors::Scalar extractor(1);
for (const auto &cell : dof_handler.active_cell_iterators())
{
std::vector<double> solution_values(fe.dofs_per_cell);
std::vector<double> solution_values2(fe.dofs_per_cell);
- FEValuesExtractors::Vector extractor(0);
+ const FEValuesExtractors::Vector extractor(0);
for (const auto &cell : dof_handler.active_cell_iterators())
{
std::vector<double> solution_values(fe.dofs_per_cell);
std::vector<double> solution_values2(fe.dofs_per_cell);
- FEValuesExtractors::Vector extractor(0);
+ const FEValuesExtractors::Vector extractor(0);
for (const auto &cell : dof_handler.active_cell_iterators())
{
std::vector<double> solution_values(fe.dofs_per_cell);
std::vector<double> solution_values2(fe.dofs_per_cell);
- FEValuesExtractors::Vector extractor(0);
+ const FEValuesExtractors::Vector extractor(0);
for (const auto &cell : dof_handler.active_cell_iterators())
{
std::vector<Tensor<1, spacedim>> function_values(unit_points.size());
std::vector<Tensor<2, spacedim>> function_gradients(unit_points.size());
- FEValuesExtractors::Vector extractor(0);
+ const FEValuesExtractors::Vector extractor(0);
for (const auto &cell : dof_handler.active_cell_iterators())
{
{};
- double H1_norm = 0;
- FEValuesExtractors::Scalar scalar(0);
+ double H1_norm = 0;
+ const FEValuesExtractors::Scalar scalar(0);
ScratchData scratch(fe, quad, cell_flags);
CopyData copy;
using Iterator = decltype(cell);
- FEValuesExtractors::Scalar scalar(0);
+ const FEValuesExtractors::Scalar scalar(0);
auto cell_worker = [&rhs_function, &solution, &scalar](const Iterator &cell,
ScratchData &s,
using Iterator = decltype(cell);
- FEValuesExtractors::Scalar scalar(0);
+ const FEValuesExtractors::Scalar scalar(0);
auto cell_worker = [&rhs_function, &solution, &scalar](const Iterator &cell,
ScratchData &s,
using Iterator = decltype(cell);
- FEValuesExtractors::Scalar scalar(0);
+ const FEValuesExtractors::Scalar scalar(0);
auto cell_worker = [&rhs_function, &solution, &scalar](const Iterator &cell,
ScratchData &s,
Utilities::MPI::MPI_InitFinalize mpi_initialization(
argc, argv, testing_max_num_threads());
- FEValuesExtractors::Scalar extractor(0);
+ const FEValuesExtractors::Scalar extractor(0);
run<2>(extractor);
run<3>(extractor);
Utilities::MPI::MPI_InitFinalize mpi_initialization(
argc, argv, testing_max_num_threads());
- FEValuesExtractors::Scalar extractor(0);
+ const FEValuesExtractors::Scalar extractor(0);
run<2>(extractor);
run<3>(extractor);
Utilities::MPI::MPI_InitFinalize mpi_initialization(
argc, argv, testing_max_num_threads());
- FEValuesExtractors::Vector extractor(0);
+ const FEValuesExtractors::Vector extractor(0);
// Just run in 3d, so we can extract the curl
run<3>(extractor);
Utilities::MPI::MPI_InitFinalize mpi_initialization(
argc, argv, testing_max_num_threads());
- FEValuesExtractors::Vector extractor(0);
+ const FEValuesExtractors::Vector extractor(0);
// Just run in 3d, so we can extract the curl
run<3>(extractor);
Utilities::MPI::MPI_InitFinalize mpi_initialization(
argc, argv, testing_max_num_threads());
- FEValuesExtractors::Tensor<2> extractor(0);
+ const FEValuesExtractors::Tensor<2> extractor(0);
run<2>(extractor);
run<3>(extractor);
Utilities::MPI::MPI_InitFinalize mpi_initialization(
argc, argv, testing_max_num_threads());
- FEValuesExtractors::Tensor<2> extractor(0);
+ const FEValuesExtractors::Tensor<2> extractor(0);
run<2>(extractor);
run<3>(extractor);
Utilities::MPI::MPI_InitFinalize mpi_initialization(
argc, argv, testing_max_num_threads());
- FEValuesExtractors::SymmetricTensor<2> extractor(0);
+ const FEValuesExtractors::SymmetricTensor<2> extractor(0);
run<2>(extractor);
run<3>(extractor);
Utilities::MPI::MPI_InitFinalize mpi_initialization(
argc, argv, testing_max_num_threads());
- FEValuesExtractors::SymmetricTensor<2> extractor(0);
+ const FEValuesExtractors::SymmetricTensor<2> extractor(0);
run<2>(extractor);
run<3>(extractor);
Utilities::MPI::MPI_InitFinalize mpi_initialization(
argc, argv, testing_max_num_threads());
- FEValuesExtractors::Scalar extractor(0);
+ const FEValuesExtractors::Scalar extractor(0);
run<2>(extractor);
run<3>(extractor);
Utilities::MPI::MPI_InitFinalize mpi_initialization(
argc, argv, testing_max_num_threads());
- FEValuesExtractors::Scalar extractor(0);
+ const FEValuesExtractors::Scalar extractor(0);
run<2>(extractor);
run<3>(extractor);
Utilities::MPI::MPI_InitFinalize mpi_initialization(
argc, argv, testing_max_num_threads());
- FEValuesExtractors::Vector extractor(0);
+ const FEValuesExtractors::Vector extractor(0);
run<2>(extractor);
run<3>(extractor);
Utilities::MPI::MPI_InitFinalize mpi_initialization(
argc, argv, testing_max_num_threads());
- FEValuesExtractors::Vector extractor(0);
+ const FEValuesExtractors::Vector extractor(0);
run<2>(extractor);
run<3>(extractor);
{
constraints.clear();
- FEValuesExtractors::Vector velocities(0);
- FEValuesExtractors::Scalar pressure(dim);
+ const FEValuesExtractors::Vector velocities(0);
+ const FEValuesExtractors::Scalar pressure(dim);
DoFTools::make_hanging_node_constraints(dof_handler, constraints);
#ifdef PERIODIC
{
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),
constraints.clear();
constraints.reinit(locally_relevant_dofs);
- FEValuesExtractors::Vector velocities(0);
- FEValuesExtractors::Scalar pressure(dim);
+ const FEValuesExtractors::Vector velocities(0);
+ const FEValuesExtractors::Scalar pressure(dim);
DoFTools::make_hanging_node_constraints(dof_handler, constraints);
#ifdef PERIODIC
{
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),
constraints.clear();
constraints.reinit(locally_relevant_dofs);
- FEValuesExtractors::Vector velocities(0);
- FEValuesExtractors::Scalar pressure(dim);
+ const FEValuesExtractors::Vector velocities(0);
+ const FEValuesExtractors::Scalar pressure(dim);
DoFTools::make_hanging_node_constraints(dof_handler, constraints);
{
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),
{
constraints.reinit(locally_relevant_dofs);
- FEValuesExtractors::Vector velocities(0);
+ const FEValuesExtractors::Vector velocities(0);
DoFTools::make_hanging_node_constraints(dof_handler, constraints);
VectorTools::project_boundary_values_div_conforming(
dot_soln_t -= soln_t1;
dot_soln_t *= (1.0 / delta_t);
- FEValuesExtractors::Vector u_fe(0);
- std::vector<Tensor<2, dim>> qp_Grad_u_t;
- std::vector<Tensor<2, dim>> qp_Grad_u_t1;
- std::vector<Tensor<2, dim>> qp_dot_Grad_u_t;
- std::vector<Tensor<2, dim>> qp_dot_grad_u_t;
+ const FEValuesExtractors::Vector u_fe(0);
+ std::vector<Tensor<2, dim>> qp_Grad_u_t;
+ std::vector<Tensor<2, dim>> qp_Grad_u_t1;
+ std::vector<Tensor<2, dim>> qp_dot_Grad_u_t;
+ std::vector<Tensor<2, dim>> qp_dot_grad_u_t;
FEValues<dim> fe_values(fe, qf, update_gradients);
MappingQEulerian<dim> q1_mapping(1, dof_handler, soln_t);
}
system_matrix.compress(VectorOperation::add);
system_rhs.compress(VectorOperation::add);
- 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,
}
system_matrix.compress(VectorOperation::add);
system_rhs.compress(VectorOperation::add);
- 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,
#endif
- 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(mapping,
dof_handler,
deallog << " Rebuilding Stokes preconditioner..." << std::flush;
assemble_stokes_preconditioner();
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),
{
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,
dof_handler,