10 #ifndef TPETRA_DETAILS_GETDIAGCOPYWITHOUTOFFSETS_DEF_HPP
11 #define TPETRA_DETAILS_GETDIAGCOPYWITHOUTOFFSETS_DEF_HPP
22 #include "Tpetra_RowGraph.hpp"
23 #include "Tpetra_CrsGraph.hpp"
24 #include "Tpetra_RowMatrix.hpp"
25 #include "Tpetra_Vector.hpp"
38 template<
class SC,
class LO,
class GO,
class NT>
39 class GetLocalDiagCopyWithoutOffsetsNotFillCompleteFunctor {
41 typedef ::Tpetra::RowMatrix<SC, LO, GO, NT> row_matrix_type;
42 typedef ::Tpetra::Vector<SC, LO, GO, NT> vec_type;
48 typedef typename vec_type::dual_view_type::t_host::execution_space host_execution_space;
52 graphIsSorted (
const row_matrix_type& A)
55 using Teuchos::rcp_dynamic_cast;
64 RCP<const row_graph_type> G_row = A.getGraph ();
65 if (! G_row.is_null ()) {
66 RCP<const crs_graph_type> G_crs =
67 rcp_dynamic_cast<
const crs_graph_type> (G_row);
68 if (! G_crs.is_null ()) {
69 sorted = G_crs->isSorted ();
78 GetLocalDiagCopyWithoutOffsetsNotFillCompleteFunctor (LO& lclNumErrs,
80 const row_matrix_type& A) :
82 lclRowMap_ (*A.getRowMap ()),
83 lclColMap_ (*A.getColMap ()),
84 sorted_ (graphIsSorted (A))
86 const LO lclNumRows =
static_cast<LO
> (diag.getLocalLength ());
88 const LO matLclNumRows =
89 static_cast<LO
> (lclRowMap_.getLocalNumElements ());
90 TEUCHOS_TEST_FOR_EXCEPTION
91 (lclNumRows != matLclNumRows, std::invalid_argument,
92 "diag.getLocalLength() = " << lclNumRows <<
" != "
93 "A.getRowMap()->getLocalNumElements() = " << matLclNumRows <<
".");
97 D_lcl_ = diag.getLocalViewHost(Access::OverwriteAll);
98 D_lcl_1d_ = Kokkos::subview (D_lcl_, Kokkos::ALL (), 0);
100 Kokkos::RangePolicy<host_execution_space, LO> range (0, lclNumRows);
102 Kokkos::parallel_reduce (range, *
this, lclNumErrs);
109 void operator () (
const LO& lclRowInd, LO& errCount)
const {
110 using KokkosSparse::findRelOffset;
112 D_lcl_1d_(lclRowInd) = Kokkos::ArithTraits<IST>::zero ();
113 const GO gblInd = lclRowMap_.getGlobalElement (lclRowInd);
114 const LO lclColInd = lclColMap_.getLocalElement (gblInd);
116 if (lclColInd == Tpetra::Details::OrdinalTraits<LO>::invalid ()) {
120 typename row_matrix_type::local_inds_host_view_type lclColInds;
121 typename row_matrix_type::values_host_view_type curVals;
122 A_.getLocalRowView(lclRowInd, lclColInds, curVals);
123 LO numEnt = lclColInds.extent(0);
128 findRelOffset (lclColInds, numEnt, lclColInd, hint, sorted_);
129 if (offset == numEnt) {
133 D_lcl_1d_(lclRowInd) = curVals[offset];
139 const row_matrix_type& A_;
142 typename vec_type::dual_view_type::t_host D_lcl_;
143 decltype (Kokkos::subview (D_lcl_, Kokkos::ALL (), 0)) D_lcl_1d_;
148 template<class SC, class LO, class GO, class NT>
151 const ::Tpetra::
RowMatrix<SC, LO, GO, NT>& A,
154 using ::Tpetra::Details::gathervPrint;
155 using Teuchos::outArg;
156 using Teuchos::REDUCE_MIN;
157 using Teuchos::reduceAll;
158 typedef GetLocalDiagCopyWithoutOffsetsNotFillCompleteFunctor<SC,
159 LO, GO, NT> functor_type;
169 std::ostringstream errStrm;
170 Teuchos::RCP<const Teuchos::Comm<int> > commPtr = A.getComm ();
171 if (commPtr.is_null ()) {
174 const Teuchos::Comm<int>& comm = *commPtr;
177 functor_type functor (lclNumErrs, diag, A);
179 catch (std::exception& e) {
181 errStrm <<
"Process " << A.getComm ()->getRank () <<
": "
182 << e.what () << std::endl;
184 if (lclNumErrs != 0) {
188 reduceAll<int, int> (comm, REDUCE_MIN, lclSuccess, outArg (gblSuccess));
189 if (gblSuccess == -1) {
190 if (comm.getRank () == 0) {
198 std::cerr <<
"getLocalDiagCopyWithoutOffsetsNotFillComplete threw an "
199 "exception on one or more MPI processes in the matrix's comunicator."
205 TEUCHOS_TEST_FOR_EXCEPTION(
true, std::runtime_error,
"");
207 else if (gblSuccess == 0) {
208 TEUCHOS_TEST_FOR_EXCEPTION
209 (gblSuccess != 1, std::runtime_error,
210 "getLocalDiagCopyWithoutOffsetsNotFillComplete failed on "
211 "one or more MPI processes in the matrix's communicator.");
215 functor_type functor (lclNumErrs, diag, A);
227 #define TPETRA_DETAILS_GETDIAGCOPYWITHOUTOFFSETS_INSTANT( SCALAR, LO, GO, NODE ) \
229 Details::getLocalDiagCopyWithoutOffsetsNotFillComplete< SCALAR, LO, GO, NODE > \
230 ( ::Tpetra::Vector< SCALAR, LO, GO, NODE >& diag, \
231 const ::Tpetra::RowMatrix< SCALAR, LO, GO, NODE >& A, \
234 #endif // TPETRA_DETAILS_GETDIAGCOPYWITHOUTOFFSETS_DEF_HPP
An abstract interface for graphs accessed by rows.
base_type::impl_scalar_type impl_scalar_type
The type used internally in place of Scalar.
Declaration of a function that prints strings from each process.
void gathervPrint(std::ostream &out, const std::string &s, const Teuchos::Comm< int > &comm)
On Process 0 in the given communicator, print strings from each process in that communicator, in rank order.
LO getLocalDiagCopyWithoutOffsetsNotFillComplete(::Tpetra::Vector< SC, LO, GO, NT > &diag, const ::Tpetra::RowMatrix< SC, LO, GO, NT > &A, const bool debug=false)
Given a locally indexed, global sparse matrix, extract the matrix's diagonal entries into a Tpetra::V...
A distributed graph accessed by rows (adjacency lists) and stored sparsely.
A read-only, row-oriented interface to a sparse matrix.
A distributed dense vector.
base_type::map_type map_type
The type of the Map specialization used by this class.