* This class implements a wrapper to the Trilinos distributed vector
* class Epetra_FEVector. This class is derived from the
* LinearAlgebra::VectorSpaceVector class. Note however that Epetra only
- * works with Number = double.
+ * works with Number = double. This class requires Trilinos to be compiled
+ * with MPI support.
*
* @ingroup TrilinosWrappers
* @ingroup Vectors
const bool omit_zeroing_entries = false);
/**
- * Change the dimension to that of the vector V. The elements of V are not
+ * Change the dimension to that of the vector @p V. The elements of @p V are not
* copied.
*/
virtual void
/**
* Imports all the elements present in the vector's IndexSet from the
- * input
- * vector @p V. VectorOperation::values @p operation is used to decide if
+ * input vector @p V. VectorOperation::values @p operation is used to decide if
* the elements in @p V should be added to the current vector or replace the
* current elements. The last parameter can be used if the same
* communication pattern is used multiple times. This can be used to
memory_consumption() const override;
/**
- * The vectors have different partitioning, i.e. they have use different
- * IndexSet.
+ * The vectors have different partitioning, i.e. their IndexSet objects
+ * don't represent the same indices.
*/
DeclException0(ExcDifferentParallelPartitioning);
* of the matrix.
*
* This function will be called when the underlying number type for the
- * matrix object and the one one for the vector object are the same.
+ * matrix object and the one for the vector object are the same.
*
* In case of a serial vector, this function will only work when
* running on one processor, since the matrix object is inherently
/**
* Same as the function above for the case that the underlying number type
* for the matrix object and the one for the vector object do not coincide.
- * This case is not implemented. Calling it will result in an runtime error.
+ * This case is not implemented. Calling it will result in a runtime error.
*/
template <typename VectorType>
typename std::enable_if<!std::is_same<typename VectorType::value_type,
* see the discussion about @p VectorType in vmult().
*
* This function will be called when the underlying number type for the
- * matrix object and the one one for the vector object are the same.
+ * matrix object and the one for the vector object are the same.
*/
template <typename VectorType>
typename std::enable_if<std::is_same<typename VectorType::value_type,
/**
* Same as the function above for the case that the underlying number type
* for the matrix object and the one for the vector object do not coincide.
- * This case is not implemented. Calling it will result in an runtime error.
+ * This case is not implemented. Calling it will result in a runtime error.
*/
template <typename VectorType>
typename std::enable_if<!std::is_same<typename VectorType::value_type,
// ---------------------------------------------------------------------
//
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2018 - 2019 by the deal.II authors
//
// This file is part of the deal.II library.
//
// ---------------------------------------------------------------------
//
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2018 - 2019 by the deal.II authors
//
// This file is part of the deal.II library.
//
/**
* This class implements a wrapper to the Trilinos distributed vector
* class Tpetra::Vector. This class is derived from the
- * LinearAlgebra::VectorSpaceVector class.
+ * LinearAlgebra::VectorSpaceVector class and requires Trilinos to be
+ * compiled with MPI support.
*
* @ingroup TrilinosWrappers
* @ingroup Vectors
const bool omit_zeroing_entries = false);
/**
- * Change the dimension to that of the vector V. The elements of V are not
+ * Change the dimension to that of the vector @p V. The elements of @p V are not
* copied.
*/
virtual void
/**
* Imports all the elements present in the vector's IndexSet from the
- * input
- * vector @p V. VectorOperation::values @p operation is used to decide if
+ * input vector @p V. VectorOperation::values @p operation is used to decide if
* the elements in @p V should be added to the current vector or replace the
* current elements. The last parameter can be used if the same
* communication pattern is used multiple times. This can be used to
memory_consumption() const override;
/**
- * The vectors have different partitioning, i.e. they have use different
- * IndexSet.
+ * The vectors have different partitioning, i.e. their IndexSet objects
+ * don't represent the same indices.
*/
DeclException0(ExcDifferentParallelPartitioning);
#endif
+
bool
IndexSet::is_ascending_and_one_to_one(const MPI_Comm &communicator) const
{
// ---------------------------------------------------------------------
//
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2018 - 2019 by the deal.II authors
//
// This file is part of the deal.II library.
//
// ---------------------------------------------------------------------
//
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2018 - 2019 by the deal.II authors
//
// This file is part of the deal.II library.
//
// ---------------------------------------------------------------------
//
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2018 - 2019 by the deal.II authors
//
// This file is part of the deal.II library.
//
// ---------------------------------------------------------------------
//
-// Copyright (C) 2015 - 2017 by the deal.II authors
+// Copyright (C) 2018 - 2019 by the deal.II authors
//
// This file is part of the deal.II library.
//
// ---------------------------------------------------------------------
//
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2019 by the deal.II authors
//
// This file is part of the deal.II library.
//