16#ifndef dealii_petsc_vector_h
17# define dealii_petsc_vector_h
22# ifdef DEAL_II_WITH_PETSC
199 template <
typename Number>
201 const ::Vector<Number> &v,
299 template <
typename number>
323 const bool omit_zeroing_entries =
false);
335 reinit(
const Vector &v,
const bool omit_zeroing_entries =
false);
378 print(std::ostream & out,
379 const unsigned int precision = 3,
380 const bool scientific =
true,
381 const bool across =
true)
const;
442 template <
typename number>
444 const ::Vector<number> &v,
446 : communicator(communicator)
465 template <
typename number>
519 namespace LinearOperatorImplementation
532 template <
typename Matrix>
539 matrix.get_mpi_communicator());
542 template <
typename Matrix>
549 matrix.get_mpi_communicator());
types::global_dof_index size_type
Vector(const MPI_Comm &communicator, const ::Vector< Number > &v, const size_type locally_owned_size)
virtual void create_vector(const size_type n, const size_type locally_owned_size)
void print(std::ostream &out, const unsigned int precision=3, const bool scientific=true, const bool across=true) const
const MPI_Comm & get_mpi_communicator() const override
virtual void clear() override
void reinit(const MPI_Comm &communicator, const size_type N, const size_type locally_owned_size, const bool omit_zeroing_entries=false)
Vector & operator=(const ::Vector< number > &v)
Vector & operator=(const Vector &v)
Vector & operator=(const PetscScalar s)
void swap(Vector &u, Vector &v)
size_type local_size() const
void compress(const VectorOperation::values operation)
size_type locally_owned_size() const
VectorBase & operator=(const VectorBase &)=delete
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_DEPRECATED
#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)
@ matrix
Contents is actually a matrix.
unsigned int global_dof_index