16 #ifndef IFPACK2_ILUK_GRAPH_HPP
17 #define IFPACK2_ILUK_GRAPH_HPP
22 #include "KokkosSparse_spiluk.hpp"
24 #include <Ifpack2_ConfigDefs.hpp>
26 #include <Teuchos_CommHelpers.hpp>
27 #include <Tpetra_CrsGraph.hpp>
28 #include <Tpetra_Details_WrappedDualView.hpp>
29 #include <Tpetra_Import.hpp>
30 #include <Ifpack2_CreateOverlapGraph.hpp>
31 #include <Ifpack2_Parameters.hpp>
66 template <
class GraphType,
class KKHandleType>
69 typedef typename GraphType::local_ordinal_type local_ordinal_type;
70 typedef typename GraphType::global_ordinal_type global_ordinal_type;
71 typedef typename GraphType::node_type node_type;
74 typedef Tpetra::RowGraph<local_ordinal_type,
79 typedef Tpetra::CrsGraph<local_ordinal_type,
84 typedef typename crs_graph_type::nonconst_global_inds_host_view_type nonconst_global_inds_host_view_type;
85 typedef typename crs_graph_type::nonconst_local_inds_host_view_type nonconst_local_inds_host_view_type;
86 typedef typename crs_graph_type::global_inds_host_view_type global_inds_host_view_type;
87 typedef typename crs_graph_type::local_inds_host_view_type local_inds_host_view_type;
102 const int levelOverlap,
103 const double overalloc = 2.);
152 return OverlapGraph_;
159 typedef typename GraphType::map_type map_type;
182 void constructOverlapGraph();
188 const double Overalloc_;
191 size_t NumMyDiagonals_;
192 size_t NumGlobalDiagonals_;
195 template <
class GraphType,
class KKHandleType>
199 const int levelOverlap,
200 const double overalloc)
202 , LevelFill_(levelFill)
203 , LevelOverlap_(levelOverlap)
204 , Overalloc_(overalloc)
206 , NumGlobalDiagonals_(0) {
208 "Ifpack2::IlukGraph: FATAL: overalloc must be greater than 1.")
211 template <
class GraphType,
class KKHandleType>
214 template <
class GraphType,
class KKHandleType>
217 getParameter(parameterlist,
"iluk level-of-fill", LevelFill_);
218 getParameter(parameterlist,
"iluk level-of-overlap", LevelOverlap_);
221 template <
class GraphType,
class KKHandleType>
226 if (OverlapGraph_ == Teuchos::null) {
227 OverlapGraph_ = createOverlapGraph<GraphType>(Graph_, LevelOverlap_);
231 template <
class GraphType,
class KKHandleType>
238 using Teuchos::reduceAll;
240 size_t NumIn, NumL, NumU;
243 constructOverlapGraph();
246 const int MaxNumIndices = OverlapGraph_->getLocalMaxNumRowEntries();
250 const int NumMyRows = OverlapGraph_->getRowMap()->getLocalNumElements();
252 using device_type =
typename node_type::device_type;
253 using execution_space =
typename device_type::execution_space;
254 using dual_view_type = Kokkos::DualView<size_t*, device_type>;
255 dual_view_type numEntPerRow_dv(
"numEntPerRow", NumMyRows);
256 Tpetra::Details::WrappedDualView<dual_view_type> numEntPerRow(numEntPerRow_dv);
258 const auto overalloc = Overalloc_;
259 const auto levelfill = LevelFill_;
262 auto numEntPerRow_d = numEntPerRow.getDeviceView(Tpetra::Access::OverwriteAll);
263 auto localOverlapGraph = OverlapGraph_->getLocalGraphDevice();
264 Kokkos::parallel_for(
265 "CountOverlapGraphRowEntries",
266 Kokkos::RangePolicy<execution_space>(0, NumMyRows),
267 KOKKOS_LAMBDA(
const int i) {
269 int RowMaxNumIndices = localOverlapGraph.rowConst(i).length;
270 numEntPerRow_d(i) = (levelfill == 0) ? RowMaxNumIndices
271 : Kokkos::ceil(static_cast<double>(RowMaxNumIndices) * Kokkos::pow(overalloc, levelfill));
280 OverlapGraph_->getRowMap(),
283 OverlapGraph_->getRowMap(),
286 Array<local_ordinal_type> L(MaxNumIndices);
287 Array<local_ordinal_type> U(MaxNumIndices);
293 for (
int i = 0; i < NumMyRows; ++i) {
294 local_inds_host_view_type my_indices;
295 OverlapGraph_->getLocalRowView(i, my_indices);
302 NumIn = my_indices.size();
304 for (
size_t j = 0; j < NumIn; ++j) {
305 const local_ordinal_type k = my_indices[j];
327 L_Graph_->insertLocalIndices(i, NumL, L.data());
330 U_Graph_->insertLocalIndices(i, NumU, U.data());
334 if (LevelFill_ > 0) {
336 RCP<const map_type> L_DomainMap = OverlapGraph_->getRowMap();
337 RCP<const map_type> L_RangeMap = Graph_->getRangeMap();
338 RCP<const map_type> U_DomainMap = Graph_->getDomainMap();
339 RCP<const map_type> U_RangeMap = OverlapGraph_->getRowMap();
340 RCP<Teuchos::ParameterList> params = Teuchos::parameterList();
341 params->set(
"Optimize Storage",
false);
342 L_Graph_->fillComplete(L_DomainMap, L_RangeMap, params);
343 U_Graph_->fillComplete(U_DomainMap, U_RangeMap, params);
344 L_Graph_->resumeFill();
345 U_Graph_->resumeFill();
351 int MaxRC = NumMyRows;
352 std::vector<std::vector<int> > Levels(MaxRC);
353 std::vector<int> LinkList(MaxRC);
354 std::vector<int> CurrentLevel(MaxRC);
355 Array<local_ordinal_type> CurrentRow(MaxRC + 1);
356 std::vector<int> LevelsRowU(MaxRC);
359 for (
int i = 0; i < NumMyRows; ++i) {
364 size_t LenL = L_Graph_->getNumEntriesInLocalRow(i);
365 size_t LenU = U_Graph_->getNumEntriesInLocalRow(i);
366 size_t Len = LenL + LenU + 1;
367 CurrentRow.resize(Len);
368 nonconst_local_inds_host_view_type CurrentRow_view(CurrentRow.data(), CurrentRow.size());
369 L_Graph_->getLocalRowCopy(i, CurrentRow_view, LenL);
370 CurrentRow[LenL] = i;
372 ArrayView<local_ordinal_type> URowView = CurrentRow.
view(LenL + 1, LenU);
373 nonconst_local_inds_host_view_type URowView_v(URowView.data(), URowView.size());
376 U_Graph_->getLocalRowCopy(i, URowView_v, LenU);
381 for (
size_t j = 0; j < Len - 1; j++) {
382 LinkList[CurrentRow[j]] = CurrentRow[j + 1];
383 CurrentLevel[CurrentRow[j]] = 0;
386 LinkList[CurrentRow[Len - 1]] = NumMyRows;
387 CurrentLevel[CurrentRow[Len - 1]] = 0;
391 First = CurrentRow[0];
394 int PrevInList = Next;
395 int NextInList = LinkList[Next];
398 local_inds_host_view_type IndicesU;
399 U_Graph_->getLocalRowView(RowU, IndicesU);
401 int LengthRowU = IndicesU.size();
407 for (ii = 0; ii < LengthRowU; ) {
408 int CurInList = IndicesU[ii];
409 if (CurInList < NextInList) {
411 int NewLevel = CurrentLevel[RowU] + Levels[RowU][ii + 1] + 1;
412 if (NewLevel <= LevelFill_) {
413 LinkList[PrevInList] = CurInList;
414 LinkList[CurInList] = NextInList;
415 PrevInList = CurInList;
416 CurrentLevel[CurInList] = NewLevel;
419 }
else if (CurInList == NextInList) {
420 PrevInList = NextInList;
421 NextInList = LinkList[PrevInList];
422 int NewLevel = CurrentLevel[RowU] + Levels[RowU][ii + 1] + 1;
423 CurrentLevel[CurInList] = std::min(CurrentLevel[CurInList],
427 PrevInList = NextInList;
428 NextInList = LinkList[PrevInList];
431 Next = LinkList[Next];
435 CurrentRow.resize(0);
441 CurrentRow.push_back(Next);
442 Next = LinkList[Next];
448 L_Graph_->removeLocalIndices(i);
449 if (CurrentRow.size() > 0) {
450 L_Graph_->insertLocalIndices(i, CurrentRow.size(), CurrentRow.data());
456 Next != i, std::runtime_error,
457 "Ifpack2::IlukGraph::initialize: FATAL: U has zero diagonal")
459 LevelsRowU[0] = CurrentLevel[Next];
460 Next = LinkList[Next];
463 CurrentRow.resize(0);
466 while (Next < NumMyRows) {
467 LevelsRowU[LenU + 1] = CurrentLevel[Next];
468 CurrentRow.push_back(Next);
470 Next = LinkList[Next];
477 U_Graph_->removeLocalIndices(i);
479 U_Graph_->insertLocalIndices(i, CurrentRow.size(), CurrentRow.data());
483 Levels[i] = std::vector<int>(LenU + 1);
484 for (
size_t jj = 0; jj < LenU + 1; jj++) {
485 Levels[i][jj] = LevelsRowU[jj];
488 }
catch (std::runtime_error& e) {
490 auto numEntPerRow_d = numEntPerRow.getDeviceView(Tpetra::Access::OverwriteAll);
491 Kokkos::parallel_for(
492 "CountOverlapGraphRowEntries",
493 Kokkos::RangePolicy<execution_space>(0, NumMyRows),
494 KOKKOS_LAMBDA(
const int i) {
495 const auto numRowEnt = numEntPerRow_d(i);
496 numEntPerRow_d(i) = ceil(static_cast<double>((numRowEnt != 0 ? numRowEnt : 1)) * overalloc);
499 const int localInsertError = insertError ? 1 : 0;
500 int globalInsertError = 0;
501 reduceAll(*(OverlapGraph_->getRowMap()->getComm()), REDUCE_SUM, 1,
502 &localInsertError, &globalInsertError);
503 insertError = globalInsertError > 0;
505 }
while (insertError);
508 RCP<const map_type> L_DomainMap = OverlapGraph_->getRowMap();
509 RCP<const map_type> L_RangeMap = Graph_->getRangeMap();
510 RCP<const map_type> U_DomainMap = Graph_->getDomainMap();
511 RCP<const map_type> U_RangeMap = OverlapGraph_->getRowMap();
512 L_Graph_->fillComplete(L_DomainMap, L_RangeMap);
513 U_Graph_->fillComplete(U_DomainMap, U_RangeMap);
515 reduceAll<int, size_t>(*(L_DomainMap->getComm()), REDUCE_SUM, 1,
516 &NumMyDiagonals_, &NumGlobalDiagonals_);
519 template <
class GraphType,
class KKHandleType>
526 using Teuchos::reduceAll;
528 typedef typename crs_graph_type::local_graph_device_type local_graph_device_type;
529 typedef typename local_graph_device_type::size_type size_type;
530 typedef typename local_graph_device_type::data_type data_type;
531 typedef typename local_graph_device_type::array_layout array_layout;
532 typedef typename local_graph_device_type::device_type device_type;
534 typedef typename Kokkos::View<size_type*, array_layout, device_type> lno_row_view_t;
535 typedef typename Kokkos::View<data_type*, array_layout, device_type> lno_nonzero_view_t;
537 constructOverlapGraph();
541 const int NumMyRows = OverlapGraph_->getRowMap()->getLocalNumElements();
542 auto localOverlapGraph = OverlapGraph_->getLocalGraphDevice();
544 if (KernelHandle->get_spiluk_handle()->get_nrows() <
static_cast<size_type
>(NumMyRows)) {
545 KernelHandle->get_spiluk_handle()->reset_handle(NumMyRows,
546 KernelHandle->get_spiluk_handle()->get_nnzL(),
547 KernelHandle->get_spiluk_handle()->get_nnzU());
550 lno_row_view_t L_row_map(
"L_row_map", NumMyRows + 1);
551 lno_nonzero_view_t L_entries(
"L_entries", KernelHandle->get_spiluk_handle()->get_nnzL());
552 lno_row_view_t U_row_map(
"U_row_map", NumMyRows + 1);
553 lno_nonzero_view_t U_entries(
"U_entries", KernelHandle->get_spiluk_handle()->get_nnzU());
557 symbolicError =
false;
559 KokkosSparse::spiluk_symbolic(KernelHandle.
getRawPtr(), LevelFill_,
560 localOverlapGraph.row_map, localOverlapGraph.entries,
561 L_row_map, L_entries, U_row_map, U_entries);
562 }
catch (std::runtime_error& e) {
563 symbolicError =
true;
564 data_type nnzL =
static_cast<data_type
>(Overalloc_) * L_entries.extent(0);
565 data_type nnzU =
static_cast<data_type
>(Overalloc_) * U_entries.extent(0);
566 KernelHandle->get_spiluk_handle()->reset_handle(NumMyRows, nnzL, nnzU);
567 Kokkos::resize(L_entries, KernelHandle->get_spiluk_handle()->get_nnzL());
568 Kokkos::resize(U_entries, KernelHandle->get_spiluk_handle()->get_nnzU());
570 const int localSymbolicError = symbolicError ? 1 : 0;
571 int globalSymbolicError = 0;
572 reduceAll(*(OverlapGraph_->getRowMap()->getComm()), REDUCE_SUM, 1,
573 &localSymbolicError, &globalSymbolicError);
574 symbolicError = globalSymbolicError > 0;
575 }
while (symbolicError);
577 Kokkos::resize(L_entries, KernelHandle->get_spiluk_handle()->get_nnzL());
578 Kokkos::resize(U_entries, KernelHandle->get_spiluk_handle()->get_nnzU());
580 RCP<Teuchos::ParameterList> params = Teuchos::parameterList();
581 params->set(
"Optimize Storage",
false);
583 L_Graph_ =
rcp(
new crs_graph_type(OverlapGraph_->getRowMap(),
584 OverlapGraph_->getRowMap(),
585 L_row_map, L_entries));
586 U_Graph_ =
rcp(
new crs_graph_type(OverlapGraph_->getRowMap(),
587 OverlapGraph_->getRowMap(),
588 U_row_map, U_entries));
590 RCP<const map_type> L_DomainMap = OverlapGraph_->getRowMap();
591 RCP<const map_type> L_RangeMap = Graph_->getRangeMap();
592 RCP<const map_type> U_DomainMap = Graph_->getDomainMap();
593 RCP<const map_type> U_RangeMap = OverlapGraph_->getRowMap();
594 L_Graph_->fillComplete(L_DomainMap, L_RangeMap, params);
595 U_Graph_->fillComplete(U_DomainMap, U_RangeMap, params);
IlukGraph(const Teuchos::RCP< const GraphType > &G, const int levelFill, const int levelOverlap, const double overalloc=2.)
Constructor.
Definition: Ifpack2_IlukGraph.hpp:197
Teuchos::RCP< const GraphType > getA_Graph() const
Returns the original graph given.
Definition: Ifpack2_IlukGraph.hpp:136
#define TEUCHOS_TEST_FOR_EXCEPTION(throw_exception_test, Exception, msg)
void getParameter(const Teuchos::ParameterList ¶ms, const std::string &name, T &value)
Set a value from a ParameterList if a parameter with the specified name exists.
Definition: Ifpack2_Parameters.hpp:26
size_t getNumGlobalDiagonals() const
Returns the global number of diagonals in the ILU(k) graph.
Definition: Ifpack2_IlukGraph.hpp:156
virtual ~IlukGraph()
IlukGraph Destructor.
Definition: Ifpack2_IlukGraph.hpp:212
Tpetra::CrsGraph< local_ordinal_type, global_ordinal_type, node_type > crs_graph_type
Tpetra::CrsGraph specialization used by this class.
Definition: Ifpack2_IlukGraph.hpp:82
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)
Teuchos::RCP< const crs_graph_type > getOverlapGraph() const
Returns the the overlapped graph.
Definition: Ifpack2_IlukGraph.hpp:151
Construct a level filled graph for use in computing an ILU(k) incomplete factorization.
Definition: Ifpack2_IlukGraph.hpp:67
Teuchos::RCP< crs_graph_type > getU_Graph() const
Returns the graph of upper triangle of the ILU(k) graph as a Tpetra::CrsGraph.
Definition: Ifpack2_IlukGraph.hpp:146
Teuchos::RCP< crs_graph_type > getL_Graph() const
Returns the graph of lower triangle of the ILU(k) graph as a Tpetra::CrsGraph.
Definition: Ifpack2_IlukGraph.hpp:141
void initialize()
Set up the graph structure of the L and U factors.
Definition: Ifpack2_IlukGraph.hpp:232
int getLevelFill() const
The level of fill used to construct this graph.
Definition: Ifpack2_IlukGraph.hpp:130
ArrayView< T > view(size_type offset, size_type size) const
int getLevelOverlap() const
The level of overlap used to construct this graph.
Definition: Ifpack2_IlukGraph.hpp:133
Tpetra::RowGraph< local_ordinal_type, global_ordinal_type, node_type > row_graph_type
Tpetra::RowGraph specialization used by this class.
Definition: Ifpack2_IlukGraph.hpp:77
void setParameters(const Teuchos::ParameterList ¶meterlist)
Set parameters.
Definition: Ifpack2_IlukGraph.hpp:216