16#ifndef dealii_petsc_vector_h
17#define dealii_petsc_vector_h
22#ifdef DEAL_II_WITH_PETSC
206 template <
typename Number>
208 const ::Vector<Number> &v,
288 template <
typename number>
314 const bool omit_zeroing_entries =
false);
326 reinit(
const Vector &v,
const bool omit_zeroing_entries =
false);
359 const std::shared_ptr<const Utilities::MPI::Partitioner> &partitioner,
360 const bool make_ghosted =
true);
374 print(std::ostream & out,
375 const unsigned int precision = 3,
376 const bool scientific =
true,
377 const bool across =
true)
const;
434 template <
typename number>
436 const ::Vector<number> &v,
456 template <
typename number>
504 namespace LinearOperatorImplementation
517 template <
typename Matrix>
523 v.
reinit(matrix.locally_owned_range_indices(),
524 matrix.get_mpi_communicator());
527 template <
typename Matrix>
533 v.
reinit(matrix.locally_owned_domain_indices(),
534 matrix.get_mpi_communicator());
types::global_dof_index size_type
void print(std::ostream &out, const unsigned int precision=3, const bool scientific=true, const bool across=true) const
virtual void clear() override
Vector & operator=(const ::Vector< number > &v)
Vector & operator=(const Vector &v)
virtual void create_vector(const MPI_Comm comm, const size_type n, const size_type locally_owned_size)
Vector & operator=(const PetscScalar s)
void reinit(const MPI_Comm communicator, const size_type N, const size_type locally_owned_size, const bool omit_zeroing_entries=false)
Vector(const MPI_Comm communicator, const ::Vector< Number > &v, const size_type locally_owned_size)
void swap(Vector &u, Vector &v)
void compress(const VectorOperation::values operation)
size_type locally_owned_size() const
VectorBase & operator=(const VectorBase &)
static void reinit_domain_vector(const Matrix &matrix, PETScWrappers::MPI::Vector &v, bool)
static void reinit_range_vector(const Matrix &matrix, PETScWrappers::MPI::Vector &v, bool)
#define DEAL_II_NAMESPACE_OPEN
#define DEAL_II_NAMESPACE_CLOSE
#define Assert(cond, exc)
static ::ExceptionBase & ExcDimensionMismatch(std::size_t arg1, std::size_t arg2)
unsigned int global_dof_index