const VectorBase &v,
const size_type local_size);
-
- /**
- * Constructs a new parallel ghosted PETSc vector from an Indexset. Note
- * that @p local must be contiguous and the global size of the vector is
- * determined by local.size(). The global indices in @p ghost are
- * supplied as ghost indices that can also be read locally.
- *
- * Note that the @p ghost IndexSet may be empty and that any indices
- * already contained in @p local are ignored during construction. That
- * way, the ghost parameter can equal the set of locally relevant
- * degrees of freedom, see step-32.
- *
- * @deprecated Use Vector::Vector(const IndexSet &,const IndexSet
- * &,const MPI_Comm &) instead.
- *
- * @note This operation always creates a ghosted vector.
- *
- * @see
- * @ref GlossGhostedVector "vectors with ghost elements"
- */
- explicit Vector (const MPI_Comm &communicator,
- const IndexSet &local,
- const IndexSet &ghost) DEAL_II_DEPRECATED;
-
/**
* Constructs a new parallel ghosted PETSc vector from an Indexset. Note
* that @p local must be contiguous and the global size of the vector is
const IndexSet &ghost,
const MPI_Comm &communicator);
- /**
- * Constructs a new parallel PETSc vector from an IndexSet. This creates
- * a non ghosted vector.
- *
- * @deprecated Use Vector::Vector(const IndexSet &,const MPI_Comm &)
- * instead.
- */
- explicit Vector (const MPI_Comm &communicator,
- const IndexSet &local) DEAL_II_DEPRECATED;
-
/**
* Constructs a new parallel PETSc vector from an IndexSet. This creates
* a non ghosted vector.
void reinit (const Vector &v,
const bool fast = false);
- /**
- * Reinit as a ghosted vector. See constructor with same signature for
- * more details.
- *
- * @deprecated Use Vector::reinit(const IndexSet &, const IndexSet &,
- * const MPI_Comm &) instead.
- *
- * @see
- * @ref GlossGhostedVector "vectors with ghost elements"
- */
- void reinit (const MPI_Comm &communicator,
- const IndexSet &local,
- const IndexSet &ghost) DEAL_II_DEPRECATED;
/**
* Reinit as a vector without ghost elements. See the constructor with
* same signature for more details.
const IndexSet &ghost,
const MPI_Comm &communicator);
- /**
- * Reinit as a vector without ghost elements. See constructor with same
- * signature for more details.
- *
- * @deprecated Use Vector::reinit(const IndexSet &, const MPI_Comm &)
- * instead.
- */
- void reinit (const MPI_Comm &communicator,
- const IndexSet &local) DEAL_II_DEPRECATED;
-
/**
* Reinit as a vector without ghost elements. See constructor with same
* signature for more details.
- Vector::Vector (const MPI_Comm &communicator,
- const IndexSet &local,
- const IndexSet &ghost)
- :
- communicator (communicator)
- {
- Assert(local.is_contiguous(), ExcNotImplemented());
-
- IndexSet ghost_set = ghost;
- ghost_set.subtract_set(local);
-
- Vector::create_vector(local.size(), local.n_elements(), ghost_set);
- }
-
Vector::Vector (const IndexSet &local,
const IndexSet &ghost,
const MPI_Comm &communicator)
}
- Vector::Vector (const MPI_Comm &communicator,
- const IndexSet &local)
- :
- communicator (communicator)
- {
- Assert(local.is_contiguous(), ExcNotImplemented());
- Vector::create_vector(local.size(), local.n_elements());
- }
-
void
Vector::reinit (const MPI_Comm &comm,
const size_type n,
- void
- Vector::reinit (const MPI_Comm &comm,
- const IndexSet &local,
- const IndexSet &ghost)
- {
- reinit(local, ghost, comm);
- }
-
void
Vector::reinit (const IndexSet &local,
const IndexSet &ghost,
create_vector(local.size(), local.n_elements(), ghost_set);
}
- void
- Vector::reinit (const MPI_Comm &comm,
- const IndexSet &local)
- {
- reinit(local, comm);
- }
-
void
Vector::reinit (const IndexSet &local,
const MPI_Comm &comm)