]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Tpetra: Fix unity builds 16711/head
authorDaniel Arndt <arndtd@ornl.gov>
Sat, 2 Mar 2024 18:24:00 +0000 (13:24 -0500)
committerDaniel Arndt <arndtd@ornl.gov>
Sat, 2 Mar 2024 23:41:43 +0000 (18:41 -0500)
include/deal.II/lac/trilinos_tpetra_sparse_matrix.templates.h
source/lac/trilinos_tpetra_sparsity_pattern.cc

index a421e8723e65d42276249db2831a2da98687ac1b..f4ead0de686e766441681ee60d1078a8a15b6aea 100644 (file)
@@ -140,7 +140,7 @@ namespace LinearAlgebra
 
 
     // reinit_matrix():
-    namespace
+    namespace SparseMatrixImpl
     {
       using size_type = dealii::types::signed_global_dof_index;
 
@@ -400,7 +400,7 @@ namespace LinearAlgebra
           Utilities::Trilinos::internal::make_rcp<MatrixType<Number, NodeType>>(
             graph);
       }
-    } // namespace
+    } // namespace SparseMatrixImpl
 
 
 
@@ -530,7 +530,7 @@ namespace LinearAlgebra
     SparseMatrix<Number, MemorySpace>::reinit(
       const SparsityPatternType &sparsity_pattern)
     {
-      reinit_matrix<Number, NodeType, SparsityPatternType>(
+      SparseMatrixImpl::reinit_matrix<Number, NodeType, SparsityPatternType>(
         complete_index_set(sparsity_pattern.n_rows()),
         complete_index_set(sparsity_pattern.n_cols()),
         sparsity_pattern,
@@ -675,7 +675,7 @@ namespace LinearAlgebra
       const MPI_Comm             communicator,
       const bool                 exchange_data)
     {
-      reinit_matrix<Number, NodeType, SparsityPatternType>(
+      SparseMatrixImpl::reinit_matrix<Number, NodeType, SparsityPatternType>(
         row_parallel_partitioning,
         col_parallel_partitioning,
         sparsity_pattern,
index a3d4cb41c9198ebe09700b7a902669806947e066..a76913758c48d3cde61477461be028ec360131da 100644 (file)
@@ -258,7 +258,7 @@ namespace LinearAlgebra
 
 
 
-    namespace
+    namespace SparsityPatternImpl
     {
       template <typename MemorySpace>
       using size_type = typename SparsityPattern<MemorySpace>::size_type;
@@ -465,7 +465,7 @@ namespace LinearAlgebra
 
         graph->globalAssemble();
       }
-    } // namespace
+    } // namespace SparsityPatternImpl
 
 
     template <typename MemorySpace>
@@ -478,7 +478,7 @@ namespace LinearAlgebra
                                   parallel_partitioning.size());
       Teuchos::RCP<MapType> map =
         parallel_partitioning.make_tpetra_map_rcp(communicator, false);
-      reinit_sp<MemorySpace>(
+      SparsityPatternImpl::reinit_sp<MemorySpace>(
         map, map, n_entries_per_row, column_space_map, graph, nonlocal_graph);
     }
 
@@ -495,7 +495,7 @@ namespace LinearAlgebra
                                   parallel_partitioning.size());
       Teuchos::RCP<MapType> map =
         parallel_partitioning.make_tpetra_map_rcp(communicator, false);
-      reinit_sp<MemorySpace>(
+      SparsityPatternImpl::reinit_sp<MemorySpace>(
         map, map, n_entries_per_row, column_space_map, graph, nonlocal_graph);
     }
 
@@ -515,12 +515,12 @@ namespace LinearAlgebra
         row_parallel_partitioning.make_tpetra_map_rcp(communicator, false);
       Teuchos::RCP<MapType> col_map =
         col_parallel_partitioning.make_tpetra_map_rcp(communicator, false);
-      reinit_sp<MemorySpace>(row_map,
-                             col_map,
-                             n_entries_per_row,
-                             column_space_map,
-                             graph,
-                             nonlocal_graph);
+      SparsityPatternImpl::reinit_sp<MemorySpace>(row_map,
+                                                  col_map,
+                                                  n_entries_per_row,
+                                                  column_space_map,
+                                                  graph,
+                                                  nonlocal_graph);
     }
 
 
