--- /dev/null
+Changed: deal.II now requires Trilinos version 13.2.
+<br>
+(Timo Heister, 2025/03/21)
colnum_cache->resize(colnums);
}
-# if DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
typename TpetraTypes::MatrixType<Number, MemorySpace>::
nonconst_global_inds_host_view_type col_indices(colnum_cache->data(),
colnums);
typename TpetraTypes::MatrixType<Number, MemorySpace>::
nonconst_values_host_view_type values(value_cache->data(), colnums);
-# else
- Teuchos::ArrayView<dealii::types::signed_global_dof_index> col_indices(
- *colnum_cache);
- Teuchos::ArrayView<Number> values(*value_cache);
-# endif
+
matrix->trilinos_matrix().getGlobalRowCopy(this->a_row,
col_indices,
values,
for (size_type row = first_row; row < last_row; ++row)
n_entries_per_row[row - first_row] = sparsity_pattern.row_length(row);
- // The deal.II notation of a Sparsity pattern corresponds to the
- // Tpetra concept of a Graph. Hence, we generate a graph by copying
- // the sparsity pattern into it, and then build up the matrix from the
- // graph. This is considerable faster than directly filling elements
- // into the matrix. Moreover, it consumes less memory, since the
- // internal reordering is done on ints only, and we can leave the
- // doubles aside.
-# if DEAL_II_TRILINOS_VERSION_GTE(12, 16, 0)
+ // The deal.II notation of a Sparsity pattern corresponds to the
+ // Tpetra concept of a Graph. Hence, we generate a graph by copying
+ // the sparsity pattern into it, and then build up the matrix from the
+ // graph. This is considerable faster than directly filling elements
+ // into the matrix. Moreover, it consumes less memory, since the
+ // internal reordering is done on ints only, and we can leave the
+ // doubles aside.
Teuchos::RCP<TpetraTypes::GraphType<MemorySpace>> graph =
Utilities::Trilinos::internal::make_rcp<
TpetraTypes::GraphType<MemorySpace>>(row_space_map,
n_entries_per_row);
-# else
- Teuchos::RCP<TpetraTypes::GraphType<MemorySpace>> graph =
- Utilities::Trilinos::internal::make_rcp<
- TpetraTypes::GraphType<MemorySpace>>(
- row_space_map, Teuchos::arcpFromArray(n_entries_per_row));
-# endif
// This functions assumes that the sparsity pattern sits on all
// processors (completely). The parallel version uses a Tpetra graph
// into the matrix. Moreover, it consumes less memory, since the
// internal reordering is done on ints only, and we can leave the
// doubles aside.
-# if DEAL_II_TRILINOS_VERSION_GTE(12, 16, 0)
Teuchos::RCP<TpetraTypes::GraphType<MemorySpace>> graph =
Utilities::Trilinos::internal::make_rcp<
TpetraTypes::GraphType<MemorySpace>>(row_space_map,
n_entries_per_row);
-# else
- Teuchos::RCP<TpetraTypes::GraphType<MemorySpace>> graph =
- Utilities::Trilinos::internal::make_rcp<
- TpetraTypes::GraphType<MemorySpace>>(
- row_space_map, Teuchos::arcpFromArray(n_entries_per_row));
-# endif
// This functions assumes that the sparsity pattern sits on all
// processors (completely). The parallel version uses a Tpetra graph
TpetraTypes::MapType<MemorySpace>>(
m, 0, Utilities::Trilinos::tpetra_comm_self()),
column_space_map,
-# if DEAL_II_TRILINOS_VERSION_GTE(13, 0, 0)
- Teuchos::ArrayView<size_t>{entries_per_row_size_type}
-# else
- Teuchos::ArrayRCP<size_t>(entries_per_row_size_type.data(),
- 0,
- entries_per_row_size_type.size(),
- false)
-# endif
- );
+ Teuchos::ArrayView<size_t>{entries_per_row_size_type});
}
{
Teuchos::Array<size_t> n_entries_per_row_array(n_entries_per_row.begin(),
n_entries_per_row.end());
-# if DEAL_II_TRILINOS_VERSION_GTE(12, 16, 0)
matrix = Utilities::Trilinos::internal::make_rcp<
TpetraTypes::MatrixType<Number, MemorySpace>>(column_space_map,
n_entries_per_row_array);
-# else
- matrix = Utilities::Trilinos::internal::make_rcp<
- TpetraTypes::MatrixType<Number, MemorySpace>>(
- column_space_map, Teuchos::arcpFromArray(n_entries_per_row_array));
-# endif
}
{
Teuchos::Array<size_t> n_entries_per_row_array(n_entries_per_row.begin(),
n_entries_per_row.end());
-# if DEAL_II_TRILINOS_VERSION_GTE(12, 16, 0)
+
matrix = Utilities::Trilinos::internal::make_rcp<
TpetraTypes::MatrixType<Number, MemorySpace>>(
row_parallel_partitioning
.template make_tpetra_map_rcp<TpetraTypes::NodeType<MemorySpace>>(
communicator, false),
n_entries_per_row_array);
-# else
- matrix = Utilities::Trilinos::internal::make_rcp<
- TpetraTypes::MatrixType<Number, MemorySpace>>(
- row_parallel_partitioning
- .template make_tpetra_map_rcp<TpetraTypes::NodeType<MemorySpace>>(
- communicator, false),
- Teuchos::arcpFromArray(n_entries_per_row_array));
-# endif
}
size_t nnz = matrix->getNumEntriesInLocalRow(local_row);
col_indices_vector.resize(nnz);
values_vector.resize(nnz);
-# if DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
+
typename TpetraTypes::MatrixType<Number, MemorySpace>::
nonconst_local_inds_host_view_type col_indices(
col_indices_vector.data(), nnz);
typename TpetraTypes::MatrixType<Number, MemorySpace>::
nonconst_values_host_view_type values(values_vector.data(),
nnz);
-# else
- Teuchos::ArrayView<int> col_indices(col_indices_vector);
- Teuchos::ArrayView<Number> values(values_vector);
-# endif
+
matrix->getLocalRowCopy(local_row, col_indices, values, nnz);
const size_t diag_index = std::find(col_indices_vector.begin(),
// not need to perform a deep copy.
// Perform a deep copy
-# if DEAL_II_TRILINOS_VERSION_GTE(12, 18, 1)
matrix = Utilities::Trilinos::internal::make_rcp<
TpetraTypes::MatrixType<Number, MemorySpace>>(*source.matrix,
Teuchos::Copy);
-# else
- matrix = source.matrix->clone(Utilities::Trilinos::internal::make_rcp<
- TpetraTypes::NodeType<MemorySpace>>());
-# endif
+
column_space_map =
Teuchos::rcp_const_cast<TpetraTypes::MapType<MemorySpace>>(
matrix->getColMap());
}
else
{
-# if DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
typename TpetraTypes::MatrixType<Number,
MemorySpace>::values_host_view_type
values;
typename TpetraTypes::MatrixType<Number, MemorySpace>::
local_inds_host_view_type indices;
-# else
- Teuchos::ArrayView<const Number> values;
- Teuchos::ArrayView<const int> indices;
-# endif
# if DEAL_II_TRILINOS_VERSION_GTE(14, 0, 0)
for (size_t i = 0; i < matrix->getLocalNumRows(); ++i)
// Prepare pointers for extraction of a view of the row.
size_t nnz_present = matrix->getNumEntriesInLocalRow(trilinos_i);
-# if DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
+
typename TpetraTypes::MatrixType<Number, MemorySpace>::
nonconst_local_inds_host_view_type col_indices("indices",
nnz_present);
typename TpetraTypes::MatrixType<Number, MemorySpace>::
nonconst_values_host_view_type values("values", nnz_present);
-# else
- std::vector<int> col_indices_vector(nnz_present);
- Teuchos::ArrayView<int> col_indices(col_indices_vector);
- std::vector<Number> values_vector(nnz_present);
- Teuchos::ArrayView<Number> values(values_vector);
-# endif
matrix->getLocalRowCopy(trilinos_i, col_indices, values, nnz_present);
// writing to this vector at all.
Assert(!has_ghost_elements(), ExcGhostsPresent());
-# if DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
auto vector_2d_local = vector->template getLocalView<Kokkos::HostSpace>(
Tpetra::Access::ReadWrite);
-# else
- vector->template sync<Kokkos::HostSpace>();
-
- auto vector_2d_local = vector->template getLocalView<Kokkos::HostSpace>();
-# endif
// Having extracted a view into the multivectors above, now also
// extract a view into the one vector we actually store. We can
{
AssertDimension(indices.size(), elements.size());
-# if DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
auto vector_2d = vector->template getLocalView<Kokkos::HostSpace>(
Tpetra::Access::ReadOnly);
-# else
- /*
- * For Trilinos older than 13.2 we would normally have to call
- * vector.template sync<Kokkos::HostSpace>() at this place in order
- * to sync between memory spaces. This is necessary for GPU support.
- * Unfortunately, we are in a const context here and cannot call to
- * sync() (which is a non-const member function).
- *
- * Let us choose to simply ignore this problem for such an old
- * Trilinos version.
- */
- auto vector_2d = vector->template getLocalView<Kokkos::HostSpace>();
-# endif
auto vector_1d = Kokkos::subview(vector_2d, Kokkos::ALL(), 0);
for (unsigned int i = 0; i < indices.size(); ++i)
if (vector->getMap()->isSameAs(*V.vector->getMap()))
{
// Create a read-only Kokkos view from the source vector
-# if DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
auto source_vector_2d =
V.vector->template getLocalView<Kokkos::HostSpace>(
Tpetra::Access::ReadOnly);
-# else
- auto source_vector_2d =
- V.vector->template getLocalView<Kokkos::HostSpace>();
-# endif
+
auto source_vector_1d =
Kokkos::subview(source_vector_2d, Kokkos::ALL(), 0);
// Create a read/write Kokkos view from the target vector
-# if DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
auto target_vector_2d =
vector->template getLocalView<Kokkos::HostSpace>(
Tpetra::Access::ReadWrite);
-# else
- vector->template sync<Kokkos::HostSpace>();
- auto target_vector_2d =
- vector->template getLocalView<Kokkos::HostSpace>();
-# endif
auto target_vector_1d =
Kokkos::subview(target_vector_2d, Kokkos::ALL(), 0);
-# if !DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
- vector->template modify<Kokkos::HostSpace>();
-# endif
// Copy the data
Kokkos::deep_copy(target_vector_1d, source_vector_1d);
-
-# if !DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
- vector->template sync<typename Tpetra::Vector<
- Number,
- int,
- types::signed_global_dof_index>::device_type::memory_space>();
-# endif
}
else if (size() == V.size())
{
tpetra_export->getSourceMap());
{
-# if DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
auto x_2d = source_vector.template getLocalView<Kokkos::HostSpace>(
Tpetra::Access::ReadWrite);
-# else
- source_vector.template sync<Kokkos::HostSpace>();
- auto x_2d = source_vector.template getLocalView<Kokkos::HostSpace>();
-# endif
auto x_1d = Kokkos::subview(x_2d, Kokkos::ALL(), 0);
-# if !DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
- source_vector.template modify<Kokkos::HostSpace>();
-# endif
+
const size_t localLength = source_vector.getLocalLength();
auto values_it = V.begin();
for (size_t k = 0; k < localLength; ++k)
x_1d(k) = *values_it++;
-# if !DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
- source_vector.template sync<typename MemorySpace::kokkos_space>();
-# endif
}
Tpetra::CombineMode tpetra_operation = Tpetra::ZERO;
if (operation == VectorOperation::insert)
// writing to this vector at all.
Assert(!has_ghost_elements(), ExcGhostsPresent());
-# if DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
auto vector_2d = vector->template getLocalView<Kokkos::HostSpace>(
Tpetra::Access::ReadWrite);
-# else
- vector->template sync<Kokkos::HostSpace>();
- auto vector_2d = vector->template getLocalView<Kokkos::HostSpace>();
-# endif
auto vector_1d = Kokkos::subview(vector_2d, Kokkos::ALL(), 0);
-# if !DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
- vector->template modify<Kokkos::HostSpace>();
-# endif
+
const size_t localLength = vector->getLocalLength();
for (size_t k = 0; k < localLength; ++k)
{
vector_1d(k) += a;
}
-# if !DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
- vector->template sync<typename MemorySpace::kokkos_space>();
-# endif
}
if (this_local_length != other_local_length)
return false;
-# if DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
auto this_vector_2d = vector->template getLocalView<Kokkos::HostSpace>(
Tpetra::Access::ReadOnly);
auto other_vector_2d = v.vector->template getLocalView<Kokkos::HostSpace>(
Tpetra::Access::ReadOnly);
-# else
- vector->template sync<Kokkos::HostSpace>();
- v.vector->template sync<Kokkos::HostSpace>();
- auto this_vector_2d = vector->template getLocalView<Kokkos::HostSpace>();
- auto other_vector_2d =
- v.vector->template getLocalView<Kokkos::HostSpace>();
-# endif
auto this_vector_1d = Kokkos::subview(this_vector_2d, Kokkos::ALL(), 0);
auto other_vector_1d = Kokkos::subview(other_vector_2d, Kokkos::ALL(), 0);
else
out.setf(std::ios::fixed, std::ios::floatfield);
-# if DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
auto vector_2d = vector->template getLocalView<Kokkos::HostSpace>(
Tpetra::Access::ReadOnly);
-# else
- vector->template sync<Kokkos::HostSpace>();
- auto vector_2d = vector->template getLocalView<Kokkos::HostSpace>();
-# endif
+
auto vector_1d = Kokkos::subview(vector_2d, Kokkos::ALL(), 0);
const size_t local_length = vector->getLocalLength();
{
// get a representation of the present row
std::size_t ncols;
-# if DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
typename TpetraTypes::GraphType<
MemorySpace>::nonconst_global_inds_host_view_type
column_indices_view(colnum_cache->data(), colnum_cache->size());
-# else
- Teuchos::ArrayView<dealii::types::signed_global_dof_index>
- column_indices_view(colnum_cache->data(), colnum_cache->size());
-# endif
+
sparsity_pattern->graph->getGlobalRowCopy(this->a_row,
column_indices_view,
ncols);
"that. Either use more MPI processes or recompile Trilinos "
"with 'local ordinate = long long' "));
-# if DEAL_II_TRILINOS_VERSION_GTE(12, 16, 0)
if (row_map->getComm()->getSize() > 1)
graph = Utilities::Trilinos::internal::make_rcp<
TpetraTypes::GraphType<MemorySpace>>(row_map, n_entries_per_row);
TpetraTypes::GraphType<MemorySpace>>(row_map,
col_map,
n_entries_per_row);
-# else
- if (row_map->getComm()->getSize() > 1)
- graph = Utilities::Trilinos::internal::make_rcp<
- TpetraTypes::GraphType<MemorySpace>>(
- row_map, Teuchos::arcpFromArray(n_entries_per_row));
- else
- graph = Utilities::Trilinos::internal::make_rcp<
- TpetraTypes::GraphType<MemorySpace>>(
- row_map, col_map, Teuchos::arcpFromArray(n_entries_per_row));
-
-# endif
AssertDimension(sp.n_rows(), graph->getGlobalNumRows());
AssertDimension(sp.n_cols(), graph->getGlobalNumEntries());
SparsityPattern<MemorySpace>::exists(const size_type i,
const size_type j) const
{
-# if DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
if (!row_is_stored_locally(i))
return false;
col_indices.data();
return static_cast<std::size_t>(local_col_index) != col_indices.size();
-# else
- (void)i;
- (void)j;
- DEAL_II_NOT_IMPLEMENTED();
- return false;
-# endif
}
// deallog.pop();
// }
-#if DEAL_II_TRILINOS_VERSION_GTE(13, 0, 0)
{
// Make sure the general Ifpack preconditioner throws an Exception for an
// unsupported solver.
}
deallog.pop();
}
-#endif
deallog.pop();
}