if (dof_handler.get_fe().get_unit_support_points().size() == 0)
return;
- std::vector<Point<dof_handler.dimension>> map(dof_handler.n_dofs());
- MappingQ<dof_handler.dimension> mapping(2);
+ std::vector<Point<DoFHandlerType::dimension>> map(dof_handler.n_dofs());
+ MappingQ<DoFHandlerType::dimension> mapping(2);
DoFTools::map_dofs_to_support_points(mapping, dof_handler, map);
deallog << dof_handler.n_boundary_dofs() << std::endl;
// with std::map
- std::map<types::boundary_id, const Function<dof_handler.dimension> *> fm;
+ std::map<types::boundary_id, const Function<DoFHandlerType::dimension> *> fm;
fm[0] = nullptr;
deallog << dof_handler.n_boundary_dofs(fm) << std::endl;
DoFTools::map_dof_to_boundary_indices(dof_handler, set, map);
// create sparsity pattern
- std::map<types::boundary_id, const Function<dof_handler.dimension> *>
+ std::map<types::boundary_id, const Function<DoFHandlerType::dimension> *>
boundary_ids;
boundary_ids[0] = nullptr;
SparsityPattern sp(dof_handler.n_boundary_dofs(boundary_ids),
DoFTools::map_dof_to_boundary_indices(dof_handler, set, map);
// create sparsity pattern
- std::map<types::boundary_id, const Function<dof_handler.dimension> *>
+ std::map<types::boundary_id, const Function<DoFHandlerType::dimension> *>
boundary_ids;
boundary_ids[0] = nullptr;
DynamicSparsityPattern sp(dof_handler.n_boundary_dofs(boundary_ids));
set.insert(0);
DoFTools::map_dof_to_boundary_indices(dof_handler, set, map);
- std::map<types::boundary_id, const Function<dof_handler.dimension> *>
+ std::map<types::boundary_id, const Function<DoFHandlerType::dimension> *>
boundary_ids;
boundary_ids[0] = nullptr;
const unsigned int n_boundary_dofs =
set.insert(0);
DoFTools::map_dof_to_boundary_indices(dof_handler, set, map);
- std::map<types::boundary_id, const Function<dof_handler.dimension> *>
+ std::map<types::boundary_id, const Function<DoFHandlerType::dimension> *>
boundary_ids;
boundary_ids[0] = nullptr;
const types::global_dof_index n_boundary_dofs =
std::string::npos)
return;
- Functions::ConstantFunction<dof_handler.dimension> test_func(
+ Functions::ConstantFunction<DoFHandlerType::dimension> test_func(
1, dof_handler.get_fe().n_components());
// don't run this test if hanging
deallog << cm.max_constraint_indirections() << std::endl;
// L_2 project constant function onto field
- QGauss<dof_handler.dimension> quadrature(6);
- Vector<double> solution(dof_handler.n_dofs());
+ QGauss<DoFHandlerType::dimension> quadrature(6);
+ Vector<double> solution(dof_handler.n_dofs());
VectorTools::project(dof_handler, cm, quadrature, test_func, solution);
cm.distribute(solution);
void
check_this(const DoFHandlerType &dof_handler)
{
- Functions::CosineFunction<dof_handler.dimension> test_func(
+ Functions::CosineFunction<DoFHandlerType::dimension> test_func(
dof_handler.get_fe().n_components());
AffineConstraints<double> cm;
deallog << cm.n_constraints() << std::endl;
deallog << cm.max_constraint_indirections() << std::endl;
- QGauss<dof_handler.dimension> quadrature(6);
+ QGauss<DoFHandlerType::dimension> quadrature(6);
Vector<double> unconstrained(dof_handler.n_dofs());
Vector<double> constrained(dof_handler.n_dofs());
void
check_this(const DoFHandlerType &dof_handler)
{
- const FiniteElement<dof_handler.dimension> &fe = dof_handler.get_fe();
+ const FiniteElement<DoFHandlerType::dimension> &fe = dof_handler.get_fe();
deallog << fe.dofs_per_vertex << ' ' << fe.dofs_per_line << ' '
<< fe.dofs_per_quad << ' ' << fe.dofs_per_hex << std::endl;
deallog << fe.template n_dofs_per_object<0>() << ' '