@@ -539,12 +539,12 @@ namespace LinearAlgebra
         row_parallel_partitioning.make_tpetra_map_rcp(communicator, false);
       Teuchos::RCP<MapType> col_map =
         col_parallel_partitioning.make_tpetra_map_rcp(communicator, false);
-      reinit_sp<MemorySpace>(row_map,
-                             col_map,
-                             n_entries_per_row,
-                             column_space_map,
-                             graph,
-                             nonlocal_graph);
+      SparsityPatternImpl::reinit_sp<MemorySpace>(row_map,
+                                                  col_map,
+                                                  n_entries_per_row,
+                                                  column_space_map,
+                                                  graph,
+                                                  nonlocal_graph);
     }
 
 
@@ -564,12 +564,12 @@ namespace LinearAlgebra
         row_parallel_partitioning.make_tpetra_map_rcp(communicator, false);
       Teuchos::RCP<MapType> col_map =
         col_parallel_partitioning.make_tpetra_map_rcp(communicator, false);
-      reinit_sp<MemorySpace>(row_map,
-                             col_map,
-                             n_entries_per_row,
-                             column_space_map,
-                             graph,
-                             nonlocal_graph);
+      SparsityPatternImpl::reinit_sp<MemorySpace>(row_map,
+                                                  col_map,
+                                                  n_entries_per_row,
+                                                  column_space_map,
+                                                  graph,
+                                                  nonlocal_graph);
 
       IndexSet nonlocal_partitioner = writable_rows;
       AssertDimension(nonlocal_partitioner.size(),
@@ -615,13 +615,14 @@ namespace LinearAlgebra
         row_parallel_partitioning.make_tpetra_map_rcp(communicator, false);
       Teuchos::RCP<MapType> col_map =
         col_parallel_partitioning.make_tpetra_map_rcp(communicator, false);
-      reinit_sp<SparsityPatternType, MemorySpace>(row_map,
-                                                  col_map,
-                                                  nontrilinos_sparsity_pattern,
-                                                  exchange_data,
-                                                  column_space_map,
-                                                  graph,
-                                                  nonlocal_graph);
+      SparsityPatternImpl::reinit_sp<SparsityPatternType, MemorySpace>(
+        row_map,
+        col_map,
+        nontrilinos_sparsity_pattern,
+        exchange_data,
+        column_space_map,
+        graph,
+        nonlocal_graph);
     }
 
 
@@ -643,13 +644,14 @@ namespace LinearAlgebra
                                   parallel_partitioning.size());
       Teuchos::RCP<MapType> map =
         parallel_partitioning.make_tpetra_map_rcp(communicator, false);
-      reinit_sp<SparsityPatternType, MemorySpace>(map,
-                                                  map,
-                                                  nontrilinos_sparsity_pattern,
-                                                  exchange_data,
-                                                  column_space_map,
-                                                  graph,
-                                                  nonlocal_graph);
+      SparsityPatternImpl::reinit_sp<SparsityPatternType, MemorySpace>(
+        map,
+        map,
+        nontrilinos_sparsity_pattern,
+        exchange_data,
+        column_space_map,
+        graph,
+        nonlocal_graph);
     }
 
 
@@ -701,7 +703,7 @@ namespace LinearAlgebra
           0,
           Utilities::Trilinos::tpetra_comm_self());
 
-      reinit_sp<SparsityPatternType, MemorySpace>(
+      SparsityPatternImpl::reinit_sp<SparsityPatternType, MemorySpace>(
         rows, columns, sp, false, column_space_map, graph, nonlocal_graph);
     }
 

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.