if (this->parameters.load_type == "displacement")
{
const std::vector<double> value = get_dirichlet_load(5,2);
- FEValuesExtractors::Scalar direction;
+ const FEValuesExtractors::Scalar direction;
direction = this->z_displacement;
VectorTools::interpolate_boundary_values( this->dof_handler_ref,
if (this->parameters.load_type == "displacement")
{
const std::vector<double> value = get_dirichlet_load(5,2);
- FEValuesExtractors::Scalar direction;
+ const FEValuesExtractors::Scalar direction;
direction = this->z_displacement;
VectorTools::interpolate_boundary_values( this->dof_handler_ref,
if (this->parameters.load_type == "displacement")
{
const std::vector<double> value = get_dirichlet_load(4,0);
- FEValuesExtractors::Scalar direction;
+ const FEValuesExtractors::Scalar direction;
direction = this->x_displacement;
VectorTools::interpolate_boundary_values( this->dof_handler_ref,
std::vector<unsigned int> local_dof_indices (dofs_per_cell);
- FEValuesExtractors::Scalar c(0), lambda(1), f(2);
+ const FEValuesExtractors::Scalar c(0), lambda(1), f(2);
for (const auto &cell : dof_handler.active_cell_iterators())
{
QGauss<dim> quadrature(3);
FEValues<dim> fe_values (fe, quadrature, update_values | update_JxW_values);
- FEValuesExtractors::Scalar lambda(1), f(2);
+ const FEValuesExtractors::Scalar lambda(1), f(2);
std::vector<double> lambda_values (quadrature.size());
std::vector<double> f_values (quadrature.size());
else
dirichlet_bc_ids = std::vector<unsigned int>{0, 2, 3, 4, 5, 6};
- FEValuesExtractors::Vector velocities(0);
+ const FEValuesExtractors::Vector velocities(0);
for (auto id : dirichlet_bc_ids)
{
VectorTools::interpolate_boundary_values(dof_handler,
pcout << "Refining mesh..." << std::endl;
Vector<float> estimated_error_per_cell(triangulation.n_active_cells());
- FEValuesExtractors::Vector velocity(0);
+ const FEValuesExtractors::Vector velocity(0);
KellyErrorEstimator<dim>::estimate(dof_handler,
face_quad_formula,
{},