15#ifndef dealii_petsc_vector_h
16#define dealii_petsc_vector_h
21#ifdef DEAL_II_WITH_PETSC
205 template <
typename Number>
207 const ::Vector<Number> &v,
311 template <
typename number>
337 const bool omit_zeroing_entries =
false);
349 reinit(
const Vector &v,
const bool omit_zeroing_entries =
false);
382 const std::shared_ptr<const Utilities::MPI::Partitioner> &partitioner,
383 const bool make_ghosted =
true);
397 print(std::ostream &out,
398 const unsigned int precision = 3,
399 const bool scientific =
true,
400 const bool across =
true)
const;
457 template <
typename number>
459 const ::Vector<number> &v,
479 template <
typename number>
527 namespace LinearOperatorImplementation
540 template <
typename Matrix>
546 v.
reinit(matrix.locally_owned_range_indices(),
547 matrix.get_mpi_communicator());
550 template <
typename Matrix>
556 v.
reinit(matrix.locally_owned_domain_indices(),
557 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
void swap(Vector &u, Vector &v) noexcept
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 compress(const VectorOperation::values operation)
size_type locally_owned_size() const
VectorBase & operator=(const VectorBase &)
size_type size() const override
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)
types::global_dof_index locally_owned_size
unsigned int global_dof_index