10 #ifndef MUELU_UTILITIESBASE_DEF_HPP
11 #define MUELU_UTILITIESBASE_DEF_HPP
17 #include <Kokkos_Core.hpp>
18 #include <KokkosSparse_CrsMatrix.hpp>
19 #include <KokkosSparse_getDiagCopy.hpp>
21 #include <Xpetra_BlockedVector.hpp>
22 #include <Xpetra_BlockedMap.hpp>
23 #include <Xpetra_BlockedMultiVector.hpp>
31 #include <Xpetra_CrsMatrixWrap.hpp>
32 #include <Xpetra_StridedMap.hpp>
37 #include <KokkosKernels_Handle.hpp>
38 #include <KokkosGraph_RCM.hpp>
42 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
43 RCP<Xpetra::Matrix<Scalar, LocalOrdinal, GlobalOrdinal, Node>>
48 return rcp(
new CrsMatrixWrap(Op));
58 const bool keepDiagonal) {
60 using row_ptr_type =
typename crs_matrix::local_graph_type::row_map_type::non_const_type;
61 using col_idx_type =
typename crs_matrix::local_graph_type::entries_type::non_const_type;
62 using vals_type =
typename crs_matrix::local_matrix_type::values_type;
63 using execution_space =
typename crs_matrix::local_matrix_type::execution_space;
65 using ATS = Kokkos::ArithTraits<Scalar>;
66 using impl_SC =
typename ATS::val_type;
67 using impl_ATS = Kokkos::ArithTraits<impl_SC>;
69 auto lclA = A->getLocalMatrixDevice();
71 auto rowptr = row_ptr_type(
"rowptr", lclA.numRows() + 1);
77 auto lclRowMap = A->
getRowMap()->getLocalMap();
78 auto lclColMap = A->getColMap()->getLocalMap();
79 Kokkos::parallel_scan(
80 "removeSmallEntries::rowptr",
81 Kokkos::RangePolicy<LocalOrdinal, execution_space>(0, lclA.numRows()),
83 auto row = lclA.row(rlid);
84 auto rowInCol = lclColMap.getLocalElement(lclRowMap.getGlobalElement(rlid));
86 if ((impl_ATS::magnitude(row.value(k)) > threshold) || (row.colidx(k) == rowInCol)) {
91 rowptr(rlid + 1) = partial_nnz;
95 idx = col_idx_type(
"idx", nnz);
96 vals = vals_type(
"vals", nnz);
99 "removeSmallEntries::indicesValues",
100 Kokkos::RangePolicy<LocalOrdinal, execution_space>(0, lclA.numRows()),
102 auto row = lclA.row(rlid);
103 auto rowInCol = lclColMap.getLocalElement(lclRowMap.getGlobalElement(rlid));
104 auto I = rowptr(rlid);
106 if ((impl_ATS::magnitude(row.value(k)) > threshold) || (row.colidx(k) == rowInCol)) {
107 idx(
I) = row.colidx(k);
108 vals(
I) = row.value(k);
116 Kokkos::parallel_scan(
117 "removeSmallEntries::rowptr",
118 Kokkos::RangePolicy<LocalOrdinal, execution_space>(0, lclA.numRows()),
120 auto row = lclA.row(rlid);
122 if (impl_ATS::magnitude(row.value(k)) > threshold) {
127 rowptr(rlid + 1) = partial_nnz;
131 idx = col_idx_type(
"idx", nnz);
132 vals = vals_type(
"vals", nnz);
134 Kokkos::parallel_for(
135 "removeSmallEntries::indicesValues",
136 Kokkos::RangePolicy<LocalOrdinal, execution_space>(0, lclA.numRows()),
138 auto row = lclA.row(rlid);
139 auto I = rowptr(rlid);
141 if (impl_ATS::magnitude(row.value(k)) > threshold) {
142 idx(
I) = row.colidx(k);
143 vals(
I) = row.value(k);
152 auto lclNewA =
typename crs_matrix::local_matrix_type(
"thresholdedMatrix", lclA.numRows(), lclA.numCols(), nnz, vals, rowptr, idx);
158 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
159 RCP<Xpetra::CrsMatrixWrap<Scalar, LocalOrdinal, GlobalOrdinal, Node>>
162 auto crsWrap = rcp_dynamic_cast<CrsMatrixWrap>(Ain);
163 if (!crsWrap.is_null()) {
164 auto crsMat = crsWrap->getCrsMatrix();
166 return rcp_static_cast<CrsMatrixWrap>(filteredMat);
171 RCP<CrsMatrixWrap> Aout =
rcp(
new CrsMatrixWrap(rowmap, expectedNNZperRow <= 0 ? Ain->getGlobalMaxNumRowEntries() : expectedNNZperRow));
173 for (
size_t row = 0; row < Ain->getLocalNumRows(); row++) {
174 size_t nnz = Ain->getNumEntriesInLocalRow(row);
178 Ain->getLocalRowView(row, indices, vals);
184 size_t nNonzeros = 0;
187 LocalOrdinal lclColIdx = colmap->getLocalElement(glbRow);
188 for (
size_t i = 0; i < (size_t)indices.
size(); i++) {
190 indout[nNonzeros] = colmap->getGlobalElement(indices[i]);
191 valout[nNonzeros] = vals[i];
196 for (
size_t i = 0; i < (size_t)indices.
size(); i++) {
198 indout[nNonzeros] = colmap->getGlobalElement(indices[i]);
199 valout[nNonzeros] = vals[i];
205 valout.resize(nNonzeros);
207 Aout->insertGlobalValues(Ain->getRowMap()->getGlobalElement(row), indout.view(0, indout.size()), valout.view(0, valout.size()));
209 Aout->fillComplete(Ain->getDomainMap(), Ain->getRangeMap());
214 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
219 RCP<CrsGraph> sparsityPattern = CrsGraphFactory::Build(A->getRowMap(), expectedNNZperRow <= 0 ? A->getGlobalMaxNumRowEntries() : expectedNNZperRow);
221 RCP<Vector> diag = GetMatrixOverlappedDiagonal(*A);
224 for (
size_t row = 0; row < A->getLocalNumRows(); row++) {
227 A->getLocalRowView(row, indices, vals);
229 GlobalOrdinal globalRow = A->getRowMap()->getGlobalElement(row);
230 LocalOrdinal col = A->getColMap()->getLocalElement(globalRow);
232 const Scalar Dk = STS::magnitude(D[col]) > 0.0 ? STS::magnitude(D[col]) : 1.0;
235 for (
size_t i = 0; i < size_t(indices.
size()); i++)
237 if (col == indices[i] || STS::magnitude(STS::squareroot(Dk) * vals[i] * STS::squareroot(Dk)) > STS::magnitude(threshold))
238 indicesNew.
append(A->getColMap()->getGlobalElement(indices[i]));
242 sparsityPattern->fillComplete();
244 return sparsityPattern;
247 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
251 size_t numRows = A.getRowMap()->getLocalNumElements();
255 for (
size_t i = 0; i < numRows; ++i) {
258 for (; j < cols.
size(); ++j) {
259 if (Teuchos::as<size_t>(cols[j]) == i) {
264 if (j == cols.
size()) {
272 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
276 const auto rowMap = A.getRowMap();
279 const CrsMatrixWrap* crsOp =
dynamic_cast<const CrsMatrixWrap*
>(&A);
281 using device_type =
typename CrsGraph::device_type;
282 Kokkos::View<size_t*, device_type> offsets(
"offsets", rowMap->getLocalNumElements());
283 crsOp->getCrsGraph()->getLocalDiagOffsets(offsets);
284 crsOp->getCrsMatrix()->getLocalDiagCopy(*diag, offsets);
286 A.getLocalDiagCopy(*diag);
308 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
314 const bool doLumped) {
327 using local_matrix_type =
typename Matrix::local_matrix_type;
329 using value_type =
typename local_matrix_type::value_type;
330 using values_type =
typename local_matrix_type::values_type;
331 using scalar_type =
typename values_type::non_const_value_type;
332 using ordinal_type =
typename local_matrix_type::ordinal_type;
333 using execution_space =
typename local_matrix_type::execution_space;
340 using KAT = Kokkos::ArithTraits<value_type>;
344 RCP<Vector> diag = VectorFactory::Build(rowMap,
false);
347 local_matrix_type localMatrix = A.getLocalMatrixDevice();
348 auto diagVals = diag->getDeviceLocalView(Xpetra::Access::ReadWrite);
350 ordinal_type numRows = localMatrix.graph.numRows();
352 scalar_type valReplacement_dev = valReplacement;
359 Kokkos::parallel_for(
360 "Utilities::GetMatrixDiagonalInverse",
361 Kokkos::RangePolicy<ordinal_type, execution_space>(0, numRows),
362 KOKKOS_LAMBDA(
const ordinal_type rowIdx) {
363 bool foundDiagEntry =
false;
364 auto myRow = localMatrix.rowConst(rowIdx);
365 for (ordinal_type entryIdx = 0; entryIdx < myRow.length; ++entryIdx) {
366 if (myRow.colidx(entryIdx) == rowIdx) {
367 foundDiagEntry =
true;
368 if (KAT::magnitude(myRow.value(entryIdx)) > KAT::magnitude(tol)) {
369 diagVals(rowIdx, 0) = KAT::one() / myRow.value(entryIdx);
371 diagVals(rowIdx, 0) = valReplacement_dev;
377 if (!foundDiagEntry) {
378 diagVals(rowIdx, 0) = KAT::zero();
382 Kokkos::parallel_for(
383 "Utilities::GetMatrixDiagonalInverse",
384 Kokkos::RangePolicy<ordinal_type, execution_space>(0, numRows),
385 KOKKOS_LAMBDA(
const ordinal_type rowIdx) {
386 auto myRow = localMatrix.rowConst(rowIdx);
387 for (ordinal_type entryIdx = 0; entryIdx < myRow.length; ++entryIdx) {
388 diagVals(rowIdx, 0) += KAT::magnitude(myRow.value(entryIdx));
390 if (KAT::magnitude(diagVals(rowIdx, 0)) > KAT::magnitude(tol))
391 diagVals(rowIdx, 0) = KAT::one() / diagVals(rowIdx, 0);
393 diagVals(rowIdx, 0) = valReplacement_dev;
399 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
405 const bool replaceSingleEntryRowWithZero,
406 const bool useAverageAbsDiagVal) {
410 const Scalar zero = TST::zero();
411 const Scalar one = TST::one();
412 const Scalar two = one + one;
418 if (bA == Teuchos::null) {
422 if (rowMap->lib() == Xpetra::UnderlyingLib::UseTpetra) {
425 using local_vector_type =
typename Vector::dual_view_type::t_dev_um;
426 using local_matrix_type =
typename Matrix::local_matrix_type;
427 using execution_space =
typename local_vector_type::execution_space;
430 using values_type =
typename local_matrix_type::values_type;
431 using scalar_type =
typename values_type::non_const_value_type;
432 using mag_type =
typename Kokkos::ArithTraits<scalar_type>::mag_type;
433 using KAT_S =
typename Kokkos::ArithTraits<scalar_type>;
434 using KAT_M =
typename Kokkos::ArithTraits<mag_type>;
435 using size_type =
typename local_matrix_type::non_const_size_type;
437 local_vector_type diag_dev = diag->getDeviceLocalView(Xpetra::Access::OverwriteAll);
438 local_matrix_type local_mat_dev = rcpA->getLocalMatrixDevice();
439 Kokkos::RangePolicy<execution_space, int> my_policy(0, static_cast<int>(diag_dev.extent(0)));
440 scalar_type valReplacement_dev = valReplacement;
443 Kokkos::View<int*, execution_space> nnzPerRow(
"nnz per rows", diag_dev.extent(0));
444 Kokkos::View<scalar_type*, execution_space> regSum(
"regSum", diag_dev.extent(0));
445 Kokkos::View<mag_type, execution_space> avgAbsDiagVal_dev(
"avgAbsDiagVal");
446 Kokkos::View<int, execution_space> numDiagsEqualToOne_dev(
"numDiagsEqualToOne");
450 Kokkos::parallel_for(
451 "GetLumpedMatrixDiagonal", my_policy,
452 KOKKOS_LAMBDA(
const int rowIdx) {
453 diag_dev(rowIdx, 0) = KAT_S::zero();
454 for (size_type entryIdx = local_mat_dev.graph.row_map(rowIdx);
455 entryIdx < local_mat_dev.graph.row_map(rowIdx + 1);
457 regSum(rowIdx) += local_mat_dev.values(entryIdx);
458 if (KAT_M::zero() < KAT_S::abs(local_mat_dev.values(entryIdx))) {
461 diag_dev(rowIdx, 0) += KAT_S::abs(local_mat_dev.values(entryIdx));
462 if (rowIdx == local_mat_dev.graph.entries(entryIdx)) {
463 Kokkos::atomic_add(&avgAbsDiagVal_dev(), KAT_S::abs(local_mat_dev.values(entryIdx)));
467 if (nnzPerRow(rowIdx) == 1 && KAT_S::magnitude(diag_dev(rowIdx, 0)) == KAT_M::one()) {
468 Kokkos::atomic_add(&numDiagsEqualToOne_dev(), 1);
472 if (useAverageAbsDiagVal) {
474 typename Kokkos::View<mag_type, execution_space>::HostMirror avgAbsDiagVal = Kokkos::create_mirror_view(avgAbsDiagVal_dev);
475 Kokkos::deep_copy(avgAbsDiagVal, avgAbsDiagVal_dev);
476 int numDiagsEqualToOne;
477 Kokkos::deep_copy(numDiagsEqualToOne, numDiagsEqualToOne_dev);
484 Kokkos::parallel_for(
485 "ComputeLumpedDiagonalInverse", my_policy,
486 KOKKOS_LAMBDA(
const int rowIdx) {
487 if (replaceSingleEntryRowWithZero && nnzPerRow(rowIdx) <= 1) {
488 diag_dev(rowIdx, 0) = KAT_S::zero();
489 }
else if ((diag_dev(rowIdx, 0) != KAT_S::zero()) && (KAT_S::magnitude(diag_dev(rowIdx, 0)) < KAT_S::magnitude(2 * regSum(rowIdx)))) {
490 diag_dev(rowIdx, 0) = KAT_S::one() / KAT_S::magnitude(2 * regSum(rowIdx));
492 if (KAT_S::magnitude(diag_dev(rowIdx, 0)) > tol) {
493 diag_dev(rowIdx, 0) = KAT_S::one() / diag_dev(rowIdx, 0);
495 diag_dev(rowIdx, 0) = valReplacement_dev;
503 Kokkos::parallel_for(
504 "GetLumpedMatrixDiagonal", my_policy,
505 KOKKOS_LAMBDA(
const int rowIdx) {
506 diag_dev(rowIdx, 0) = KAT_S::zero();
507 for (size_type entryIdx = local_mat_dev.graph.row_map(rowIdx);
508 entryIdx < local_mat_dev.graph.row_map(rowIdx + 1);
510 diag_dev(rowIdx, 0) += KAT_S::magnitude(local_mat_dev.values(entryIdx));
522 std::vector<int> nnzPerRow(rowMap->getLocalNumElements());
527 const Magnitude zeroMagn = TST::magnitude(zero);
528 Magnitude avgAbsDiagVal = TST::magnitude(zero);
529 int numDiagsEqualToOne = 0;
530 for (
size_t i = 0; i < rowMap->getLocalNumElements(); ++i) {
532 rcpA->getLocalRowView(i, cols, vals);
535 regSum[i] += vals[j];
536 const Magnitude rowEntryMagn = TST::magnitude(vals[j]);
537 if (rowEntryMagn > zeroMagn)
539 diagVals[i] += rowEntryMagn;
540 if (static_cast<size_t>(cols[j]) == i)
541 avgAbsDiagVal += rowEntryMagn;
543 if (nnzPerRow[i] == 1 && TST::magnitude(diagVals[i]) == 1.)
544 numDiagsEqualToOne++;
546 if (useAverageAbsDiagVal)
549 for (
size_t i = 0; i < rowMap->getLocalNumElements(); ++i) {
550 if (replaceSingleEntryRowWithZero && nnzPerRow[i] <= static_cast<int>(1))
552 else if ((diagVals[i] != zero) && (TST::magnitude(diagVals[i]) < TST::magnitude(two * regSum[i])))
553 diagVals[i] = one / TST::magnitude((two * regSum[i]));
555 if (TST::magnitude(diagVals[i]) > tol)
556 diagVals[i] = one / diagVals[i];
558 diagVals[i] = valReplacement;
566 "UtilitiesBase::GetLumpedMatrixDiagonal(): extracting reciprocal of diagonal of a blocked matrix is not supported");
569 for (
size_t row = 0; row < bA->Rows(); ++row) {
570 for (
size_t col = 0; col < bA->Cols(); ++col) {
571 if (!bA->getMatrix(row, col).
is_null()) {
574 RCP<Vector> ddtemp = bA->getRangeMapExtractor()->ExtractVector(diag, row, bThyraMode);
576 ddtemp->update(Teuchos::as<Scalar>(1.0), *dd, Teuchos::as<Scalar>(1.0));
577 bA->getRangeMapExtractor()->InsertVector(ddtemp, row, diag, bThyraMode);
586 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
595 using local_vector_type =
typename Vector::dual_view_type::t_dev_um;
596 using local_matrix_type =
typename Matrix::local_matrix_type;
597 using execution_space =
typename local_vector_type::execution_space;
598 using values_type =
typename local_matrix_type::values_type;
599 using scalar_type =
typename values_type::non_const_value_type;
600 using KAT_S =
typename Kokkos::ArithTraits<scalar_type>;
602 auto diag_dev = diag->getDeviceLocalView(Xpetra::Access::OverwriteAll);
603 auto local_mat_dev = A.getLocalMatrixDevice();
604 Kokkos::RangePolicy<execution_space, int> my_policy(0, static_cast<int>(diag_dev.extent(0)));
606 Kokkos::parallel_for(
607 "GetMatrixMaxMinusOffDiagonal", my_policy,
609 auto mymax = KAT_S::zero();
610 auto row = local_mat_dev.rowConst(rowIdx);
611 for (
LocalOrdinal entryIdx = 0; entryIdx < row.length; ++entryIdx) {
612 if (rowIdx != row.colidx(entryIdx)) {
613 if (KAT_S::real(mymax) < -KAT_S::real(row.value(entryIdx)))
614 mymax = -KAT_S::real(row.value(entryIdx));
617 diag_dev(rowIdx, 0) = mymax;
623 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
627 TEUCHOS_TEST_FOR_EXCEPTION(!A.getColMap()->isSameAs(*BlockNumber.
getMap()), std::runtime_error,
"GetMatrixMaxMinusOffDiagonal: BlockNumber must match's A's column map.");
634 using local_vector_type =
typename Vector::dual_view_type::t_dev_um;
635 using local_matrix_type =
typename Matrix::local_matrix_type;
636 using execution_space =
typename local_vector_type::execution_space;
637 using values_type =
typename local_matrix_type::values_type;
638 using scalar_type =
typename values_type::non_const_value_type;
639 using KAT_S =
typename Kokkos::ArithTraits<scalar_type>;
641 auto diag_dev = diag->getDeviceLocalView(Xpetra::Access::OverwriteAll);
642 auto local_mat_dev = A.getLocalMatrixDevice();
643 auto local_block_dev = BlockNumber.getDeviceLocalView(Xpetra::Access::ReadOnly);
644 Kokkos::RangePolicy<execution_space, int> my_policy(0, static_cast<int>(diag_dev.extent(0)));
646 Kokkos::parallel_for(
647 "GetMatrixMaxMinusOffDiagonal", my_policy,
649 auto mymax = KAT_S::zero();
650 auto row = local_mat_dev.row(rowIdx);
651 for (
LocalOrdinal entryIdx = 0; entryIdx < row.length; ++entryIdx) {
652 if ((rowIdx != row.colidx(entryIdx)) && (local_block_dev(rowIdx, 0) == local_block_dev(row.colidx(entryIdx), 0))) {
653 if (KAT_S::real(mymax) < -KAT_S::real(row.value(entryIdx)))
654 mymax = -KAT_S::real(row.value(entryIdx));
657 diag_dev(rowIdx, 0) = mymax;
663 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
671 if (bv.is_null() ==
false) {
675 for (
size_t r = 0; r < bmap->getNumMaps(); ++r) {
679 bret->setMultiVector(r, subvecinf, bmap->getThyraMode());
687 for (
size_t i = 0; i < v->getMap()->getLocalNumElements(); ++i) {
691 retVals[i] = valReplacement;
734 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
740 RCP<Vector> diagonal = VectorFactory::Build(colMap);
742 if (importer == Teuchos::null) {
743 importer = ImportFactory::Build(rowMap, colMap);
750 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
759 if (!browMap.
is_null()) rowMap = browMap->getMap();
765 for (
LO row = 0; row < static_cast<LO>(A.getRowMap()->getLocalNumElements()); ++row) {
773 for (
LO colID = 0; colID < static_cast<LO>(nnz); colID++) {
774 if (indices[colID] != row) {
783 if (importer == Teuchos::null) {
790 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
802 if (!browMap.
is_null()) rowMap = browMap->getMap();
808 for (
LO rowIdx = 0; rowIdx < static_cast<LO>(A.getRowMap()->getLocalNumElements()); ++rowIdx) {
816 for (
LO colID = 0; colID < static_cast<LO>(nnz); ++colID) {
817 if (indices[colID] != rowIdx) {
818 si += STS::magnitude(vals[colID]);
821 localVals[rowIdx] = si;
826 if (importer == Teuchos::null) {
833 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
838 const size_t numVecs = X.getNumVectors();
845 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
850 const size_t numVecs = X.getNumVectors();
851 Residual(Op, X, RHS, Resid);
857 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
862 const size_t numVecs = X.getNumVectors();
865 Op.residual(X, RHS, *RES);
869 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
874 Op.residual(X, RHS, Resid);
877 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
883 "Utils::PowerMethod: operator must have domain and range maps that are equivalent.");
888 diagInvVec = GetMatrixDiagonalInverse(A);
891 Scalar lambda = PowerMethod(A, diagInvVec, niters, tolerance, verbose, seed);
895 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
898 PowerMethod(
const Matrix& A,
const RCP<Vector>& diagInvVec,
901 "Utils::PowerMethod: operator must have domain and range maps that are equivalent.");
915 const Scalar zero = STS::zero(), one = STS::one();
918 Magnitude
residual = STS::magnitude(zero);
921 for (
int iter = 0;
iter < niters; ++
iter) {
923 q->update(one / norms[0], *z, zero);
925 if (diagInvVec != Teuchos::null)
926 z->elementWiseMultiply(one, *diagInvVec, *z, zero);
929 if (iter % 100 == 0 || iter + 1 == niters) {
930 r->update(1.0, *z, -lambda, *q, zero);
932 residual = STS::magnitude(norms[0] / lambda);
934 std::cout <<
"Iter = " <<
iter
935 <<
" Lambda = " << lambda
936 <<
" Residual of A*q - lambda*q = " << residual
940 if (residual < tolerance)
946 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
947 RCP<Teuchos::FancyOStream>
954 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
958 const size_t numVectors = v.size();
961 for (
size_t j = 0; j < numVectors; j++) {
962 d += (v[j][i0] - v[j][i1]) * (v[j][i0] - v[j][i1]);
967 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
971 const size_t numVectors = v.size();
975 for (
size_t j = 0; j < numVectors; j++) {
976 d += Teuchos::as<MT>(weight[j]) * (v[j][i0] - v[j][i1]) * (v[j][i0] - v[j][i1]);
981 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
988 if (count_twos_as_dirichlet) {
996 for (col = 0; col < nnz; col++)
997 if ((indices[col] != row) && STS::magnitude(vals[col]) > tol) {
998 if (!boundaryNodes[row])
1000 boundaryNodes[row] =
false;
1003 boundaryNodes[row] =
true;
1013 for (
size_t col = 0; col < nnz; col++)
1014 if ((indices[col] != row) && STS::magnitude(vals[col]) > tol) {
1015 boundaryNodes[row] =
false;
1020 return boundaryNodes;
1023 template <
class SC,
class LO,
class GO,
class NO,
class memory_space>
1024 Kokkos::View<bool*, memory_space>
1027 const bool count_twos_as_dirichlet) {
1028 using impl_scalar_type =
typename Kokkos::ArithTraits<SC>::val_type;
1029 using ATS = Kokkos::ArithTraits<impl_scalar_type>;
1030 using range_type = Kokkos::RangePolicy<LO, typename NO::execution_space>;
1033 Kokkos::View<bool*, typename NO::device_type::memory_space> boundaryNodes;
1035 if (helpers::isTpetraBlockCrs(A)) {
1037 auto b_graph = Am.getCrsGraph().getLocalGraphDevice();
1038 auto b_rowptr = Am.getCrsGraph().getLocalRowPtrsDevice();
1043 boundaryNodes = Kokkos::View<bool*, typename NO::device_type::memory_space>(Kokkos::ViewAllocateWithoutInitializing(
"boundaryNodes"), numBlockRows);
1045 if (count_twos_as_dirichlet)
1048 Kokkos::parallel_for(
1049 "MueLu:Utils::DetectDirichletRowsBlockCrs", range_type(0, numBlockRows),
1050 KOKKOS_LAMBDA(
const LO row) {
1051 auto rowView = b_graph.rowConst(row);
1052 auto length = rowView.length;
1053 LO valstart = b_rowptr[row] * stride;
1055 boundaryNodes(row) =
true;
1056 decltype(length) colID = 0;
1057 for (; colID < length; colID++) {
1058 if (rowView.colidx(colID) != row) {
1059 LO current = valstart + colID * stride;
1060 for (
LO k = 0; k < stride; k++) {
1061 if (ATS::magnitude(values[current + k]) > tol) {
1062 boundaryNodes(row) =
false;
1067 if (boundaryNodes(row) ==
false)
1072 auto localMatrix = A.getLocalMatrixDevice();
1073 LO numRows = A.getLocalNumRows();
1074 boundaryNodes = Kokkos::View<bool*, typename NO::device_type::memory_space>(Kokkos::ViewAllocateWithoutInitializing(
"boundaryNodes"), numRows);
1076 if (count_twos_as_dirichlet)
1077 Kokkos::parallel_for(
1078 "MueLu:Utils::DetectDirichletRows_Twos_As_Dirichlet", range_type(0, numRows),
1079 KOKKOS_LAMBDA(
const LO row) {
1080 auto rowView = localMatrix.row(row);
1081 auto length = rowView.length;
1083 boundaryNodes(row) =
true;
1085 decltype(length) colID = 0;
1086 for (; colID < length; colID++)
1087 if ((rowView.colidx(colID) != row) &&
1088 (ATS::magnitude(rowView.value(colID)) > tol)) {
1089 if (!boundaryNodes(row))
1091 boundaryNodes(row) =
false;
1093 if (colID == length)
1094 boundaryNodes(row) =
true;
1098 Kokkos::parallel_for(
1099 "MueLu:Utils::DetectDirichletRows", range_type(0, numRows),
1100 KOKKOS_LAMBDA(
const LO row) {
1101 auto rowView = localMatrix.row(row);
1102 auto length = rowView.length;
1104 boundaryNodes(row) =
true;
1105 for (decltype(length) colID = 0; colID < length; colID++)
1106 if ((rowView.colidx(colID) != row) &&
1107 (ATS::magnitude(rowView.value(colID)) > tol)) {
1108 boundaryNodes(row) =
false;
1113 if constexpr (std::is_same<memory_space, typename NO::device_type::memory_space>::value)
1114 return boundaryNodes;
1116 Kokkos::View<bool*, memory_space> boundaryNodes2(Kokkos::ViewAllocateWithoutInitializing(
"boundaryNodes"), boundaryNodes.extent(0));
1117 Kokkos::deep_copy(boundaryNodes2, boundaryNodes);
1118 return boundaryNodes2;
1121 Kokkos::View<bool*, memory_space> dummy(
"dummy", 0);
1125 template <
class SC,
class LO,
class GO,
class NO>
1126 Kokkos::View<bool*, typename NO::device_type::memory_space>
1130 const bool count_twos_as_dirichlet) {
1131 return MueLu::DetectDirichletRows_kokkos<SC, LO, GO, NO, typename NO::device_type::memory_space>(A, tol, count_twos_as_dirichlet);
1134 template <
class SC,
class LO,
class GO,
class NO>
1135 Kokkos::View<bool*, typename Kokkos::HostSpace>
1139 const bool count_twos_as_dirichlet) {
1140 return MueLu::DetectDirichletRows_kokkos<SC, LO, GO, NO, typename Kokkos::HostSpace>(A, tol, count_twos_as_dirichlet);
1143 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1148 bHasZeroDiagonal =
false;
1162 bool bHasDiag =
false;
1163 for (decltype(indices.
size()) col = 0; col < indices.
size(); col++) {
1164 if (indices[col] != row) {
1165 if (STS::magnitude(vals[col] / STS::magnitude(sqrt(STS::magnitude(diagVecData[row]) * STS::magnitude(diagVecData[col])))) > tol) {
1171 if (bHasDiag ==
false)
1172 bHasZeroDiagonal =
true;
1174 boundaryNodes[row] =
true;
1176 return boundaryNodes;
1179 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1185 const bool count_twos_as_dirichlet) {
1186 using range_type = Kokkos::RangePolicy<LO, typename Node::execution_space>;
1197 auto lclRHS = RHS.getDeviceLocalView(Xpetra::Access::ReadOnly);
1198 auto lclInitialGuess = InitialGuess.getDeviceLocalView(Xpetra::Access::ReadWrite);
1200 Kokkos::parallel_for(
1201 "MueLu:Utils::EnforceInitialCondition", range_type(0, numRows),
1202 KOKKOS_LAMBDA(
const LO row) {
1203 if (dirichletRows(row)) {
1205 lclInitialGuess(row, j) = lclRHS(row, j);
1210 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1217 for (
size_t i = 0; i < static_cast<size_t>(vals.
size()); i++) {
1223 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1226 Kokkos::View<bool*, typename Node::device_type> nonzeros) {
1227 using ATS = Kokkos::ArithTraits<Scalar>;
1228 using impl_ATS = Kokkos::ArithTraits<typename ATS::val_type>;
1229 using range_type = Kokkos::RangePolicy<LocalOrdinal, typename Node::execution_space>;
1231 const typename ATS::magnitudeType eps = 2.0 * impl_ATS::eps();
1233 Kokkos::parallel_for(
1234 "MueLu:Maxwell1::FindNonZeros", range_type(0, vals.extent(0)),
1235 KOKKOS_LAMBDA(
const size_t i) {
1236 nonzeros(i) = (impl_ATS::magnitude(vals(i, 0)) > eps);
1240 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1250 TEUCHOS_ASSERT(static_cast<size_t>(dirichletRows.
size()) == rowMap->getLocalNumElements());
1251 TEUCHOS_ASSERT(static_cast<size_t>(dirichletCols.
size()) == colMap->getLocalNumElements());
1252 TEUCHOS_ASSERT(static_cast<size_t>(dirichletDomain.
size()) == domMap->getLocalNumElements());
1255 for (
size_t i = 0; i < (size_t)dirichletRows.
size(); i++) {
1256 if (dirichletRows[i]) {
1260 for (
size_t j = 0; j < static_cast<size_t>(indices.
size()); j++)
1261 myColsToZero->replaceLocalValue(indices[j], 0, one);
1270 globalColsToZero->doExport(*myColsToZero, *importer,
Xpetra::ADD);
1272 myColsToZero->doImport(*globalColsToZero, *importer,
Xpetra::INSERT);
1274 globalColsToZero = myColsToZero;
1276 FindNonZeros(globalColsToZero->getData(0), dirichletDomain);
1277 FindNonZeros(myColsToZero->getData(0), dirichletCols);
1280 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1283 const Kokkos::View<bool*, typename Node::device_type>& dirichletRows,
1284 Kokkos::View<bool*, typename Node::device_type> dirichletCols,
1285 Kokkos::View<bool*, typename Node::device_type> dirichletDomain) {
1286 using ATS = Kokkos::ArithTraits<Scalar>;
1287 using impl_ATS = Kokkos::ArithTraits<typename ATS::val_type>;
1288 using range_type = Kokkos::RangePolicy<LocalOrdinal, typename Node::execution_space>;
1292 TEUCHOS_ASSERT(dirichletRows.extent(0) == rowMap->getLocalNumElements());
1293 TEUCHOS_ASSERT(dirichletCols.extent(0) == colMap->getLocalNumElements());
1294 TEUCHOS_ASSERT(dirichletDomain.extent(0) == domMap->getLocalNumElements());
1297 auto myColsToZeroView = myColsToZero->getDeviceLocalView(Xpetra::Access::ReadWrite);
1298 auto localMatrix = A.getLocalMatrixDevice();
1299 Kokkos::parallel_for(
1300 "MueLu:Maxwell1::DetectDirichletCols", range_type(0, rowMap->getLocalNumElements()),
1302 if (dirichletRows(row)) {
1303 auto rowView = localMatrix.row(row);
1304 auto length = rowView.length;
1306 for (decltype(length) colID = 0; colID < length; colID++)
1307 myColsToZeroView(rowView.colidx(colID), 0) = impl_ATS::one();
1316 globalColsToZero->doExport(*myColsToZero, *importer,
Xpetra::ADD);
1318 myColsToZero->doImport(*globalColsToZero, *importer,
Xpetra::INSERT);
1320 globalColsToZero = myColsToZero;
1325 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1332 for (
LocalOrdinal row = 0; row < Teuchos::as<LocalOrdinal>(rowmap->getLocalNumElements()); ++row) {
1338 Scalar rowsum = STS::zero();
1339 Scalar diagval = STS::zero();
1341 for (
LocalOrdinal colID = 0; colID < Teuchos::as<LocalOrdinal>(nnz); colID++) {
1344 diagval = vals[colID];
1345 rowsum += vals[colID];
1348 if (rowSumTol < MTS::one() && STS::magnitude(rowsum) > STS::magnitude(diagval) * rowSumTol) {
1350 dirichletRows[row] =
true;
1355 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1361 RCP<const Xpetra::Map<LocalOrdinal, GlobalOrdinal, Node>> rowmap = A.getRowMap();
1363 TEUCHOS_TEST_FOR_EXCEPTION(!A.getColMap()->isSameAs(*BlockNumber.
getMap()), std::runtime_error,
"ApplyRowSumCriterion: BlockNumber must match's A's column map.");
1366 for (
LocalOrdinal row = 0; row < Teuchos::as<LocalOrdinal>(rowmap->getLocalNumElements()); ++row) {
1368 ArrayView<const LocalOrdinal> indices;
1369 ArrayView<const Scalar> vals;
1372 Scalar rowsum = STS::zero();
1373 Scalar diagval = STS::zero();
1374 for (
LocalOrdinal colID = 0; colID < Teuchos::as<LocalOrdinal>(nnz); colID++) {
1377 diagval = vals[colID];
1378 if (block_id[row] == block_id[col])
1379 rowsum += vals[colID];
1383 if (rowSumTol < MTS::one() && STS::magnitude(rowsum) > STS::magnitude(diagval) * rowSumTol) {
1385 dirichletRows[row] =
true;
1391 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node,
class memory_space>
1394 Kokkos::View<bool*, memory_space>& dirichletRows) {
1398 auto dirichletRowsHost = Kokkos::create_mirror_view(dirichletRows);
1399 Kokkos::deep_copy(dirichletRowsHost, dirichletRows);
1401 for (
LocalOrdinal row = 0; row < Teuchos::as<LocalOrdinal>(rowmap->getLocalNumElements()); ++row) {
1407 Scalar rowsum = STS::zero();
1408 Scalar diagval = STS::zero();
1409 for (
LocalOrdinal colID = 0; colID < Teuchos::as<LocalOrdinal>(nnz); colID++) {
1412 diagval = vals[colID];
1413 rowsum += vals[colID];
1415 if (STS::real(rowsum) > STS::magnitude(diagval) * rowSumTol)
1416 dirichletRowsHost(row) =
true;
1419 Kokkos::deep_copy(dirichletRows, dirichletRowsHost);
1422 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1426 Kokkos::View<bool*, typename Node::device_type::memory_space>& dirichletRows) {
1427 MueLu::ApplyRowSumCriterion<Scalar, LocalOrdinal, GlobalOrdinal, Node, typename Node::device_type::memory_space>(A, rowSumTol, dirichletRows);
1430 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1434 Kokkos::View<bool*, Kokkos::HostSpace>& dirichletRows) {
1435 MueLu::ApplyRowSumCriterion<Scalar, LocalOrdinal, GlobalOrdinal, Node, Kokkos::HostSpace>(A, rowSumTol, dirichletRows);
1439 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node,
class memory_space>
1443 Kokkos::View<bool*, memory_space>& dirichletRows) {
1447 TEUCHOS_TEST_FOR_EXCEPTION(!A.getColMap()->isSameAs(*BlockNumber.
getMap()), std::runtime_error,
"ApplyRowSumCriterion: BlockNumber must match's A's column map.");
1449 auto dirichletRowsHost = Kokkos::create_mirror_view(dirichletRows);
1450 Kokkos::deep_copy(dirichletRowsHost, dirichletRows);
1453 for (
LocalOrdinal row = 0; row < Teuchos::as<LocalOrdinal>(rowmap->getLocalNumElements()); ++row) {
1459 Scalar rowsum = STS::zero();
1460 Scalar diagval = STS::zero();
1461 for (
LocalOrdinal colID = 0; colID < Teuchos::as<LocalOrdinal>(nnz); colID++) {
1464 diagval = vals[colID];
1465 if (block_id[row] == block_id[col])
1466 rowsum += vals[colID];
1468 if (STS::real(rowsum) > STS::magnitude(diagval) * rowSumTol)
1469 dirichletRowsHost(row) =
true;
1472 Kokkos::deep_copy(dirichletRows, dirichletRowsHost);
1475 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1480 Kokkos::View<bool*, typename Node::device_type::memory_space>& dirichletRows) {
1481 MueLu::ApplyRowSumCriterion<Scalar, LocalOrdinal, GlobalOrdinal, Node, typename Node::device_type::memory_space>(A, BlockNumber, rowSumTol, dirichletRows);
1484 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1489 Kokkos::View<bool*, Kokkos::HostSpace>& dirichletRows) {
1490 MueLu::ApplyRowSumCriterion<Scalar, LocalOrdinal, GlobalOrdinal, Node, Kokkos::HostSpace>(A, BlockNumber, rowSumTol, dirichletRows);
1493 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1503 myColsToZero->putScalar(zero);
1505 for (
size_t i = 0; i < (size_t)dirichletRows.
size(); i++) {
1506 if (dirichletRows[i]) {
1510 for (
size_t j = 0; j < static_cast<size_t>(indices.
size()); j++)
1511 myColsToZero->replaceLocalValue(indices[j], 0, one);
1516 globalColsToZero->putScalar(zero);
1519 globalColsToZero->doExport(*myColsToZero, *exporter,
Xpetra::ADD);
1521 myColsToZero->doImport(*globalColsToZero, *exporter,
Xpetra::INSERT);
1525 for (
size_t i = 0; i < colMap->getLocalNumElements(); i++) {
1528 return dirichletCols;
1531 template <
class SC,
class LO,
class GO,
class NO>
1532 Kokkos::View<bool*, typename NO::device_type>
1535 const Kokkos::View<const bool*, typename NO::device_type>& dirichletRows) {
1536 using ATS = Kokkos::ArithTraits<SC>;
1537 using impl_ATS = Kokkos::ArithTraits<typename ATS::val_type>;
1538 using range_type = Kokkos::RangePolicy<LO, typename NO::execution_space>;
1540 SC zero = ATS::zero();
1542 auto localMatrix = A.getLocalMatrixDevice();
1543 LO numRows = A.getLocalNumRows();
1548 myColsToZero->putScalar(zero);
1549 auto myColsToZeroView = myColsToZero->getDeviceLocalView(Xpetra::Access::ReadWrite);
1551 Kokkos::parallel_for(
1552 "MueLu:Utils::DetectDirichletCols1", range_type(0, numRows),
1553 KOKKOS_LAMBDA(
const LO row) {
1554 if (dirichletRows(row)) {
1555 auto rowView = localMatrix.row(row);
1556 auto length = rowView.length;
1558 for (decltype(length) colID = 0; colID < length; colID++)
1559 myColsToZeroView(rowView.colidx(colID), 0) = impl_ATS::one();
1564 globalColsToZero->putScalar(zero);
1567 globalColsToZero->doExport(*myColsToZero, *exporter,
Xpetra::ADD);
1569 myColsToZero->doImport(*globalColsToZero, *exporter,
Xpetra::INSERT);
1571 auto myCols = myColsToZero->getDeviceLocalView(Xpetra::Access::ReadOnly);
1572 size_t numColEntries = colMap->getLocalNumElements();
1573 Kokkos::View<bool*, typename NO::device_type> dirichletCols(Kokkos::ViewAllocateWithoutInitializing(
"dirichletCols"), numColEntries);
1574 const typename ATS::magnitudeType eps = 2.0 * ATS::eps();
1576 Kokkos::parallel_for(
1577 "MueLu:Utils::DetectDirichletCols2", range_type(0, numColEntries),
1578 KOKKOS_LAMBDA(
const size_t i) {
1579 dirichletCols(i) = impl_ATS::magnitude(myCols(i, 0)) > eps;
1581 return dirichletCols;
1584 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1595 const Map& AColMap = *A.getColMap();
1596 const Map& BColMap = *B.getColMap();
1600 size_t nnzA = 0, nnzB = 0;
1616 size_t numRows = A.getLocalNumRows();
1617 for (
size_t i = 0; i < numRows; i++) {
1624 for (
size_t j = 0; j < nnzB; j++)
1625 valBAll[indB[j]] = valB[j];
1627 for (
size_t j = 0; j < nnzA; j++) {
1630 LocalOrdinal ind = BColMap.getLocalElement(AColMap.getGlobalElement(indA[j]));
1632 f += valBAll[ind] * valA[j];
1636 for (
size_t j = 0; j < nnzB; j++)
1637 valBAll[indB[j]] = zero;
1645 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1653 int maxint = INT_MAX;
1654 int mySeed = Teuchos::as<int>((maxint - 1) * (one - (comm.
getRank() + 1) / (comm.
getSize() + one)));
1655 if (mySeed < 1 || mySeed == maxint) {
1656 std::ostringstream errStr;
1657 errStr <<
"Error detected with random seed = " << mySeed <<
". It should be in the interval [1,2^31-2].";
1669 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1672 std::vector<LocalOrdinal>& dirichletRows,
bool count_twos_as_dirichlet) {
1674 dirichletRows.resize(0);
1675 for (
size_t i = 0; i < A->getLocalNumRows(); i++) {
1680 for (
size_t j = 0; j < (size_t)indices.
size(); j++) {
1685 if (nnz == 1 || (count_twos_as_dirichlet && nnz == 2)) {
1686 dirichletRows.push_back(i);
1691 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1694 const std::vector<LocalOrdinal>& dirichletRows) {
1700 for (
size_t i = 0; i < dirichletRows.size(); i++) {
1701 GlobalOrdinal row_gid = Rmap->getGlobalElement(dirichletRows[i]);
1708 for (
size_t j = 0; j < (size_t)indices.
size(); j++) {
1709 if (Cmap->getGlobalElement(indices[j]) == row_gid)
1717 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1726 TEUCHOS_ASSERT(static_cast<size_t>(dirichletRows.
size()) == Rmap->getLocalNumElements());
1730 for (
size_t i = 0; i < (size_t)dirichletRows.
size(); i++) {
1731 if (dirichletRows[i]) {
1739 for (
size_t j = 0; j < (size_t)indices.
size(); j++) {
1740 if (Cmap->getGlobalElement(indices[j]) == row_gid)
1751 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1754 const Kokkos::View<const bool*, typename Node::device_type>& dirichletRows) {
1756 using ATS = Kokkos::ArithTraits<Scalar>;
1757 using impl_ATS = Kokkos::ArithTraits<typename ATS::val_type>;
1758 using range_type = Kokkos::RangePolicy<LocalOrdinal, typename Node::execution_space>;
1765 TEUCHOS_ASSERT(static_cast<size_t>(dirichletRows.size()) == Rmap->getLocalNumElements());
1767 auto localMatrix = A->getLocalMatrixDevice();
1768 auto localRmap = Rmap->getLocalMap();
1769 auto localCmap = Cmap->getLocalMap();
1771 Kokkos::parallel_for(
1772 "MueLu::Utils::ApplyOAZ", range_type(0, dirichletRows.extent(0)),
1774 if (dirichletRows(row)) {
1775 auto rowView = localMatrix.row(row);
1776 auto length = rowView.length;
1777 auto row_gid = localRmap.getGlobalElement(row);
1778 auto row_lid = localCmap.getLocalElement(row_gid);
1780 for (decltype(length) colID = 0; colID < length; colID++)
1781 if (rowView.colidx(colID) == row_lid)
1782 rowView.value(colID) = impl_ATS::one();
1784 rowView.value(colID) = impl_ATS::zero();
1789 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1792 const std::vector<LocalOrdinal>& dirichletRows,
1794 for (
size_t i = 0; i < dirichletRows.size(); i++) {
1800 for (
size_t j = 0; j < (size_t)indices.
size(); j++)
1801 valuesNC[j] = replaceWith;
1805 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1810 TEUCHOS_ASSERT(static_cast<size_t>(dirichletRows.
size()) == A->getRowMap()->getLocalNumElements());
1811 for (
size_t i = 0; i < (size_t)dirichletRows.
size(); i++) {
1812 if (dirichletRows[i]) {
1818 for (
size_t j = 0; j < (size_t)indices.
size(); j++)
1819 valuesNC[j] = replaceWith;
1824 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1829 TEUCHOS_ASSERT(static_cast<size_t>(dirichletRows.
size()) == X->getMap()->getLocalNumElements());
1830 for (
size_t i = 0; i < (size_t)dirichletRows.
size(); i++) {
1831 if (dirichletRows[i]) {
1832 for (
size_t j = 0; j < X->getNumVectors(); j++)
1833 X->replaceLocalValue(i, j, replaceWith);
1838 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1841 const Kokkos::View<const bool*, typename Node::device_type>& dirichletRows,
1843 using ATS = Kokkos::ArithTraits<Scalar>;
1844 using range_type = Kokkos::RangePolicy<LocalOrdinal, typename Node::execution_space>;
1846 typename ATS::val_type impl_replaceWith = replaceWith;
1848 auto localMatrix = A->getLocalMatrixDevice();
1851 Kokkos::parallel_for(
1852 "MueLu:Utils::ZeroDirichletRows", range_type(0, numRows),
1854 if (dirichletRows(row)) {
1855 auto rowView = localMatrix.row(row);
1856 auto length = rowView.length;
1857 for (decltype(length) colID = 0; colID < length; colID++)
1858 rowView.value(colID) = impl_replaceWith;
1863 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1866 const Kokkos::View<const bool*, typename Node::device_type>& dirichletRows,
1868 using ATS = Kokkos::ArithTraits<Scalar>;
1869 using range_type = Kokkos::RangePolicy<LocalOrdinal, typename Node::execution_space>;
1871 typename ATS::val_type impl_replaceWith = replaceWith;
1873 auto myCols = X->getDeviceLocalView(Xpetra::Access::ReadWrite);
1874 size_t numVecs = X->getNumVectors();
1875 Kokkos::parallel_for(
1876 "MueLu:Utils::ZeroDirichletRows_MV", range_type(0, dirichletRows.size()),
1877 KOKKOS_LAMBDA(
const size_t i) {
1878 if (dirichletRows(i)) {
1879 for (
size_t j = 0; j < numVecs; j++)
1880 myCols(i, j) = impl_replaceWith;
1885 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1890 TEUCHOS_ASSERT(static_cast<size_t>(dirichletCols.
size()) == A->getColMap()->getLocalNumElements());
1891 for (
size_t i = 0; i < A->getLocalNumRows(); i++) {
1894 A->getLocalRowView(i, indices, values);
1897 for (
size_t j = 0; j < static_cast<size_t>(indices.
size()); j++)
1898 if (dirichletCols[indices[j]])
1899 valuesNC[j] = replaceWith;
1903 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1906 const Kokkos::View<const bool*, typename Node::device_type>& dirichletCols,
1908 using ATS = Kokkos::ArithTraits<Scalar>;
1909 using range_type = Kokkos::RangePolicy<LocalOrdinal, typename Node::execution_space>;
1911 typename ATS::val_type impl_replaceWith = replaceWith;
1913 auto localMatrix = A->getLocalMatrixDevice();
1916 Kokkos::parallel_for(
1917 "MueLu:Utils::ZeroDirichletCols", range_type(0, numRows),
1919 auto rowView = localMatrix.row(row);
1920 auto length = rowView.length;
1921 for (decltype(length) colID = 0; colID < length; colID++)
1922 if (dirichletCols(rowView.colidx(colID))) {
1923 rowView.value(colID) = impl_replaceWith;
1928 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1935 throw std::runtime_error(
"UtilitiesBase::FindDirichletRowsAndPropagateToCols row and domain maps must match.");
1938 bool has_import = !importer.
is_null();
1941 std::vector<LocalOrdinal> dirichletRows;
1942 FindDirichletRows(A, dirichletRows);
1945 printf(
"[%d] DirichletRow Ids = ",A->getRowMap()->getComm()->getRank());
1946 for(
size_t i=0; i<(size_t) dirichletRows.size(); i++)
1947 printf(
"%d ",dirichletRows[i]);
1960 for (
size_t i = 0; i < (size_t)dirichletRows.size(); i++) {
1961 dr[dirichletRows[i]] = 1;
1962 if (!has_import) dc[dirichletRows[i]] = 1;
1967 isDirichletCol->doImport(*isDirichletRow, *importer, Xpetra::CombineMode::ADD);
1970 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
1974 using ISC =
typename Kokkos::ArithTraits<Scalar>::val_type;
1975 using range_type = Kokkos::RangePolicy<LocalOrdinal, typename Node::execution_space>;
1976 using local_matrix_type =
typename CrsMatrix::local_matrix_type;
1977 using values_type =
typename local_matrix_type::values_type;
1979 const ISC ONE = Kokkos::ArithTraits<ISC>::one();
1980 const ISC
ZERO = Kokkos::ArithTraits<ISC>::zero();
1983 auto localMatrix = original->getLocalMatrixDevice();
1985 values_type new_values(
"values", localMatrix.nnz());
1987 Kokkos::parallel_for(
1988 "ReplaceNonZerosWithOnes", range_type(0, localMatrix.nnz()), KOKKOS_LAMBDA(
const size_t i) {
1989 if (localMatrix.values(i) != ZERO)
1990 new_values(i) = ONE;
1992 new_values(i) = ZERO;
1998 NewMatrix->fillComplete(original->getDomainMap(), original->getRangeMap());
2002 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
2013 if (!stridedMap.
is_null()) fullMap = stridedMap->getMap();
2016 const size_t numSubMaps = sourceBlockedMap.
getNumMaps();
2018 throw std::runtime_error(
"GenerateBlockedTargetMap(): Map compatibility error");
2023 for (
size_t i = 0; i < numSubMaps; i++) {
2026 for (
size_t j = 0; j < map->getLocalNumElements(); j++) {
2027 LocalOrdinal jj = fullMap->getLocalElement(map->getGlobalElement(j));
2028 block_ids->replaceLocalValue(jj, (
int)i);
2035 new_block_ids->doImport(*block_ids, Importer, Xpetra::CombineMode::ADD);
2041 for (
size_t i = 0; i < targetMap->getLocalNumElements(); i++) {
2042 elementsInSubMap[data[i]].
push_back(targetMap->getGlobalElement(i));
2046 std::vector<RCP<const Map>> subMaps(numSubMaps);
2047 for (
size_t i = 0; i < numSubMaps; i++) {
2052 return rcp(
new BlockedMap(targetMap, subMaps));
2055 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
2061 const size_t numElements = rowElements.
size();
2063 if (
size_t(colElements.
size()) < numElements)
2066 bool goodMap =
true;
2067 for (
size_t i = 0; i < numElements; i++)
2068 if (rowElements[i] != colElements[i]) {
2076 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
2081 using local_graph_type =
typename local_matrix_type::staticcrsgraph_type;
2082 using lno_nnz_view_t =
typename local_graph_type::entries_type::non_const_type;
2083 using device =
typename local_graph_type::device_type;
2084 using execution_space =
typename local_matrix_type::execution_space;
2085 using ordinal_type =
typename local_matrix_type::ordinal_type;
2087 local_graph_type localGraph = Op.getLocalMatrixDevice().graph;
2089 lno_nnz_view_t rcmOrder = KokkosGraph::Experimental::graph_rcm<device, typename local_graph_type::row_map_type, typename local_graph_type::entries_type, lno_nnz_view_t>(localGraph.row_map, localGraph.entries);
2095 auto view1D = Kokkos::subview(retval->getDeviceLocalView(Xpetra::Access::ReadWrite), Kokkos::ALL(), 0);
2096 Kokkos::parallel_for(
2097 "Utilities::ReverseCuthillMcKee",
2098 Kokkos::RangePolicy<ordinal_type, execution_space>(0, localGraph.numRows()),
2099 KOKKOS_LAMBDA(
const ordinal_type rowIdx) {
2100 view1D(rcmOrder(rowIdx)) = rowIdx;
2105 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
2110 using local_graph_type =
typename local_matrix_type::staticcrsgraph_type;
2111 using lno_nnz_view_t =
typename local_graph_type::entries_type::non_const_type;
2112 using device =
typename local_graph_type::device_type;
2113 using execution_space =
typename local_matrix_type::execution_space;
2114 using ordinal_type =
typename local_matrix_type::ordinal_type;
2116 local_graph_type localGraph = Op.getLocalMatrixDevice().graph;
2119 lno_nnz_view_t rcmOrder = KokkosGraph::Experimental::graph_rcm<device, typename local_graph_type::row_map_type, typename local_graph_type::entries_type, lno_nnz_view_t>(localGraph.row_map, localGraph.entries);
2125 auto view1D = Kokkos::subview(retval->getDeviceLocalView(Xpetra::Access::ReadWrite), Kokkos::ALL(), 0);
2127 Kokkos::parallel_for(
2128 "Utilities::ReverseCuthillMcKee",
2129 Kokkos::RangePolicy<ordinal_type, execution_space>(0, numRows),
2130 KOKKOS_LAMBDA(
const ordinal_type rowIdx) {
2131 view1D(rcmOrder(numRows - 1 - rowIdx)) = rowIdx;
2138 #define MUELU_UTILITIESBASE_SHORT
2139 #endif // MUELU_UTILITIESBASE_DEF_HPP
static void FindNonZeros(const Teuchos::ArrayRCP< const Scalar > vals, Teuchos::ArrayRCP< bool > nonzeros)
Find non-zero values in an ArrayRCP Compares the value to 2 * machine epsilon.
static RCP< Export< LocalOrdinal, GlobalOrdinal, Node > > Build(const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &source, const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &target)
static RCP< Vector > GetMatrixDiagonal(const Matrix &A)
Extract Matrix Diagonal.
static void ApplyOAZToMatrixRows(Teuchos::RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >> &A, const std::vector< LocalOrdinal > &dirichletRows)
static Teuchos::RCP< Vector > GetMatrixMaxMinusOffDiagonal(const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A)
Return vector containing: max_{i=k}(-a_ik), for each for i in the matrix.
static void ZeroDirichletCols(Teuchos::RCP< Matrix > &A, const Teuchos::ArrayRCP< const bool > &dirichletCols, Scalar replaceWith=Teuchos::ScalarTraits< Scalar >::zero())
static void DetectDirichletColsAndDomains(const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Teuchos::ArrayRCP< bool > &dirichletRows, Teuchos::ArrayRCP< bool > dirichletCols, Teuchos::ArrayRCP< bool > dirichletDomain)
Detects Dirichlet columns & domains from a list of Dirichlet rows.
#define MueLu_sumAll(rcpComm, in, out)
Array< T > & append(const T &x)
virtual int getSize() const =0
MueLu::DefaultLocalOrdinal LocalOrdinal
void ApplyRowSumCriterion(const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const typename Teuchos::ScalarTraits< Scalar >::magnitudeType rowSumTol, Kokkos::View< bool *, memory_space > &dirichletRows)
virtual LO getBlockSize() const override
static bool MapsAreNested(const Xpetra::Map< LocalOrdinal, GlobalOrdinal, Node > &rowMap, const Xpetra::Map< LocalOrdinal, GlobalOrdinal, Node > &colMap)
static RCP< Xpetra::Vector< LocalOrdinal, LocalOrdinal, GlobalOrdinal, Node > > ReverseCuthillMcKee(const Matrix &Op)
static void FindDirichletRowsAndPropagateToCols(Teuchos::RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >> &A, Teuchos::RCP< Xpetra::Vector< int, LocalOrdinal, GlobalOrdinal, Node >> &isDirichletRow, Teuchos::RCP< Xpetra::Vector< int, LocalOrdinal, GlobalOrdinal, Node >> &isDirichletCol)
virtual int getRank() const =0
static void ApplyRowSumCriterionHost(const Matrix &A, const typename Teuchos::ScalarTraits< Scalar >::magnitudeType rowSumTol, Kokkos::View< bool *, Kokkos::HostSpace > &dirichletRows)
static Teuchos::RCP< MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > Build(const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node >> &map, size_t NumVectors, bool zeroOut=true)
static magnitudeType eps()
Teuchos::RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > removeSmallEntries(Teuchos::RCP< Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >> &A, const typename Teuchos::ScalarTraits< Scalar >::magnitudeType threshold, const bool keepDiagonal)
static Scalar PowerMethod(const Matrix &A, bool scaleByDiag=true, LocalOrdinal niters=10, Magnitude tolerance=1e-2, bool verbose=false, unsigned int seed=123)
Power method.
static void ApplyRowSumCriterion(const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Magnitude rowSumTol, Teuchos::ArrayRCP< bool > &dirichletRows)
Apply Rowsum Criterion.
#define TEUCHOS_TEST_FOR_EXCEPTION(throw_exception_test, Exception, msg)
static RCP< Vector > GetMatrixOverlappedDeletedRowsum(const Matrix &A)
Extract Overlapped Matrix Deleted Rowsum.
virtual const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getRowMap() const =0
static RCP< Xpetra::CrsGraph< LocalOrdinal, GlobalOrdinal, Node > > GetThresholdedGraph(const RCP< Matrix > &A, const Magnitude threshold, const GlobalOrdinal expectedNNZperRow=-1)
Threshold a graph.
virtual void resumeFill(const RCP< ParameterList > ¶ms=null)=0
static void ZeroDirichletRows(Teuchos::RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >> &A, const std::vector< LocalOrdinal > &dirichletRows, Scalar replaceWith=Teuchos::ScalarTraits< Scalar >::zero())
static RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > ReplaceNonZerosWithOnes(const RCP< Matrix > &original)
Creates a copy of a matrix where the non-zero entries are replaced by ones.
size_t getLocalNumRows() const override
Exception throws to report incompatible objects (like maps).
static void SetRandomSeed(const Teuchos::Comm< int > &comm)
Set seed for random number generator.
static RCP< Xpetra::Vector< LocalOrdinal, LocalOrdinal, GlobalOrdinal, Node > > CuthillMcKee(const Matrix &Op)
virtual Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getTargetMap() const =0
static RCP< Time > getNewTimer(const std::string &name)
void resize(const size_type n, const T &val=T())
virtual void fillComplete(const RCP< const Map > &domainMap, const RCP< const Map > &rangeMap, const RCP< ParameterList > ¶ms=null)=0
virtual void getLocalDiagCopy(Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &diag) const =0
static RCP< MultiVector > Residual(const Xpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > &Op, const MultiVector &X, const MultiVector &RHS)
static Teuchos::ArrayRCP< const bool > DetectDirichletCols(const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Teuchos::ArrayRCP< const bool > &dirichletRows)
Detect Dirichlet columns based on Dirichlet rows.
virtual void getLocalRowView(LocalOrdinal LocalRow, ArrayView< const LocalOrdinal > &indices, ArrayView< const Scalar > &values) const =0
static void FindDirichletRows(Teuchos::RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >> &A, std::vector< LocalOrdinal > &dirichletRows, bool count_twos_as_dirichlet=false)
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)
MueLu::DefaultScalar Scalar
Kokkos::View< bool *, memory_space > DetectDirichletRows_kokkos(const Xpetra::Matrix< SC, LO, GO, NO > &A, const typename Teuchos::ScalarTraits< SC >::magnitudeType &tol, const bool count_twos_as_dirichlet)
MueLu::DefaultGlobalOrdinal GlobalOrdinal
static RCP< CrsMatrixWrap > GetThresholdedMatrix(const RCP< Matrix > &Ain, const Magnitude threshold, const bool keepDiagonal=true, const GlobalOrdinal expectedNNZperRow=-1)
Threshold a matrix.
static Teuchos::RCP< Map< LocalOrdinal, GlobalOrdinal, Node > > Build(UnderlyingLib lib, global_size_t numGlobalElements, GlobalOrdinal indexBase, const Teuchos::RCP< const Teuchos::Comm< int >> &comm, LocalGlobal lg=Xpetra::GloballyDistributed)
static Teuchos::ArrayRCP< const bool > DetectDirichletRows(const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Magnitude &tol=Teuchos::ScalarTraits< Magnitude >::zero(), bool count_twos_as_dirichlet=false)
Detect Dirichlet rows.
virtual bool isFillComplete() const =0
static RCP< Xpetra::Vector< Magnitude, LocalOrdinal, GlobalOrdinal, Node > > GetMatrixOverlappedAbsDeletedRowsum(const Matrix &A)
size_t getNumMaps() const
virtual void replaceLocalValues(LocalOrdinal localRow, const ArrayView< const LocalOrdinal > &cols, const ArrayView< const Scalar > &vals)=0
static Teuchos::ArrayRCP< Scalar > GetMatrixDiagonal_arcp(const Matrix &A)
Extract Matrix Diagonal.
virtual Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getMap() const =0
static RCP< const Xpetra::BlockedMap< LocalOrdinal, GlobalOrdinal, Node > > GeneratedBlockedTargetMap(const Xpetra::BlockedMap< LocalOrdinal, GlobalOrdinal, Node > &sourceBlockedMap, const Xpetra::Import< LocalOrdinal, GlobalOrdinal, Node > &Importer)
static RCP< Vector > GetMatrixOverlappedDiagonal(const Matrix &A)
Extract Overlapped Matrix Diagonal.
Teuchos::ScalarTraits< Scalar >::magnitudeType Magnitude
virtual size_t getNumEntriesInLocalRow(LocalOrdinal localRow) const =0
static RCP< Vector > GetMatrixDiagonalInverse(const Matrix &A, Magnitude tol=Teuchos::ScalarTraits< Scalar >::eps()*100, Scalar valReplacement=Teuchos::ScalarTraits< Scalar >::zero(), const bool doLumped=false)
Extract Matrix Diagonal.
static void seedrandom(unsigned int s)
static Teuchos::ArrayRCP< const bool > DetectDirichletRowsExt(const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, bool &bHasZeroDiagonal, const Magnitude &tol=Teuchos::ScalarTraits< Scalar >::zero())
Detect Dirichlet rows (extended version)
static RCP< Vector > Build(const Teuchos::RCP< const Map > &map, bool zeroOut=true)
const RCP< const Xpetra::Map< LocalOrdinal, GlobalOrdinal, Node > > getMap(size_t i, bool bThyraMode=false) const
virtual UnderlyingLib lib() const
static magnitudeType magnitude(T a)
void push_back(const value_type &x)
virtual RCP< const CrsGraph > getCrsGraph() const =0
static Teuchos::Array< Magnitude > ResidualNorm(const Xpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > &Op, const MultiVector &X, const MultiVector &RHS)
static void EnforceInitialCondition(const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &RHS, Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &InitialGuess, const Magnitude &tol=Teuchos::ScalarTraits< Magnitude >::zero(), const bool count_twos_as_dirichlet=false)
Detect Dirichlet rows and copy values from RHS multivector to InitialGuess for Dirichlet rows...
impl_scalar_type_dualview::t_dev::const_type getValuesDevice(const LO &lclRow) const
virtual Teuchos::RCP< const Map > getRangeMap() const =0
static RCP< Teuchos::FancyOStream > MakeFancy(std::ostream &os)
static RCP< Matrix > Build(const RCP< const Map > &rowMap, size_t maxNumEntriesPerRow, Xpetra::ProfileType pftype=Xpetra::DynamicProfile)
void residual(const Operator< SC, LO, GO, NO > &Aop, const MultiVector< SC, LO, GO, NO > &X_in, const MultiVector< SC, LO, GO, NO > &B_in, MultiVector< SC, LO, GO, NO > &R_in)
Exception throws to report errors in the internal logical of the program.
static Scalar Frobenius(const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &B)
Frobenius inner product of two matrices.
virtual Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getSourceMap() const =0
#define TEUCHOS_ASSERT(assertion_test)
#define TEUCHOS_ASSERT_EQUALITY(val1, val2)
static Teuchos::RCP< Vector > GetInverse(Teuchos::RCP< const Vector > v, Magnitude tol=Teuchos::ScalarTraits< Scalar >::eps()*100, Scalar valReplacement=Teuchos::ScalarTraits< Scalar >::zero())
Return vector containing inverse of input vector.
static Kokkos::View< bool *, typename Kokkos::HostSpace > DetectDirichletRows_kokkos_host(const Matrix &A, const Magnitude &tol=Teuchos::ScalarTraits< typename Teuchos::ScalarTraits< SC >::magnitudeType >::zero(), const bool count_twos_as_dirichlet=false)
virtual size_t getNumVectors() const =0
static Teuchos::ScalarTraits< Scalar >::magnitudeType Distance2(const Teuchos::Array< Teuchos::ArrayRCP< const Scalar >> &v, LocalOrdinal i0, LocalOrdinal i1)
Squared distance between two rows in a multivector.
static Teuchos::RCP< Vector > GetLumpedMatrixDiagonal(Matrix const &A, const bool doReciprocal=false, Magnitude tol=Teuchos::ScalarTraits< Scalar >::magnitude(Teuchos::ScalarTraits< Scalar >::zero()), Scalar valReplacement=Teuchos::ScalarTraits< Scalar >::zero(), const bool replaceSingleEntryRowWithZero=false, const bool useAverageAbsDiagVal=false)
Extract Matrix Diagonal of lumped matrix.
static Kokkos::View< bool *, typename NO::device_type::memory_space > DetectDirichletRows_kokkos(const Matrix &A, const Magnitude &tol=Teuchos::ScalarTraits< typename Teuchos::ScalarTraits< SC >::magnitudeType >::zero(), const bool count_twos_as_dirichlet=false)
Detect Dirichlet rows.
static RCP< Matrix > Crs2Op(RCP< CrsMatrix > Op)
virtual Teuchos::ArrayRCP< const Scalar > getData(size_t j) const =0
virtual Teuchos::RCP< const Map > getDomainMap() const =0
static RCP< Import< LocalOrdinal, GlobalOrdinal, Node > > Build(const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &source, const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &target, const Teuchos::RCP< Teuchos::ParameterList > &plist=Teuchos::null)