DoFTools::extract_locally_relevant_dofs(dof_handler,
locally_relevant_dofs);
- std::vector<types::global_dof_index> dofs_per_component(dim+1);
- DoFTools::count_dofs_per_component(dof_handler, dofs_per_component);
+ const std::vector<types::global_dof_index> dofs_per_component =
+ DoFTools::count_dofs_per_fe_component(dof_handler);
// Discontinuous Galerkin methods are fantanistic methods in part because
// many of the limitations of traditional finite element methods no longer
dsp);
SparsityTools::distribute_sparsity_pattern(dsp,
- dof_handler.n_locally_owned_dofs_per_processor(),
+ dof_handler.locally_owned_dofs(),
MPI_COMM_WORLD,
locally_relevant_dofs);
// compute the interior fluxes across the children faces
// and the neighbor's face.
for (unsigned int subface_no=0;
- subface_no < face->number_of_children();
+ subface_no < face->n_children();
++subface_no)
{
// We then get the neighbor cell's subface that
H1_error = difference_per_cell.l2_norm();
// compute W1infty error (save to difference_per_cell)
- const QTrapez<1> q_trapez;
+ const QTrapezoid<1> q_trapez;
const QIterated<dim> q_iterated (q_trapez, 5);
VectorTools::integrate_difference (dof_handler,present_solution,Solution<dim>(),
difference_per_cell,q_iterated,VectorTools::W1infty_seminorm);
std::map<types::global_dof_index,double> boundary_values;
VectorTools::interpolate_boundary_values (dof_handler,
0,
- ZeroFunction<dim>(),
+ Functions::ZeroFunction<dim>(),
boundary_values);
MatrixTools::apply_boundary_values (boundary_values,
system_matrix,
double ElastoplasticTorsion<dim>::dual_infty_error () const
{
double obj = 0.0;
- const QTrapez<1> q_trapez;
+ const QTrapezoid<1> q_trapez;
const QIterated<dim> quadrature_formula (q_trapez, 10);
FEValues<dim> fe_values (fe, quadrature_formula,
{
Point<dim> operator() (const Point<dim> &in) const
{
- static const Tensor<2,dim> rot_mat = Physics::Transformations::Rotations::rotation_matrix_3d(Point<dim>(0,1,0), M_PI/2.0);
+ static const Tensor<2,dim> rot_mat = Physics::Transformations::Rotations::rotation_matrix_3d(Tensor<1,dim>({0,1,0}), M_PI/2.0);
return Point<dim>(rot_mat*in);
}
};
component_mask_x.set(0, true);
VectorTools::interpolate_boundary_values (dof_handler,
parameters.bid_CC_dirichlet_symm_X,
- ZeroFunction<dim>(dim),
+ Functions::ZeroFunction<dim>(dim),
boundary_values,
component_mask_x);
}
component_mask_z.set(2, true);
VectorTools::interpolate_boundary_values (dof_handler,
parameters.bid_CC_dirichlet_symm_Z,
- ZeroFunction<dim>(dim),
+ Functions::ZeroFunction<dim>(dim),
boundary_values,
component_mask_z);
}
component_mask_x.set(0, true);
VectorTools::interpolate_boundary_values (dof_handler,
parameters.bid_BB_dirichlet_X,
- ZeroFunction<dim>(dim),
+ Functions::ZeroFunction<dim>(dim),
boundary_values,
component_mask_x);
}
ComponentMask component_mask_x (dim, true);
VectorTools::interpolate_boundary_values (dof_handler,
parameters.bid_BB_dirichlet_X,
- ZeroFunction<dim>(dim),
+ Functions::ZeroFunction<dim>(dim),
boundary_values,
component_mask_x);
}
component_mask_x.set(2, true);
VectorTools::interpolate_boundary_values (dof_handler,
parameters.bid_BB_neumann,
- ZeroFunction<dim>(dim),
+ Functions::ZeroFunction<dim>(dim),
boundary_values,
component_mask_x);
}
VectorTools::interpolate_boundary_values(dof_handler,
0,
- ZeroFunction<dim>(),
+ Functions::ZeroFunction<dim>(),
boundary_values);
}
}
dof_handler.distribute_dofs(fe);
DoFRenumbering::component_wise (dof_handler);
- std::vector<types::global_dof_index> dofs_per_component (dim+1);
- DoFTools::count_dofs_per_component (dof_handler, dofs_per_component);
+ const std::vector<types::global_dof_index> dofs_per_component
+ = DoFTools::count_dofs_per_fe_component (dof_handler);
QGaussLobatto<dim> quad(degree+1);
QGauss<dim-1> face_quad(degree);
Vector<double> cellwise_errors (triangulation.n_active_cells());
- QTrapez<1> q_trapez;
+ QTrapezoid<1> q_trapez;
QIterated<dim> quadrature(q_trapez,degree+2);
QGauss<dim> quadrature_super(degree);
auto& inverse_diagonal = this->inverse_diagonal_entries->get_vector();
if(NS_stage == 1) {
- MatrixFreeTools::compute_diagonal<dim, Number, VectorizedArray<Number>>
+ ::MatrixFreeTools::compute_diagonal<dim, Number, VectorizedArray<Number>>
(*(this->data),
inverse_diagonal,
[&](const auto& data, auto& dst, const auto& src, const auto& cell_range) {
0);
}
else if(NS_stage == 2) {
- MatrixFreeTools::compute_diagonal<dim, Number, VectorizedArray<Number>>
+ ::MatrixFreeTools::compute_diagonal<dim, Number, VectorizedArray<Number>>
(*(this->data),
inverse_diagonal,
[&](const auto& data, auto& dst, const auto& src, const auto& cell_range) {
{\r
VectorTools::interpolate_boundary_values(this->dof_handler_ref,\r
2,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
(this->fe.component_mask(this->pressure)));\r
}\r
\r
VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
0,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
(this->fe.component_mask(this->x_displacement)|\r
this->fe.component_mask(this->y_displacement) ) );\r
\r
VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
1,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
(this->fe.component_mask(this->x_displacement) |\r
this->fe.component_mask(this->y_displacement) |\r
{\r
VectorTools::interpolate_boundary_values(this->dof_handler_ref,\r
101,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
(this->fe.component_mask(this->pressure)));\r
}\r
\r
VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
0,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
this->fe.component_mask(this->x_displacement));\r
\r
VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
1,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
this->fe.component_mask(this->x_displacement));\r
\r
VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
2,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
this->fe.component_mask(this->y_displacement));\r
\r
VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
3,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
this->fe.component_mask(this->y_displacement));\r
\r
VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
4,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
( this->fe.component_mask(this->x_displacement) |\r
this->fe.component_mask(this->y_displacement) |\r
{\r
VectorTools::interpolate_boundary_values(this->dof_handler_ref,\r
1,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
(this->fe.component_mask(this->pressure)));\r
\r
VectorTools::interpolate_boundary_values(this->dof_handler_ref,\r
2,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
(this->fe.component_mask(this->pressure)));\r
}\r
\r
VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
0,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
(this->fe.component_mask(this->x_displacement)|\r
this->fe.component_mask(this->y_displacement) ) );\r
\r
VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
1,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
(this->fe.component_mask(this->x_displacement) |\r
this->fe.component_mask(this->y_displacement) |\r
\r
VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
2,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
(this->fe.component_mask(this->x_displacement) |\r
this->fe.component_mask(this->y_displacement) ));\r
{\r
VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
100,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
(this->fe.component_mask(this->pressure)));\r
}\r
VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
4,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
this->fe.component_mask(this->z_displacement) );\r
\r
{\r
VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
100,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
(this->fe.component_mask(this->pressure)));\r
}\r
\r
VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
4,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
(this->fe.component_mask(this->x_displacement) |\r
this->fe.component_mask(this->y_displacement) |\r
\r
VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
5,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
(this->fe.component_mask(this->x_displacement) |\r
this->fe.component_mask(this->y_displacement) ));\r
{\r
VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
100,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
(this->fe.component_mask(this->pressure)));\r
}\r
\r
VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
5,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
(this->fe.component_mask(this->x_displacement) |\r
this->fe.component_mask(this->y_displacement) |\r
\r
VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
4,\r
- ZeroFunction<dim>(this->n_components),\r
+ Functions::ZeroFunction<dim>(this->n_components),\r
constraints,\r
(this->fe.component_mask(this->y_displacement) |\r
this->fe.component_mask(this->z_displacement) ));\r
const int boundary_id = 1;
VectorTools::interpolate_boundary_values(dof_handler_ref,
boundary_id,
- ZeroFunction<dim>(n_components),
+ Functions::ZeroFunction<dim>(n_components),
constraints,
fe.component_mask(u_fe));
}
const FEValuesExtractors::Scalar z_displacement(2);
VectorTools::interpolate_boundary_values(dof_handler_ref,
boundary_id,
- ZeroFunction<dim>(n_components),
+ Functions::ZeroFunction<dim>(n_components),
constraints,
fe.component_mask(z_displacement));
}
DoFRenumbering::component_wise(dof_handler, block_component);
// Count DoFs in each block
- dofs_per_block.clear();
- dofs_per_block.resize(n_blocks);
- DoFTools::count_dofs_per_block(dof_handler, dofs_per_block,
- block_component);
+ dofs_per_block = DoFTools::count_dofs_per_fe_block(dof_handler, block_component);
all_locally_owned_dofs = DoFTools::locally_owned_dofs_per_subdomain (dof_handler);
std::vector<IndexSet> all_locally_relevant_dofs
if (apply_dirichlet_bc == true)
VectorTools::interpolate_boundary_values(dof_handler,
boundary_id,
- ZeroFunction<dim>(n_components),
+ Functions::ZeroFunction<dim>(n_components),
constraints,
fe.component_mask(x_displacement));
else
VectorTools::interpolate_boundary_values(dof_handler,
boundary_id,
- ZeroFunction<dim>(n_components),
+ Functions::ZeroFunction<dim>(n_components),
constraints,
fe.component_mask(x_displacement));
}
if (apply_dirichlet_bc == true)
VectorTools::interpolate_boundary_values(dof_handler,
boundary_id,
- ZeroFunction<dim>(n_components),
+ Functions::ZeroFunction<dim>(n_components),
constraints,
fe.component_mask(y_displacement));
else
VectorTools::interpolate_boundary_values(dof_handler,
boundary_id,
- ZeroFunction<dim>(n_components),
+ Functions::ZeroFunction<dim>(n_components),
constraints,
fe.component_mask(y_displacement));
}
if (apply_dirichlet_bc == true)
VectorTools::interpolate_boundary_values(dof_handler,
boundary_id,
- ZeroFunction<dim>(n_components),
+ Functions::ZeroFunction<dim>(n_components),
constraints,
fe.component_mask(z_displacement));
else
VectorTools::interpolate_boundary_values(dof_handler,
boundary_id,
- ZeroFunction<dim>(n_components),
+ Functions::ZeroFunction<dim>(n_components),
constraints,
fe.component_mask(z_displacement));
}
if (apply_dirichlet_bc == true)
VectorTools::interpolate_boundary_values(dof_handler,
boundary_id,
- ZeroFunction<dim>(n_components),
+ Functions::ZeroFunction<dim>(n_components),
constraints,
fe.component_mask(z_displacement));
else
VectorTools::interpolate_boundary_values(dof_handler,
boundary_id,
- ZeroFunction<dim>(n_components),
+ Functions::ZeroFunction<dim>(n_components),
constraints,
fe.component_mask(z_displacement));
}
const double delta_u_y = delta_length/2.0/n_stretch_steps;
VectorTools::interpolate_boundary_values(dof_handler,
boundary_id,
- ConstantFunction<dim>(delta_u_y,n_components),
+ Functions::ConstantFunction<dim>(delta_u_y,n_components),
constraints,
fe.component_mask(y_displacement));
}
else
VectorTools::interpolate_boundary_values(dof_handler,
boundary_id,
- ZeroFunction<dim>(n_components),
+ Functions::ZeroFunction<dim>(n_components),
constraints,
fe.component_mask(y_displacement));
}
else
VectorTools::interpolate_boundary_values(dof_handler,
boundary_id,
- ZeroFunction<dim>(n_components),
+ Functions::ZeroFunction<dim>(n_components),
constraints,
fe.component_mask(y_displacement));
}
}
}
- template<int dim, class DH=DoFHandler<dim> >
- class FilteredDataOut : public DataOut<dim, DH>
+ template<int dim>
+ class FilteredDataOut : public DataOut<dim>
{
public:
FilteredDataOut (const unsigned int subdomain_id)
virtual ~FilteredDataOut() {}
- virtual typename DataOut<dim, DH>::cell_iterator
+ virtual typename DataOut<dim>::cell_iterator
first_cell ()
{
auto cell = this->dofs->begin_active();
return cell;
}
- virtual typename DataOut<dim, DH>::cell_iterator
- next_cell (const typename DataOut<dim, DH>::cell_iterator &old_cell)
+ virtual typename DataOut<dim>::cell_iterator
+ next_cell (const typename DataOut<dim>::cell_iterator &old_cell)
{
if (old_cell != this->dofs->end())
{
const IteratorFilters::SubdomainEqualTo predicate(subdomain_id);
return
++(FilteredIterator
- <typename DataOut<dim, DH>::cell_iterator>
+ <typename DataOut<dim>::cell_iterator>
(predicate,old_cell));
}
else
{
for (unsigned int j = 0; j < n_dofs; ++j)
{
- copy_data_face.cell_matrix(i, j) += (beta(q_points[qpoint]) * normals[qpoint] * fe_iv.average(j, qpoint) * fe_iv.jump(i, qpoint) +
- theta * std::abs(beta_dot_n) * fe_iv.jump(j, qpoint) * fe_iv.jump(i, qpoint)) *
+ copy_data_face.cell_matrix(i, j) += (beta(q_points[qpoint]) * normals[qpoint] * fe_iv.average_of_shape_values(j, qpoint) * fe_iv.jump_in_shape_values(i, qpoint) +
+ theta * std::abs(beta_dot_n) * fe_iv.jump_in_shape_values(j, qpoint) * fe_iv.jump_in_shape_values(i, qpoint)) *
JxW[qpoint];
}
}
DoFTools::make_sparsity_pattern(dof_handler, dynamic_sparsity_pattern,
constraints, /*keep_constrained_dofs*/true);
SparsityTools::distribute_sparsity_pattern
- (dynamic_sparsity_pattern, dof_handler.n_locally_owned_dofs_per_processor(),
+ (dynamic_sparsity_pattern, dof_handler.locally_owned_dofs(),
mpi_communicator, locally_relevant_dofs);
system_rhs.reinit(locally_owned_dofs, mpi_communicator);
// For the purposes of this program, we choose a simple form of boundary
// displacement: we displace the top boundary with constant velocity
// downwards. The rest of the boundary is either going to be fixed (and is
- // then described using an object of type <code>ZeroFunction</code>) or free
+ // then described using an object of type <code>Functions::ZeroFunction</code>) or free
// (Neumann-type, in which case nothing special has to be done). The
// implementation of the class describing the constant downward motion
// should then be obvious using the knowledge we gained through all the
template <int dim>
- class BodyForce : public ZeroFunction<dim>
+ class BodyForce : public Functions::ZeroFunction<dim>
{
public:
- BodyForce () : ZeroFunction<dim> (dim) {}
+ BodyForce () : Functions::ZeroFunction<dim> (dim) {}
};
template <int dim>
template <int dim>
- class BodyForce : public ZeroFunction<dim>
+ class BodyForce : public Functions::ZeroFunction<dim>
{
public:
- BodyForce () : ZeroFunction<dim> (dim) {}
+ BodyForce () : Functions::ZeroFunction<dim> (dim) {}
};
template <int dim>
- class BodyForce : public ZeroFunction<dim>
+ class BodyForce : public Functions::ZeroFunction<dim>
{
public:
- BodyForce () : ZeroFunction<dim> (dim) {}
+ BodyForce () : Functions::ZeroFunction<dim> (dim) {}
};
template <int dim>
- class BodyForce : public ZeroFunction<dim>
+ class BodyForce : public Functions::ZeroFunction<dim>
{
public:
- BodyForce () : ZeroFunction<dim> (dim) {}
+ BodyForce () : Functions::ZeroFunction<dim> (dim) {}
};
// init condition for u=0
completely_distributed_solution_u = 0;
VectorTools::interpolate(dof_handler_U,
- ZeroFunction<dim>(),
+ Functions::ZeroFunction<dim>(),
completely_distributed_solution_u);
constraints.distribute (completely_distributed_solution_u);
locally_relevant_solution_u = completely_distributed_solution_u;
// init condition for v
completely_distributed_solution_v = 0;
VectorTools::interpolate(dof_handler_U,
- ZeroFunction<dim>(),
+ Functions::ZeroFunction<dim>(),
completely_distributed_solution_v);
constraints.distribute (completely_distributed_solution_v);
locally_relevant_solution_v = completely_distributed_solution_v;
// init condition for p
completely_distributed_solution_p = 0;
VectorTools::interpolate(dof_handler_P,
- ZeroFunction<dim>(),
+ Functions::ZeroFunction<dim>(),
completely_distributed_solution_p);
constraints.distribute (completely_distributed_solution_p);
locally_relevant_solution_p = completely_distributed_solution_p;
if (PROBLEM==BREAKING_DAM || PROBLEM==FALLING_DROP)
{
//LEFT
- VectorTools::interpolate_boundary_values (dof_handler_U,0,ZeroFunction<dim>(),map_boundary_values_u);
- VectorTools::interpolate_boundary_values (dof_handler_U,0,ZeroFunction<dim>(),map_boundary_values_v);
+ VectorTools::interpolate_boundary_values (dof_handler_U,0,Functions::ZeroFunction<dim>(),map_boundary_values_u);
+ VectorTools::interpolate_boundary_values (dof_handler_U,0,Functions::ZeroFunction<dim>(),map_boundary_values_v);
// RIGHT
- VectorTools::interpolate_boundary_values (dof_handler_U,1,ZeroFunction<dim>(),map_boundary_values_u);
- VectorTools::interpolate_boundary_values (dof_handler_U,1,ZeroFunction<dim>(),map_boundary_values_v);
+ VectorTools::interpolate_boundary_values (dof_handler_U,1,Functions::ZeroFunction<dim>(),map_boundary_values_u);
+ VectorTools::interpolate_boundary_values (dof_handler_U,1,Functions::ZeroFunction<dim>(),map_boundary_values_v);
// BOTTOM
- VectorTools::interpolate_boundary_values (dof_handler_U,2,ZeroFunction<dim>(),map_boundary_values_u);
- VectorTools::interpolate_boundary_values (dof_handler_U,2,ZeroFunction<dim>(),map_boundary_values_v);
+ VectorTools::interpolate_boundary_values (dof_handler_U,2,Functions::ZeroFunction<dim>(),map_boundary_values_u);
+ VectorTools::interpolate_boundary_values (dof_handler_U,2,Functions::ZeroFunction<dim>(),map_boundary_values_v);
// TOP
- VectorTools::interpolate_boundary_values (dof_handler_U,3,ZeroFunction<dim>(),map_boundary_values_u);
- VectorTools::interpolate_boundary_values (dof_handler_U,3,ZeroFunction<dim>(),map_boundary_values_v);
+ VectorTools::interpolate_boundary_values (dof_handler_U,3,Functions::ZeroFunction<dim>(),map_boundary_values_u);
+ VectorTools::interpolate_boundary_values (dof_handler_U,3,Functions::ZeroFunction<dim>(),map_boundary_values_v);
}
else if (PROBLEM==SMALL_WAVE_PERTURBATION)
{
// no slip in bottom and top and slip in left and right
//LEFT
- VectorTools::interpolate_boundary_values (dof_handler_U,0,ZeroFunction<dim>(),map_boundary_values_u);
+ VectorTools::interpolate_boundary_values (dof_handler_U,0,Functions::ZeroFunction<dim>(),map_boundary_values_u);
// RIGHT
- VectorTools::interpolate_boundary_values (dof_handler_U,1,ZeroFunction<dim>(),map_boundary_values_u);
+ VectorTools::interpolate_boundary_values (dof_handler_U,1,Functions::ZeroFunction<dim>(),map_boundary_values_u);
// BOTTOM
- VectorTools::interpolate_boundary_values (dof_handler_U,2,ZeroFunction<dim>(),map_boundary_values_u);
- VectorTools::interpolate_boundary_values (dof_handler_U,2,ZeroFunction<dim>(),map_boundary_values_v);
+ VectorTools::interpolate_boundary_values (dof_handler_U,2,Functions::ZeroFunction<dim>(),map_boundary_values_u);
+ VectorTools::interpolate_boundary_values (dof_handler_U,2,Functions::ZeroFunction<dim>(),map_boundary_values_v);
// TOP
- VectorTools::interpolate_boundary_values (dof_handler_U,3,ZeroFunction<dim>(),map_boundary_values_u);
- VectorTools::interpolate_boundary_values (dof_handler_U,3,ZeroFunction<dim>(),map_boundary_values_v);
+ VectorTools::interpolate_boundary_values (dof_handler_U,3,Functions::ZeroFunction<dim>(),map_boundary_values_u);
+ VectorTools::interpolate_boundary_values (dof_handler_U,3,Functions::ZeroFunction<dim>(),map_boundary_values_v);
}
else if (PROBLEM==FILLING_TANK)
{
//LEFT: entry in x, zero in y
VectorTools::interpolate_boundary_values (dof_handler_U,0,BoundaryU<dim>(PROBLEM),map_boundary_values_u);
- VectorTools::interpolate_boundary_values (dof_handler_U,0,ZeroFunction<dim>(),map_boundary_values_v);
+ VectorTools::interpolate_boundary_values (dof_handler_U,0,Functions::ZeroFunction<dim>(),map_boundary_values_v);
//RIGHT: no-slip condition
- VectorTools::interpolate_boundary_values (dof_handler_U,1,ZeroFunction<dim>(),map_boundary_values_u);
- VectorTools::interpolate_boundary_values (dof_handler_U,1,ZeroFunction<dim>(),map_boundary_values_v);
+ VectorTools::interpolate_boundary_values (dof_handler_U,1,Functions::ZeroFunction<dim>(),map_boundary_values_u);
+ VectorTools::interpolate_boundary_values (dof_handler_U,1,Functions::ZeroFunction<dim>(),map_boundary_values_v);
//BOTTOM: non-slip
- VectorTools::interpolate_boundary_values (dof_handler_U,2,ZeroFunction<dim>(),map_boundary_values_u);
- VectorTools::interpolate_boundary_values (dof_handler_U,2,ZeroFunction<dim>(),map_boundary_values_v);
+ VectorTools::interpolate_boundary_values (dof_handler_U,2,Functions::ZeroFunction<dim>(),map_boundary_values_u);
+ VectorTools::interpolate_boundary_values (dof_handler_U,2,Functions::ZeroFunction<dim>(),map_boundary_values_v);
//TOP: exit in y, zero in x
- VectorTools::interpolate_boundary_values (dof_handler_U,3,ZeroFunction<dim>(),map_boundary_values_u);
+ VectorTools::interpolate_boundary_values (dof_handler_U,3,Functions::ZeroFunction<dim>(),map_boundary_values_u);
VectorTools::interpolate_boundary_values (dof_handler_U,3,BoundaryV<dim>(PROBLEM),map_boundary_values_v);
}
else
completely_distributed_solution_phi = 0;
VectorTools::interpolate(dof_handler_LS,
InitialPhi<dim>(PROBLEM, sharpness),
- //ZeroFunction<dim>(),
+ //Functions::ZeroFunction<dim>(),
completely_distributed_solution_phi);
constraints.distribute (completely_distributed_solution_phi);
locally_relevant_solution_phi = completely_distributed_solution_phi;
//////////////////// FORCE TERMS ///// ////////////////
///////////////////////////////////////////////////////
template <int dim>
-class ForceTerms : public ConstantFunction <dim>
+class ForceTerms : public Functions::ConstantFunction <dim>
{
public:
- ForceTerms (const std::vector<double> values) : ConstantFunction<dim>(values) {}
+ ForceTerms (const std::vector<double> values) : Functions::ConstantFunction<dim>(values) {}
};
/////////////////////////////////////////////////////
//////////////////// BOUNDARY PHI ///////////////////
/////////////////////////////////////////////////////
template <int dim>
-class BoundaryPhi : public ConstantFunction <dim>
+class BoundaryPhi : public Functions::ConstantFunction <dim>
{
public:
- BoundaryPhi (const double value, const unsigned int n_components=1) : ConstantFunction<dim>(value,n_components) {}
+ BoundaryPhi (const double value, const unsigned int n_components=1) : Functions::ConstantFunction<dim>(value,n_components) {}
};
//////////////////////////////////////////////////////////