/*std::vector<bool> boundary_dofs (dof_handler.n_dofs(), false);
- std::vector<bool>boundary_mask (dim+1, false);
+ std::vector<bool> boundary_mask (dim+1, false);
boundary_mask[dim]=true;
DoFTools::extract_boundary_dofs (dof_handler,boundary_mask,boundary_dofs);
AffineConstraints<PetscScalar> constraints(locally_relevant_dofs);
constraints.clear();
{
- IndexSet boundary_dofs(dof_handler.n_dofs());
- DoFTools::extract_boundary_dofs(dof_handler,
- std::vector<bool>(1, true),
- boundary_dofs);
+ const IndexSet boundary_dofs =
+ DoFTools::extract_boundary_dofs(dof_handler, std::vector<bool>(1, true));
unsigned int first_nboundary_dof = 0;
while (boundary_dofs.is_element(first_nboundary_dof))
DoFHandler<dim> dofh(tr);
dofh.distribute_dofs(fe);
- IndexSet relevant_set, boundary_dofs;
- DoFTools::extract_boundary_dofs(dofh,
- std::vector<bool>(1, true),
- boundary_dofs);
+ const IndexSet boundary_dofs =
+ DoFTools::extract_boundary_dofs(dofh, std::vector<bool>(1, true));
if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) == 0)
boundary_dofs.write(deallog.get_file_stream());
// the result of extract_boundary_dofs is supposed to be a subset of the
// locally relevant dofs, so test this
+ IndexSet relevant_set;
DoFTools::extract_locally_relevant_dofs(dofh, relevant_set);
boundary_dofs.subtract_set(relevant_set);
AssertThrow(boundary_dofs.n_elements() == 0, ExcInternalError());
DoFHandler<dim> dofh(tr);
dofh.distribute_dofs(fe);
- IndexSet relevant_set, boundary_dofs;
- DoFTools::extract_boundary_dofs(dofh,
- std::vector<bool>(1, true),
- boundary_dofs);
+ IndexSet boundary_dofs =
+ DoFTools::extract_boundary_dofs(dofh, std::vector<bool>(1, true));
if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) == 0)
boundary_dofs.write(deallog.get_file_stream());
// the result of extract_boundary_dofs is supposed to be a subset of the
// locally relevant dofs, so test this
+ IndexSet relevant_set;
DoFTools::extract_locally_relevant_dofs(dofh, relevant_set);
boundary_dofs.subtract_set(relevant_set);
AssertThrow(boundary_dofs.n_elements() == 0, ExcInternalError());