18#ifdef DEAL_II_WITH_SUNDIALS
35 const N_Vector_ID
id = N_VGetVectorID(vec);
39 case SUNDIALS_NVEC_SERIAL:
41 length = NV_LENGTH_S(vec);
44# ifdef DEAL_II_WITH_MPI
45 case SUNDIALS_NVEC_PARALLEL:
47 length = NV_LOCLENGTH_P(vec);
56 return static_cast<std::size_t
>(length);
67 for (std::size_t i = 0; i < N; ++i)
69# ifdef DEAL_II_WITH_MPI
84 for (std::size_t i = 0; i < N; ++i)
86# ifdef DEAL_II_WITH_MPI
102 for (std::size_t i = 0; i < N; ++i)
104# ifdef DEAL_II_WITH_MPI
120 for (std::size_t i = 0; i < N; ++i)
122# ifdef DEAL_II_WITH_MPI
130# ifdef DEAL_II_WITH_MPI
132# ifdef DEAL_II_WITH_TRILINOS
141 for (std::size_t i = 0; i < N; ++i)
154 for (std::size_t i = 0; i < N; ++i)
166 for (std::size_t i = 0; i < N; ++i)
179 for (std::size_t i = 0; i < N; ++i)
187# ifdef DEAL_II_WITH_PETSC
188# ifndef PETSC_USE_COMPLEX
196 for (std::size_t i = 0; i < N; ++i)
209 for (std::size_t i = 0; i < N; ++i)
221 for (std::size_t i = 0; i < N; ++i)
234 for (std::size_t i = 0; i < N; ++i)
248 const std::size_t N = dst.
size();
250 for (std::size_t i = 0; i < N; ++i)
252 dst[i] = NV_Ith_S(src, i);
259 const std::size_t N = src.
size();
261 for (std::size_t i = 0; i < N; ++i)
263 NV_Ith_S(dst, i) = src[i];
270 const std::size_t N = dst.
size();
272 for (std::size_t i = 0; i < N; ++i)
274 dst[i] = NV_Ith_S(src, i);
281 const std::size_t N = src.
size();
283 for (std::size_t i = 0; i < N; ++i)
285 NV_Ith_S(dst, i) = src[i];
size_type n_elements() const
size_type nth_index_in_set(const size_type local_index) const
IndexSet locally_owned_elements() const
void compress(const VectorOperation::values operation)
#define DEAL_II_NAMESPACE_OPEN
#define DEAL_II_NAMESPACE_CLOSE
static ::ExceptionBase & ExcNotImplemented()
#define Assert(cond, exc)
#define AssertDimension(dim1, dim2)
static ::ExceptionBase & ExcInternalError()
void compress(::VectorOperation::values operation)
IndexSet locally_owned_elements() const
IndexSet locally_owned_elements() const
void compress(::VectorOperation::values operation)
void zero_out_ghost_values() const
Number local_element(const size_type local_index) const
virtual ::IndexSet locally_owned_elements() const override
virtual void compress(::VectorOperation::values operation) override
virtual void compress(::VectorOperation::values operation) override
void zero_out_ghost_values() const
virtual ::IndexSet locally_owned_elements() const override
std::size_t N_Vector_length(const N_Vector &vec)
void copy(TrilinosWrappers::MPI::Vector &dst, const N_Vector &src)