LinearAlgebraTrilinos::MPI::Vector present_solution;
const size_t dof_numbers = dof_handler.n_dofs();
IndexSet solution_partitioning(dof_numbers), solution_relevant_partitioning(dof_numbers);
solution_partitioning = dof_handler.locally_owned_dofs();
DoFTools::extract_locally_relevant_dofs(dof_handler, solution_relevant_partitioning);
present_solution.reinit(solution_relevant_partitioning, MPI_COMM_WORLD);
ConstraintMatrix boundary_constraints
;
boundary_constraints.clear();
boundary_constraints.reinit(solution_relevant_partitioning);
DoFTools::make_hanging_node_constraints(dof_handler, boundary_constraints);
VectorTools::interpolate_boundary_values(dof_handler, 0, BoundaryValues<dim>(), boundary_constraints);
boundary_constraints.close();
boundary_constraints.distribute(present_solution);
An error occurred in line <1367> of file </home/roland/Downloads/dealii/include/deal.II/lac/trilinos_vector.h> in function
dealii::IndexSet dealii::TrilinosWrappers::MPI::Vector::locally_owned_elements() const
The violated condition was:
owned_elements.size()==size()
Additional information:
The locally owned elements have not been properly initialized! This happens for example if this object has been initialized with exactly one overlapping IndexSet.
An error occurred in line <754> of file <~/Downloads/dealii/include/deal.II/lac/constraint_matrix.templates.h> in function
void dealii::internal::{anonymous}::import_vector_with_ghost_elements(const dealii::TrilinosWrappers::MPI::Vector&, const dealii::IndexSet&, const dealii::IndexSet&, dealii::TrilinosWrappers::MPI::Vector&, dealii::internal::bool2type<false>)
The violated condition was:
!vec.has_ghost_elements()
Additional information:
You are trying an operation on a vector that is only allowed if the vector has no ghost elements, but the vector you are operating on does have ghost elements. Specifically, vectors with ghost elements are read-only and cannot appear in operations that write into the
se vectors.
See the glossary entry on 'Ghosted vectors' for more information.
Stacktrace:
-----------
#0 /opt/dealII/lib/libdeal_II.g.so.9.0.0-pre:
#1 /opt/dealII/lib/libdeal_II.g.so.9.0.0-pre: void dealii::ConstraintMatrix::distribute<dealii::TrilinosWrappers::MPI::Vector>(dealii::TrilinosWrappers::MPI::Vector&) const
#2 main: Step15::MinimalSurfaceProblem<2>::run()
#3 main: main
--------------------------------------------------------
Calling MPI_Abort now.
To break execution in a GDB session, execute 'break MPI_Abort' before running. You can also put the following into your ~/.gdbinit:
set breakpoint pending on
break MPI_Abort
set breakpoint pending auto
--------------------------------------------------------------------------
MPI_ABORT was invoked on rank 1 in communicator MPI_COMM_WORLD
with errorcode 255.
NOTE: invoking MPI_ABORT causes Open MPI to kill all MPI processes.
You may or may not see output from other processes, depending on
exactly when Open MPI kills them.
--------------------------------------------------------------------------
Calling MPI_Abort now.
To break execution in a GDB session, execute 'break MPI_Abort' before running. You can also put the following into your ~/.gdbinit:
set breakpoint pending on
break MPI_Abort
set breakpoint pending auto
[linux-lb8c:17949] 1 more process has sent help message help-mpi-api.txt / mpi-abort
[linux-lb8c:17949] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages