diff --git a/packages/kokkos-kernels/src/graph/KokkosGraph_Distance1ColorHandle.hpp b/packages/kokkos-kernels/src/graph/KokkosGraph_Distance1ColorHandle.hpp index b7003d4a1ab6..eb4f6768e7df 100644 --- a/packages/kokkos-kernels/src/graph/KokkosGraph_Distance1ColorHandle.hpp +++ b/packages/kokkos-kernels/src/graph/KokkosGraph_Distance1ColorHandle.hpp @@ -521,13 +521,7 @@ class GraphColoringHandle vector_size, nv, ne); - team_policy_t tmp_policy(nv, Kokkos::AUTO, vector_size); - int max_allowed_team_size = tmp_policy.team_size_max( clt, Kokkos::ParallelForTag() ); - - KokkosKernels::Impl::get_suggested_team_size( - max_allowed_team_size, - vector_size, - teamSizeMax); + teamSizeMax = KokkosKernels::Impl::get_suggested_team_size(clt, vector_size); #endif Kokkos::parallel_for("KokkosGraph::CountLowerTriangleTeam", diff --git a/packages/kokkos-kernels/unit_test/blas/Test_Blas3_gemm.hpp b/packages/kokkos-kernels/unit_test/blas/Test_Blas3_gemm.hpp index 66ef713e6a44..07e029fd42a7 100644 --- a/packages/kokkos-kernels/unit_test/blas/Test_Blas3_gemm.hpp +++ b/packages/kokkos-kernels/unit_test/blas/Test_Blas3_gemm.hpp @@ -106,9 +106,23 @@ namespace Test { Kokkos::Random_XorShift64_Pool rand_pool(seed); // (SA 11 Dec 2019) Max (previously: 10) increased to detect the bug in Trilinos issue #6418 - Kokkos::fill_random(A,rand_pool, Kokkos::rand::generator_type,ScalarA>::max()); - Kokkos::fill_random(B,rand_pool, Kokkos::rand::generator_type,ScalarB>::max()); - Kokkos::fill_random(C,rand_pool, Kokkos::rand::generator_type,ScalarC>::max()); + // Revisit this to address issues with complex types +/* +#ifdef KOKKOS_ENABLE_CUDA + if (std::is_same::value) + { + Kokkos::fill_random(A,rand_pool, Kokkos::rand::generator_type,ScalarA>::max()); + Kokkos::fill_random(B,rand_pool, Kokkos::rand::generator_type,ScalarB>::max()); + Kokkos::fill_random(C,rand_pool, Kokkos::rand::generator_type,ScalarC>::max()); + } + else +#endif +*/ + { + Kokkos::fill_random(A,rand_pool,ScalarA(10)); + Kokkos::fill_random(B,rand_pool,ScalarB(10)); + Kokkos::fill_random(C,rand_pool,ScalarC(10)); + } Kokkos::deep_copy(C2,C); diff --git a/packages/muelu/test/interface/ParameterListInterpreter.cpp b/packages/muelu/test/interface/ParameterListInterpreter.cpp index e6de48a0772b..50bba302e733 100644 --- a/packages/muelu/test/interface/ParameterListInterpreter.cpp +++ b/packages/muelu/test/interface/ParameterListInterpreter.cpp @@ -221,13 +221,10 @@ int main_(Teuchos::CommandLineProcessor &clp, Xpetra::UnderlyingLib& lib, int ar continue; } - std::filebuf buffer; + std::stringbuf buffer; std::streambuf* oldbuffer = NULL; - if (myRank == 0) { - // Redirect output - buffer.open((baseFile + ".out").c_str(), std::ios::out); - oldbuffer = std::cout.rdbuf(&buffer); - } + // // Redirect output + oldbuffer = std::cout.rdbuf(&buffer); // NOTE: we cannot use ParameterListInterpreter(xmlFile, comm), because we want to update the ParameterList // first to include "test" verbosity @@ -295,18 +292,14 @@ int main_(Teuchos::CommandLineProcessor &clp, Xpetra::UnderlyingLib& lib, int ar } timer.stop(); + } catch (Teuchos::ExceptionBase& e) { std::string msg = e.what(); msg = msg.substr(msg.find_last_of('\n')+1); - if (myRank == 0) { + if (myRank == 0) std::cout << "Caught exception: " << msg << std::endl; - // Redirect output back - std::cout.rdbuf(oldbuffer); - buffer.close(); - } - if (msg == "Zoltan interface is not available" || msg == "Zoltan2 interface is not available" || msg == "MueLu::FactoryFactory:BuildFactory(): Cannot create a Zoltan2Interface object: Zoltan2 is disabled: HAVE_MUELU_ZOLTAN2 && HAVE_MPI == false.") { @@ -318,12 +311,27 @@ int main_(Teuchos::CommandLineProcessor &clp, Xpetra::UnderlyingLib& lib, int ar } } + // Redirect output back + std::cout.rdbuf(oldbuffer); +#ifdef HAVE_MPI + std::string logStr = buffer.str(); + RCP > mpiComm = Teuchos::rcp_dynamic_cast >(comm)->getRawMpiComm(); + MPI_File logfile; + MPI_File_open((*mpiComm)(), (baseFile + ".out").c_str(), MPI_MODE_WRONLY | MPI_MODE_CREATE, MPI_INFO_NULL, &logfile); + MPI_File_set_atomicity(logfile, true); + const char* msg = logStr.c_str(); + int err = MPI_File_write_ordered(logfile, msg, logStr.size(), MPI_CHAR, MPI_STATUS_IGNORE); + TEUCHOS_ASSERT(err == MPI_SUCCESS); + MPI_File_close(&logfile); +#else + std::ofstream outStream; + outStream.open((baseFile + ".out").c_str(), std::ofstream::out); + outStream << buffer.str(); + outStream.close(); +#endif + std::string cmd; if (myRank == 0) { - // Redirect output back - std::cout.rdbuf(oldbuffer); - buffer.close(); - // Create a copy of outputs cmd = "cp -f "; system((cmd + baseFile + ".gold " + baseFile + ".gold_filtered").c_str()); diff --git a/packages/muelu/test/interface/complex/Output/driver_drekar1_np4_tpetra.gold b/packages/muelu/test/interface/complex/Output/driver_drekar1_np4_tpetra.gold index a601e454369a..e301177cbd40 100644 --- a/packages/muelu/test/interface/complex/Output/driver_drekar1_np4_tpetra.gold +++ b/packages/muelu/test/interface/complex/Output/driver_drekar1_np4_tpetra.gold @@ -176,3 +176,315 @@ Smoother (level 2) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 3) pre : solver interface Smoother (level 3) post : no smoother +Setup Smoother (MueLu::Ifpack2Smoother{type = RELAXATION}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + relaxation: type = Symmetric Gauss-Seidel + relaxation: sweeps = 2 + relaxation: damping factor = 1 [default] + relaxation: zero starting solution = 1 [default] + relaxation: backward mode = 0 [default] + relaxation: use l1 = 0 [default] + relaxation: l1 eta = 1.5 [default] + relaxation: min diagonal value = 0 [default] + relaxation: fix tiny diagonal entries = 0 [default] + relaxation: check diagonal entries = 0 [default] + relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] + relaxation: symmetric matrix structure = 0 [default] + relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] + +Level 2 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Matrix filtering (MueLu::FilteredAFactory) +Build (MueLu::CoalesceDropFactory) +Build (MueLu::AmalgamationFactory) +[empty list] + +algorithm = "distance laplacian": threshold = (0,0), blocksize = 1 +aggregation: drop tol = 0 [default] +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +lightweight wrap = 1 + +Filtered matrix is not being constructed as no filtering is being done +filtered matrix: use lumping = 1 [unused] +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] + +Build (MueLu::TentativePFactory) +Build (MueLu::UncoupledAggregationFactory) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregates (Phase 1 (main)) +BuildAggregates (Phase 2a (secondary)) +BuildAggregates (Phase 2b (expansion)) +BuildAggregates (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +aggregation: use interface aggregation = 0 [default] +aggregation: error on nodes with no on-rank neighbors = 0 [default] +aggregation: phase3 avoid singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] +Interface aggregate map name = [default] +Interface aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory) +Striding info = {} [default] +Strided block id = -1 [default] +Domain GID offsets = {0} [default] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Ifpack2Smoother{type = RELAXATION}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + relaxation: type = Symmetric Gauss-Seidel + relaxation: sweeps = 2 + relaxation: damping factor = 1 [default] + relaxation: zero starting solution = 1 [default] + relaxation: backward mode = 0 [default] + relaxation: use l1 = 0 [default] + relaxation: l1 eta = 1.5 [default] + relaxation: min diagonal value = 0 [default] + relaxation: fix tiny diagonal entries = 0 [default] + relaxation: check diagonal entries = 0 [default] + relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] + relaxation: symmetric matrix structure = 0 [default] + relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] + +Level 3 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Matrix filtering (MueLu::FilteredAFactory) +Build (MueLu::CoalesceDropFactory) +Build (MueLu::AmalgamationFactory) +[empty list] + +algorithm = "distance laplacian": threshold = (0,0), blocksize = 1 +aggregation: drop tol = 0 [default] +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +lightweight wrap = 1 + +Filtered matrix is not being constructed as no filtering is being done +filtered matrix: use lumping = 1 [unused] +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] + +Build (MueLu::TentativePFactory) +Build (MueLu::UncoupledAggregationFactory) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregates (Phase 1 (main)) +BuildAggregates (Phase 2a (secondary)) +BuildAggregates (Phase 2b (expansion)) +BuildAggregates (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +aggregation: use interface aggregation = 0 [default] +aggregation: error on nodes with no on-rank neighbors = 0 [default] +aggregation: phase3 avoid singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] +Interface aggregate map name = [default] +Interface aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory) +Striding info = {} [default] +Strided block id = -1 [default] +Domain GID offsets = {0} [default] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Max coarse size (<= 1000) achieved +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/complex/Output/driver_drekar2_np4_tpetra.gold b/packages/muelu/test/interface/complex/Output/driver_drekar2_np4_tpetra.gold index 7eb6630a7864..bcf58e85e100 100644 --- a/packages/muelu/test/interface/complex/Output/driver_drekar2_np4_tpetra.gold +++ b/packages/muelu/test/interface/complex/Output/driver_drekar2_np4_tpetra.gold @@ -176,3 +176,315 @@ Smoother (level 2) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 3) pre : solver interface Smoother (level 3) post : no smoother +Setup Smoother (MueLu::Ifpack2Smoother{type = RELAXATION}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + relaxation: type = Symmetric Gauss-Seidel + relaxation: sweeps = 2 + relaxation: damping factor = 1 [default] + relaxation: zero starting solution = 1 [default] + relaxation: backward mode = 0 [default] + relaxation: use l1 = 0 [default] + relaxation: l1 eta = 1.5 [default] + relaxation: min diagonal value = 0 [default] + relaxation: fix tiny diagonal entries = 0 [default] + relaxation: check diagonal entries = 0 [default] + relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] + relaxation: symmetric matrix structure = 0 [default] + relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] + +Level 2 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Matrix filtering (MueLu::FilteredAFactory) +Build (MueLu::CoalesceDropFactory) +Build (MueLu::AmalgamationFactory) +[empty list] + +algorithm = "distance laplacian": threshold = (0.02,0), blocksize = 1 +aggregation: drop tol = 0.02 +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +lightweight wrap = 1 + +Lumping dropped entries +filtered matrix: use lumping = 1 +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] + +Build (MueLu::TentativePFactory) +Build (MueLu::UncoupledAggregationFactory) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregates (Phase 1 (main)) +BuildAggregates (Phase 2a (secondary)) +BuildAggregates (Phase 2b (expansion)) +BuildAggregates (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +aggregation: use interface aggregation = 0 [default] +aggregation: error on nodes with no on-rank neighbors = 0 [default] +aggregation: phase3 avoid singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] +Interface aggregate map name = [default] +Interface aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory) +Striding info = {} [default] +Strided block id = -1 [default] +Domain GID offsets = {0} [default] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Ifpack2Smoother{type = RELAXATION}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + relaxation: type = Symmetric Gauss-Seidel + relaxation: sweeps = 2 + relaxation: damping factor = 1 [default] + relaxation: zero starting solution = 1 [default] + relaxation: backward mode = 0 [default] + relaxation: use l1 = 0 [default] + relaxation: l1 eta = 1.5 [default] + relaxation: min diagonal value = 0 [default] + relaxation: fix tiny diagonal entries = 0 [default] + relaxation: check diagonal entries = 0 [default] + relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] + relaxation: symmetric matrix structure = 0 [default] + relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] + +Level 3 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Matrix filtering (MueLu::FilteredAFactory) +Build (MueLu::CoalesceDropFactory) +Build (MueLu::AmalgamationFactory) +[empty list] + +algorithm = "distance laplacian": threshold = (0.02,0), blocksize = 1 +aggregation: drop tol = 0.02 +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +lightweight wrap = 1 + +Lumping dropped entries +filtered matrix: use lumping = 1 +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] + +Build (MueLu::TentativePFactory) +Build (MueLu::UncoupledAggregationFactory) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregates (Phase 1 (main)) +BuildAggregates (Phase 2a (secondary)) +BuildAggregates (Phase 2b (expansion)) +BuildAggregates (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +aggregation: use interface aggregation = 0 [default] +aggregation: error on nodes with no on-rank neighbors = 0 [default] +aggregation: phase3 avoid singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] +Interface aggregate map name = [default] +Interface aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory) +Striding info = {} [default] +Strided block id = -1 [default] +Domain GID offsets = {0} [default] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Max coarse size (<= 1000) achieved +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/complex/Output/repartition1_np4_tpetra.gold b/packages/muelu/test/interface/complex/Output/repartition1_np4_tpetra.gold index d0e7db272688..4829adcae7c9 100644 --- a/packages/muelu/test/interface/complex/Output/repartition1_np4_tpetra.gold +++ b/packages/muelu/test/interface/complex/Output/repartition1_np4_tpetra.gold @@ -324,3 +324,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/complex/Output/reuse-RAP-1_np4_tpetra.gold b/packages/muelu/test/interface/complex/Output/reuse-RAP-1_np4_tpetra.gold index 96ac995e188f..43b70dbeeaa3 100644 --- a/packages/muelu/test/interface/complex/Output/reuse-RAP-1_np4_tpetra.gold +++ b/packages/muelu/test/interface/complex/Output/reuse-RAP-1_np4_tpetra.gold @@ -367,3 +367,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/complex/Output/reuse-RAP-2_np4_tpetra.gold b/packages/muelu/test/interface/complex/Output/reuse-RAP-2_np4_tpetra.gold index 17245b54cb3a..9a6d7e5d6eea 100644 --- a/packages/muelu/test/interface/complex/Output/reuse-RAP-2_np4_tpetra.gold +++ b/packages/muelu/test/interface/complex/Output/reuse-RAP-2_np4_tpetra.gold @@ -341,3 +341,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/complex/Output/reuse-RP-2_np4_tpetra.gold b/packages/muelu/test/interface/complex/Output/reuse-RP-2_np4_tpetra.gold index ca2eeed76d79..7d98ca018caa 100644 --- a/packages/muelu/test/interface/complex/Output/reuse-RP-2_np4_tpetra.gold +++ b/packages/muelu/test/interface/complex/Output/reuse-RP-2_np4_tpetra.gold @@ -436,3 +436,59 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Computing Ac (MueLu::RAPFactory) +Reusing previous AP data +Reusing previous RAP data +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +Reusing coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 1 +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother ( solver interface) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/complex/Output/reuse-S-1_np4_tpetra.gold b/packages/muelu/test/interface/complex/Output/reuse-S-1_np4_tpetra.gold index 91531fdf2b71..5bdb98b35f51 100644 --- a/packages/muelu/test/interface/complex/Output/reuse-S-1_np4_tpetra.gold +++ b/packages/muelu/test/interface/complex/Output/reuse-S-1_np4_tpetra.gold @@ -646,3 +646,102 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Build (MueLu::TentativePFactory) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +repartition: rebalance P and R = 1 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +repartition: rebalance P and R = 1 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother ( solver interface) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/complex/Output/reuse-full-1_np4_tpetra.gold b/packages/muelu/test/interface/complex/Output/reuse-full-1_np4_tpetra.gold index aab3abeb0f61..2a945f17cca7 100644 --- a/packages/muelu/test/interface/complex/Output/reuse-full-1_np4_tpetra.gold +++ b/packages/muelu/test/interface/complex/Output/reuse-full-1_np4_tpetra.gold @@ -347,3 +347,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/complex/Output/reuse-none_np4_tpetra.gold b/packages/muelu/test/interface/complex/Output/reuse-none_np4_tpetra.gold index 45611805a695..02e1f61570e4 100644 --- a/packages/muelu/test/interface/complex/Output/reuse-none_np4_tpetra.gold +++ b/packages/muelu/test/interface/complex/Output/reuse-none_np4_tpetra.gold @@ -650,3 +650,104 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Build (MueLu::TentativePFactory) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/complex/Output/reuse-tP-1_np4_tpetra.gold b/packages/muelu/test/interface/complex/Output/reuse-tP-1_np4_tpetra.gold index 3047f352e398..2e5ad2bd0109 100644 --- a/packages/muelu/test/interface/complex/Output/reuse-tP-1_np4_tpetra.gold +++ b/packages/muelu/test/interface/complex/Output/reuse-tP-1_np4_tpetra.gold @@ -540,3 +540,81 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Prolongator smoothing (MueLu::SaPFactory) +Reusing previous AP data +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +Using original restrictor +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Computing Ac (MueLu::RAPFactory) +Reusing previous AP data +Reusing previous RAP data +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +Reusing coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother ( solver interface) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/complex/Output/reuse-tP-2_np4_tpetra.gold b/packages/muelu/test/interface/complex/Output/reuse-tP-2_np4_tpetra.gold index 2f7f53068cd7..1e1d2fff39b6 100644 --- a/packages/muelu/test/interface/complex/Output/reuse-tP-2_np4_tpetra.gold +++ b/packages/muelu/test/interface/complex/Output/reuse-tP-2_np4_tpetra.gold @@ -592,3 +592,104 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Build (MueLu::TentativePFactory) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/complex/Output/reuse-tP-3_np4_tpetra.gold b/packages/muelu/test/interface/complex/Output/reuse-tP-3_np4_tpetra.gold index a7080ca513d2..48e585695a11 100644 --- a/packages/muelu/test/interface/complex/Output/reuse-tP-3_np4_tpetra.gold +++ b/packages/muelu/test/interface/complex/Output/reuse-tP-3_np4_tpetra.gold @@ -595,3 +595,104 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Build (MueLu::TentativePFactory) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/complex/Output/transpose2_np4_tpetra.gold b/packages/muelu/test/interface/complex/Output/transpose2_np4_tpetra.gold index 0004297addc0..e323dc4551cf 100644 --- a/packages/muelu/test/interface/complex/Output/transpose2_np4_tpetra.gold +++ b/packages/muelu/test/interface/complex/Output/transpose2_np4_tpetra.gold @@ -296,3 +296,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/complex/Output/transpose3_np4_tpetra.gold b/packages/muelu/test/interface/complex/Output/transpose3_np4_tpetra.gold index a66a9f5a3b71..d31d4ed20b33 100644 --- a/packages/muelu/test/interface/complex/Output/transpose3_np4_tpetra.gold +++ b/packages/muelu/test/interface/complex/Output/transpose3_np4_tpetra.gold @@ -296,3 +296,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/default/Output/driver_drekar1_np4_epetra.gold b/packages/muelu/test/interface/default/Output/driver_drekar1_np4_epetra.gold index 2d834f371202..e97d4448bace 100644 --- a/packages/muelu/test/interface/default/Output/driver_drekar1_np4_epetra.gold +++ b/packages/muelu/test/interface/default/Output/driver_drekar1_np4_epetra.gold @@ -167,3 +167,295 @@ Smoother (level 2) both : MueLu::IfpackSmoother{type = Chebyshev} Smoother (level 3) pre : MueLu::AmesosSmoother{type = } Smoother (level 3) post : no smoother +Setup Smoother (MueLu::IfpackSmoother{type = Chebyshev}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + chebyshev: degree = 2 + chebyshev: ratio eigenvalue = 20 [unused] + chebyshev: min eigenvalue = 1 + chebyshev: zero starting solution = 1 + chebyshev: eigenvalue max iterations = 10 + +Level 2 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Matrix filtering (MueLu::FilteredAFactory) +Build (MueLu::CoalesceDropFactory) +Build (MueLu::AmalgamationFactory) +[empty list] + +algorithm = "distance laplacian": threshold = 0, blocksize = 1 +aggregation: drop tol = 0 [default] +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +lightweight wrap = 1 + +Filtered matrix is not being constructed as no filtering is being done +filtered matrix: use lumping = 1 [unused] +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] + +Build (MueLu::TentativePFactory) +Build (MueLu::UncoupledAggregationFactory) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregates (Phase 1 (main)) +BuildAggregates (Phase 2a (secondary)) +BuildAggregates (Phase 2b (expansion)) +BuildAggregates (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +aggregation: use interface aggregation = 0 [default] +aggregation: error on nodes with no on-rank neighbors = 0 [default] +aggregation: phase3 avoid singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] +Interface aggregate map name = [default] +Interface aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory) +Striding info = {} [default] +Strided block id = -1 [default] +Domain GID offsets = {0} [default] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::IfpackSmoother{type = Chebyshev}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + chebyshev: degree = 2 + chebyshev: ratio eigenvalue = 20 [unused] + chebyshev: min eigenvalue = 1 + chebyshev: zero starting solution = 1 + chebyshev: eigenvalue max iterations = 10 + +Level 3 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Matrix filtering (MueLu::FilteredAFactory) +Build (MueLu::CoalesceDropFactory) +Build (MueLu::AmalgamationFactory) +[empty list] + +algorithm = "distance laplacian": threshold = 0, blocksize = 1 +aggregation: drop tol = 0 [default] +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +lightweight wrap = 1 + +Filtered matrix is not being constructed as no filtering is being done +filtered matrix: use lumping = 1 [unused] +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] + +Build (MueLu::TentativePFactory) +Build (MueLu::UncoupledAggregationFactory) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregates (Phase 1 (main)) +BuildAggregates (Phase 2a (secondary)) +BuildAggregates (Phase 2b (expansion)) +BuildAggregates (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +aggregation: use interface aggregation = 0 [default] +aggregation: error on nodes with no on-rank neighbors = 0 [default] +aggregation: phase3 avoid singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] +Interface aggregate map name = [default] +Interface aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory) +Striding info = {} [default] +Strided block id = -1 [default] +Domain GID offsets = {0} [default] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Max coarse size (<= 1000) achieved +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + diff --git a/packages/muelu/test/interface/default/Output/driver_drekar1_np4_tpetra.gold b/packages/muelu/test/interface/default/Output/driver_drekar1_np4_tpetra.gold index 704c8a342fb7..e593f969c372 100644 --- a/packages/muelu/test/interface/default/Output/driver_drekar1_np4_tpetra.gold +++ b/packages/muelu/test/interface/default/Output/driver_drekar1_np4_tpetra.gold @@ -170,3 +170,303 @@ Smoother (level 2) both : "Ifpack2::Chebyshev": {Initialized: true, Computed: tr Smoother (level 3) pre : solver interface Smoother (level 3) post : no smoother +Setup Smoother (MueLu::Ifpack2Smoother{type = CHEBYSHEV}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + chebyshev: degree = 2 + chebyshev: ratio eigenvalue = 20 + chebyshev: min eigenvalue = 1 + chebyshev: zero starting solution = 1 + chebyshev: eigenvalue max iterations = 10 + chebyshev: boost factor = 1.1 [unused] + chebyshev: min diagonal value = 2.22045e-16 [default] + chebyshev: assume matrix does not change = 0 [default] + +Level 2 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Matrix filtering (MueLu::FilteredAFactory) +Build (MueLu::CoalesceDropFactory) +Build (MueLu::AmalgamationFactory) +[empty list] + +algorithm = "distance laplacian": threshold = 0, blocksize = 1 +aggregation: drop tol = 0 [default] +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +lightweight wrap = 1 + +Filtered matrix is not being constructed as no filtering is being done +filtered matrix: use lumping = 1 [unused] +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] + +Build (MueLu::TentativePFactory) +Build (MueLu::UncoupledAggregationFactory) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregates (Phase 1 (main)) +BuildAggregates (Phase 2a (secondary)) +BuildAggregates (Phase 2b (expansion)) +BuildAggregates (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +aggregation: use interface aggregation = 0 [default] +aggregation: error on nodes with no on-rank neighbors = 0 [default] +aggregation: phase3 avoid singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] +Interface aggregate map name = [default] +Interface aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory) +Striding info = {} [default] +Strided block id = -1 [default] +Domain GID offsets = {0} [default] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Ifpack2Smoother{type = CHEBYSHEV}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + chebyshev: degree = 2 + chebyshev: ratio eigenvalue = 20 + chebyshev: min eigenvalue = 1 + chebyshev: zero starting solution = 1 + chebyshev: eigenvalue max iterations = 10 + chebyshev: boost factor = 1.1 [unused] + chebyshev: min diagonal value = 2.22045e-16 [default] + chebyshev: assume matrix does not change = 0 [default] + +Level 3 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Matrix filtering (MueLu::FilteredAFactory) +Build (MueLu::CoalesceDropFactory) +Build (MueLu::AmalgamationFactory) +[empty list] + +algorithm = "distance laplacian": threshold = 0, blocksize = 1 +aggregation: drop tol = 0 [default] +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +lightweight wrap = 1 + +Filtered matrix is not being constructed as no filtering is being done +filtered matrix: use lumping = 1 [unused] +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] + +Build (MueLu::TentativePFactory) +Build (MueLu::UncoupledAggregationFactory) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregates (Phase 1 (main)) +BuildAggregates (Phase 2a (secondary)) +BuildAggregates (Phase 2b (expansion)) +BuildAggregates (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +aggregation: use interface aggregation = 0 [default] +aggregation: error on nodes with no on-rank neighbors = 0 [default] +aggregation: phase3 avoid singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] +Interface aggregate map name = [default] +Interface aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory) +Striding info = {} [default] +Strided block id = -1 [default] +Domain GID offsets = {0} [default] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Max coarse size (<= 1000) achieved +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/default/Output/driver_drekar2_np4_epetra.gold b/packages/muelu/test/interface/default/Output/driver_drekar2_np4_epetra.gold index dd0bf9eae754..490164de5768 100644 --- a/packages/muelu/test/interface/default/Output/driver_drekar2_np4_epetra.gold +++ b/packages/muelu/test/interface/default/Output/driver_drekar2_np4_epetra.gold @@ -167,3 +167,295 @@ Smoother (level 2) both : MueLu::IfpackSmoother{type = Chebyshev} Smoother (level 3) pre : MueLu::AmesosSmoother{type = } Smoother (level 3) post : no smoother +Setup Smoother (MueLu::IfpackSmoother{type = Chebyshev}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + chebyshev: degree = 2 + chebyshev: ratio eigenvalue = 20 [unused] + chebyshev: min eigenvalue = 1 + chebyshev: zero starting solution = 1 + chebyshev: eigenvalue max iterations = 10 + +Level 2 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Matrix filtering (MueLu::FilteredAFactory) +Build (MueLu::CoalesceDropFactory) +Build (MueLu::AmalgamationFactory) +[empty list] + +algorithm = "distance laplacian": threshold = 0.02, blocksize = 1 +aggregation: drop tol = 0.02 +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +lightweight wrap = 1 + +Lumping dropped entries +filtered matrix: use lumping = 1 +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] + +Build (MueLu::TentativePFactory) +Build (MueLu::UncoupledAggregationFactory) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregates (Phase 1 (main)) +BuildAggregates (Phase 2a (secondary)) +BuildAggregates (Phase 2b (expansion)) +BuildAggregates (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +aggregation: use interface aggregation = 0 [default] +aggregation: error on nodes with no on-rank neighbors = 0 [default] +aggregation: phase3 avoid singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] +Interface aggregate map name = [default] +Interface aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory) +Striding info = {} [default] +Strided block id = -1 [default] +Domain GID offsets = {0} [default] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::IfpackSmoother{type = Chebyshev}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + chebyshev: degree = 2 + chebyshev: ratio eigenvalue = 20 [unused] + chebyshev: min eigenvalue = 1 + chebyshev: zero starting solution = 1 + chebyshev: eigenvalue max iterations = 10 + +Level 3 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Matrix filtering (MueLu::FilteredAFactory) +Build (MueLu::CoalesceDropFactory) +Build (MueLu::AmalgamationFactory) +[empty list] + +algorithm = "distance laplacian": threshold = 0.02, blocksize = 1 +aggregation: drop tol = 0.02 +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +lightweight wrap = 1 + +Lumping dropped entries +filtered matrix: use lumping = 1 +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] + +Build (MueLu::TentativePFactory) +Build (MueLu::UncoupledAggregationFactory) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregates (Phase 1 (main)) +BuildAggregates (Phase 2a (secondary)) +BuildAggregates (Phase 2b (expansion)) +BuildAggregates (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +aggregation: use interface aggregation = 0 [default] +aggregation: error on nodes with no on-rank neighbors = 0 [default] +aggregation: phase3 avoid singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] +Interface aggregate map name = [default] +Interface aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory) +Striding info = {} [default] +Strided block id = -1 [default] +Domain GID offsets = {0} [default] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Max coarse size (<= 1000) achieved +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + diff --git a/packages/muelu/test/interface/default/Output/driver_drekar2_np4_tpetra.gold b/packages/muelu/test/interface/default/Output/driver_drekar2_np4_tpetra.gold index b3dfd4aeb5df..79f32d1cfb2c 100644 --- a/packages/muelu/test/interface/default/Output/driver_drekar2_np4_tpetra.gold +++ b/packages/muelu/test/interface/default/Output/driver_drekar2_np4_tpetra.gold @@ -170,3 +170,303 @@ Smoother (level 2) both : "Ifpack2::Chebyshev": {Initialized: true, Computed: tr Smoother (level 3) pre : solver interface Smoother (level 3) post : no smoother +Setup Smoother (MueLu::Ifpack2Smoother{type = CHEBYSHEV}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + chebyshev: degree = 2 + chebyshev: ratio eigenvalue = 20 + chebyshev: min eigenvalue = 1 + chebyshev: zero starting solution = 1 + chebyshev: eigenvalue max iterations = 10 + chebyshev: boost factor = 1.1 [unused] + chebyshev: min diagonal value = 2.22045e-16 [default] + chebyshev: assume matrix does not change = 0 [default] + +Level 2 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Matrix filtering (MueLu::FilteredAFactory) +Build (MueLu::CoalesceDropFactory) +Build (MueLu::AmalgamationFactory) +[empty list] + +algorithm = "distance laplacian": threshold = 0.02, blocksize = 1 +aggregation: drop tol = 0.02 +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +lightweight wrap = 1 + +Lumping dropped entries +filtered matrix: use lumping = 1 +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] + +Build (MueLu::TentativePFactory) +Build (MueLu::UncoupledAggregationFactory) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregates (Phase 1 (main)) +BuildAggregates (Phase 2a (secondary)) +BuildAggregates (Phase 2b (expansion)) +BuildAggregates (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +aggregation: use interface aggregation = 0 [default] +aggregation: error on nodes with no on-rank neighbors = 0 [default] +aggregation: phase3 avoid singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] +Interface aggregate map name = [default] +Interface aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory) +Striding info = {} [default] +Strided block id = -1 [default] +Domain GID offsets = {0} [default] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Ifpack2Smoother{type = CHEBYSHEV}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + chebyshev: degree = 2 + chebyshev: ratio eigenvalue = 20 + chebyshev: min eigenvalue = 1 + chebyshev: zero starting solution = 1 + chebyshev: eigenvalue max iterations = 10 + chebyshev: boost factor = 1.1 [unused] + chebyshev: min diagonal value = 2.22045e-16 [default] + chebyshev: assume matrix does not change = 0 [default] + +Level 3 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Matrix filtering (MueLu::FilteredAFactory) +Build (MueLu::CoalesceDropFactory) +Build (MueLu::AmalgamationFactory) +[empty list] + +algorithm = "distance laplacian": threshold = 0.02, blocksize = 1 +aggregation: drop tol = 0.02 +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +lightweight wrap = 1 + +Lumping dropped entries +filtered matrix: use lumping = 1 +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] + +Build (MueLu::TentativePFactory) +Build (MueLu::UncoupledAggregationFactory) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregates (Phase 1 (main)) +BuildAggregates (Phase 2a (secondary)) +BuildAggregates (Phase 2b (expansion)) +BuildAggregates (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +aggregation: use interface aggregation = 0 [default] +aggregation: error on nodes with no on-rank neighbors = 0 [default] +aggregation: phase3 avoid singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] +Interface aggregate map name = [default] +Interface aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory) +Striding info = {} [default] +Strided block id = -1 [default] +Domain GID offsets = {0} [default] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Max coarse size (<= 1000) achieved +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/default/Output/repartition1_np4_epetra.gold b/packages/muelu/test/interface/default/Output/repartition1_np4_epetra.gold index 0978c5819f57..4217d50402bd 100644 --- a/packages/muelu/test/interface/default/Output/repartition1_np4_epetra.gold +++ b/packages/muelu/test/interface/default/Output/repartition1_np4_epetra.gold @@ -302,3 +302,10 @@ Smoother (level 1) both : MueLu::IfpackSmoother{type = point relaxation stand-al Smoother (level 2) pre : MueLu::AmesosSmoother{type = } Smoother (level 2) post : no smoother +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + diff --git a/packages/muelu/test/interface/default/Output/repartition1_np4_tpetra.gold b/packages/muelu/test/interface/default/Output/repartition1_np4_tpetra.gold index f1effde3ac0c..e9382172f393 100644 --- a/packages/muelu/test/interface/default/Output/repartition1_np4_tpetra.gold +++ b/packages/muelu/test/interface/default/Output/repartition1_np4_tpetra.gold @@ -324,3 +324,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/default/Output/reuse-RAP-1_np4_epetra.gold b/packages/muelu/test/interface/default/Output/reuse-RAP-1_np4_epetra.gold index e14aa846916a..224a9f40a8be 100644 --- a/packages/muelu/test/interface/default/Output/reuse-RAP-1_np4_epetra.gold +++ b/packages/muelu/test/interface/default/Output/reuse-RAP-1_np4_epetra.gold @@ -334,3 +334,10 @@ Smoother (level 1) both : MueLu::IfpackSmoother{type = point relaxation stand-al Smoother (level 2) pre : MueLu::AmesosSmoother{type = } Smoother (level 2) post : no smoother +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + diff --git a/packages/muelu/test/interface/default/Output/reuse-RAP-1_np4_tpetra.gold b/packages/muelu/test/interface/default/Output/reuse-RAP-1_np4_tpetra.gold index 4b693b0e4f88..449cf8b82bce 100644 --- a/packages/muelu/test/interface/default/Output/reuse-RAP-1_np4_tpetra.gold +++ b/packages/muelu/test/interface/default/Output/reuse-RAP-1_np4_tpetra.gold @@ -367,3 +367,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/default/Output/reuse-RAP-2_np4_epetra.gold b/packages/muelu/test/interface/default/Output/reuse-RAP-2_np4_epetra.gold index 755eb7b51a0a..a1a009826d5b 100644 --- a/packages/muelu/test/interface/default/Output/reuse-RAP-2_np4_epetra.gold +++ b/packages/muelu/test/interface/default/Output/reuse-RAP-2_np4_epetra.gold @@ -308,3 +308,10 @@ Smoother (level 1) both : MueLu::IfpackSmoother{type = point relaxation stand-al Smoother (level 2) pre : MueLu::AmesosSmoother{type = } Smoother (level 2) post : no smoother +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + diff --git a/packages/muelu/test/interface/default/Output/reuse-RAP-2_np4_tpetra.gold b/packages/muelu/test/interface/default/Output/reuse-RAP-2_np4_tpetra.gold index f893272f808b..0b1c7a4282d8 100644 --- a/packages/muelu/test/interface/default/Output/reuse-RAP-2_np4_tpetra.gold +++ b/packages/muelu/test/interface/default/Output/reuse-RAP-2_np4_tpetra.gold @@ -341,3 +341,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/default/Output/reuse-RP-2_np4_epetra.gold b/packages/muelu/test/interface/default/Output/reuse-RP-2_np4_epetra.gold index 11b0ac1d3ab9..8591b066f7a6 100644 --- a/packages/muelu/test/interface/default/Output/reuse-RP-2_np4_epetra.gold +++ b/packages/muelu/test/interface/default/Output/reuse-RP-2_np4_epetra.gold @@ -392,3 +392,55 @@ Smoother (level 1) both : MueLu::IfpackSmoother{type = point relaxation stand-al Smoother (level 2) pre : MueLu::AmesosSmoother{type = } Smoother (level 2) post : no smoother +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + +Build (MueLu::RebalanceTransferFactory) +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Computing Ac (MueLu::RAPFactory) +Reusing previous AP data +Reusing previous RAP data +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +Reusing coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 1 +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + diff --git a/packages/muelu/test/interface/default/Output/reuse-RP-2_np4_tpetra.gold b/packages/muelu/test/interface/default/Output/reuse-RP-2_np4_tpetra.gold index 70764494f534..de5fa55084fc 100644 --- a/packages/muelu/test/interface/default/Output/reuse-RP-2_np4_tpetra.gold +++ b/packages/muelu/test/interface/default/Output/reuse-RP-2_np4_tpetra.gold @@ -436,3 +436,59 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Computing Ac (MueLu::RAPFactory) +Reusing previous AP data +Reusing previous RAP data +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +Reusing coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 1 +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother ( solver interface) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/default/Output/reuse-S-1_np4_epetra.gold b/packages/muelu/test/interface/default/Output/reuse-S-1_np4_epetra.gold index 9d5893ca072e..f965843e9036 100644 --- a/packages/muelu/test/interface/default/Output/reuse-S-1_np4_epetra.gold +++ b/packages/muelu/test/interface/default/Output/reuse-S-1_np4_epetra.gold @@ -602,3 +602,98 @@ Smoother (level 1) both : MueLu::IfpackSmoother{type = point relaxation stand-al Smoother (level 2) pre : MueLu::AmesosSmoother{type = } Smoother (level 2) post : no smoother +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Build (MueLu::TentativePFactory) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +repartition: rebalance P and R = 1 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +repartition: rebalance P and R = 1 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + diff --git a/packages/muelu/test/interface/default/Output/reuse-S-1_np4_tpetra.gold b/packages/muelu/test/interface/default/Output/reuse-S-1_np4_tpetra.gold index 7d5ad1b448e4..622a16fc1d49 100644 --- a/packages/muelu/test/interface/default/Output/reuse-S-1_np4_tpetra.gold +++ b/packages/muelu/test/interface/default/Output/reuse-S-1_np4_tpetra.gold @@ -646,3 +646,102 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Build (MueLu::TentativePFactory) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +repartition: rebalance P and R = 1 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +repartition: rebalance P and R = 1 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother ( solver interface) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/default/Output/reuse-full-1_np4_epetra.gold b/packages/muelu/test/interface/default/Output/reuse-full-1_np4_epetra.gold index b2d22b704bb6..9635b79ae77c 100644 --- a/packages/muelu/test/interface/default/Output/reuse-full-1_np4_epetra.gold +++ b/packages/muelu/test/interface/default/Output/reuse-full-1_np4_epetra.gold @@ -325,3 +325,10 @@ Smoother (level 1) both : MueLu::IfpackSmoother{type = point relaxation stand-al Smoother (level 2) pre : MueLu::AmesosSmoother{type = } Smoother (level 2) post : no smoother +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + diff --git a/packages/muelu/test/interface/default/Output/reuse-full-1_np4_tpetra.gold b/packages/muelu/test/interface/default/Output/reuse-full-1_np4_tpetra.gold index ffca6b7699fe..35dcef6421ca 100644 --- a/packages/muelu/test/interface/default/Output/reuse-full-1_np4_tpetra.gold +++ b/packages/muelu/test/interface/default/Output/reuse-full-1_np4_tpetra.gold @@ -347,3 +347,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/default/Output/reuse-none_np4_epetra.gold b/packages/muelu/test/interface/default/Output/reuse-none_np4_epetra.gold index 727d2314846e..50076fd8ea88 100644 --- a/packages/muelu/test/interface/default/Output/reuse-none_np4_epetra.gold +++ b/packages/muelu/test/interface/default/Output/reuse-none_np4_epetra.gold @@ -606,3 +606,100 @@ Smoother (level 1) both : MueLu::IfpackSmoother{type = point relaxation stand-al Smoother (level 2) pre : MueLu::AmesosSmoother{type = } Smoother (level 2) post : no smoother +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Build (MueLu::TentativePFactory) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + diff --git a/packages/muelu/test/interface/default/Output/reuse-none_np4_tpetra.gold b/packages/muelu/test/interface/default/Output/reuse-none_np4_tpetra.gold index b55ee3809593..cd32c72e7b91 100644 --- a/packages/muelu/test/interface/default/Output/reuse-none_np4_tpetra.gold +++ b/packages/muelu/test/interface/default/Output/reuse-none_np4_tpetra.gold @@ -650,3 +650,104 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Build (MueLu::TentativePFactory) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/default/Output/reuse-tP-1_np4_epetra.gold b/packages/muelu/test/interface/default/Output/reuse-tP-1_np4_epetra.gold index b48434b36aed..12e7abc1d59c 100644 --- a/packages/muelu/test/interface/default/Output/reuse-tP-1_np4_epetra.gold +++ b/packages/muelu/test/interface/default/Output/reuse-tP-1_np4_epetra.gold @@ -496,3 +496,77 @@ Smoother (level 1) both : MueLu::IfpackSmoother{type = point relaxation stand-al Smoother (level 2) pre : MueLu::AmesosSmoother{type = } Smoother (level 2) post : no smoother +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + +Build (MueLu::RebalanceTransferFactory) +Prolongator smoothing (MueLu::SaPFactory) +Reusing previous AP data +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +Using original restrictor +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Computing Ac (MueLu::RAPFactory) +Reusing previous AP data +Reusing previous RAP data +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +Reusing coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + diff --git a/packages/muelu/test/interface/default/Output/reuse-tP-1_np4_tpetra.gold b/packages/muelu/test/interface/default/Output/reuse-tP-1_np4_tpetra.gold index 2da425dcbb75..8549583f3d96 100644 --- a/packages/muelu/test/interface/default/Output/reuse-tP-1_np4_tpetra.gold +++ b/packages/muelu/test/interface/default/Output/reuse-tP-1_np4_tpetra.gold @@ -540,3 +540,81 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Prolongator smoothing (MueLu::SaPFactory) +Reusing previous AP data +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +Using original restrictor +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Computing Ac (MueLu::RAPFactory) +Reusing previous AP data +Reusing previous RAP data +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +Reusing coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother ( solver interface) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/default/Output/reuse-tP-2_np4_epetra.gold b/packages/muelu/test/interface/default/Output/reuse-tP-2_np4_epetra.gold index 242793bee324..85efda6b1538 100644 --- a/packages/muelu/test/interface/default/Output/reuse-tP-2_np4_epetra.gold +++ b/packages/muelu/test/interface/default/Output/reuse-tP-2_np4_epetra.gold @@ -548,3 +548,100 @@ Smoother (level 1) both : MueLu::IfpackSmoother{type = point relaxation stand-al Smoother (level 2) pre : MueLu::AmesosSmoother{type = } Smoother (level 2) post : no smoother +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Build (MueLu::TentativePFactory) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + diff --git a/packages/muelu/test/interface/default/Output/reuse-tP-2_np4_tpetra.gold b/packages/muelu/test/interface/default/Output/reuse-tP-2_np4_tpetra.gold index c7310fe49175..de950225cb3a 100644 --- a/packages/muelu/test/interface/default/Output/reuse-tP-2_np4_tpetra.gold +++ b/packages/muelu/test/interface/default/Output/reuse-tP-2_np4_tpetra.gold @@ -592,3 +592,104 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Build (MueLu::TentativePFactory) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/default/Output/reuse-tP-3_np4_epetra.gold b/packages/muelu/test/interface/default/Output/reuse-tP-3_np4_epetra.gold index 543f4bad5ff6..d8f95c2bf1c3 100644 --- a/packages/muelu/test/interface/default/Output/reuse-tP-3_np4_epetra.gold +++ b/packages/muelu/test/interface/default/Output/reuse-tP-3_np4_epetra.gold @@ -551,3 +551,100 @@ Smoother (level 1) both : MueLu::IfpackSmoother{type = point relaxation stand-al Smoother (level 2) pre : MueLu::AmesosSmoother{type = } Smoother (level 2) post : no smoother +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Build (MueLu::TentativePFactory) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + diff --git a/packages/muelu/test/interface/default/Output/reuse-tP-3_np4_tpetra.gold b/packages/muelu/test/interface/default/Output/reuse-tP-3_np4_tpetra.gold index 4ecea60c74c7..1eaba1485bb8 100644 --- a/packages/muelu/test/interface/default/Output/reuse-tP-3_np4_tpetra.gold +++ b/packages/muelu/test/interface/default/Output/reuse-tP-3_np4_tpetra.gold @@ -595,3 +595,104 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory) +Build (MueLu::TentativePFactory) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +tentative: constant column sums = 0 [default] +Nullspace name = Nullspace [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory +Build (MueLu::CoordinatesTransferFactory) +Transferring coordinates +structured aggregation = 0 [default] +aggregation coupled = 0 [default] +Geometric = 0 [default] +write start = -1 [default] +write end = -1 [default] +hybrid aggregation = 0 [default] +interface aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/default/Output/transpose2_np4_epetra.gold b/packages/muelu/test/interface/default/Output/transpose2_np4_epetra.gold index 575d1adedda7..9442c8bb9fa3 100644 --- a/packages/muelu/test/interface/default/Output/transpose2_np4_epetra.gold +++ b/packages/muelu/test/interface/default/Output/transpose2_np4_epetra.gold @@ -274,3 +274,10 @@ Smoother (level 1) both : MueLu::IfpackSmoother{type = point relaxation stand-al Smoother (level 2) pre : MueLu::AmesosSmoother{type = } Smoother (level 2) post : no smoother +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + diff --git a/packages/muelu/test/interface/default/Output/transpose2_np4_tpetra.gold b/packages/muelu/test/interface/default/Output/transpose2_np4_tpetra.gold index c5dfff63cc9a..c20ed1e187f9 100644 --- a/packages/muelu/test/interface/default/Output/transpose2_np4_tpetra.gold +++ b/packages/muelu/test/interface/default/Output/transpose2_np4_tpetra.gold @@ -296,3 +296,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/default/Output/transpose3_np4_epetra.gold b/packages/muelu/test/interface/default/Output/transpose3_np4_epetra.gold index c4448d971c79..f702fda438d6 100644 --- a/packages/muelu/test/interface/default/Output/transpose3_np4_epetra.gold +++ b/packages/muelu/test/interface/default/Output/transpose3_np4_epetra.gold @@ -274,3 +274,10 @@ Smoother (level 1) both : MueLu::IfpackSmoother{type = point relaxation stand-al Smoother (level 2) pre : MueLu::AmesosSmoother{type = } Smoother (level 2) post : no smoother +Setup Smoother (MueLu::AmesosSmoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + [empty list] + diff --git a/packages/muelu/test/interface/default/Output/transpose3_np4_tpetra.gold b/packages/muelu/test/interface/default/Output/transpose3_np4_tpetra.gold index 15e1b73078b2..45d35f58b980 100644 --- a/packages/muelu/test/interface/default/Output/transpose3_np4_tpetra.gold +++ b/packages/muelu/test/interface/default/Output/transpose3_np4_tpetra.gold @@ -296,3 +296,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos-complex/Output/MLcoarse1_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/MLcoarse1_tpetra.gold index 8fba165664df..9ba523069cb0 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/MLcoarse1_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/MLcoarse1_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -104,6 +105,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -192,6 +194,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Prolongator smoothing (MueLu::SaPFactory_kokkos) diff --git a/packages/muelu/test/interface/kokkos-complex/Output/MLcoarse2_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/MLcoarse2_tpetra.gold index 55f44cbf18f5..cf0242a682ad 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/MLcoarse2_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/MLcoarse2_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -104,6 +105,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -192,6 +194,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -280,6 +283,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -368,6 +372,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 5 Prolongator smoothing (MueLu::SaPFactory_kokkos) diff --git a/packages/muelu/test/interface/kokkos-complex/Output/MLcoarse3_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/MLcoarse3_tpetra.gold index 751b9ac5b8cc..21b14e9a707e 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/MLcoarse3_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/MLcoarse3_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -104,6 +105,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -192,6 +194,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -280,6 +283,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Prolongator smoothing (MueLu::SaPFactory_kokkos) diff --git a/packages/muelu/test/interface/kokkos-complex/Output/MLcoarse5_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/MLcoarse5_tpetra.gold index 5cfb92971493..f73f0bf5f2aa 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/MLcoarse5_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/MLcoarse5_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -104,6 +105,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Prolongator smoothing (MueLu::SaPFactory_kokkos) diff --git a/packages/muelu/test/interface/kokkos-complex/Output/MLpgamg1_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/MLpgamg1_tpetra.gold index 51a8dc7b28f5..9bf542c5d1bf 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/MLpgamg1_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/MLpgamg1_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Prolongator smoothing (PG-AMG) (MueLu::PgPFactory) @@ -106,6 +107,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Prolongator smoothing (PG-AMG) (MueLu::PgPFactory) @@ -196,6 +198,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Prolongator smoothing (PG-AMG) (MueLu::PgPFactory) @@ -286,6 +289,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Prolongator smoothing (PG-AMG) (MueLu::PgPFactory) diff --git a/packages/muelu/test/interface/kokkos-complex/Output/MLsmoother1_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/MLsmoother1_tpetra.gold index 751b9ac5b8cc..21b14e9a707e 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/MLsmoother1_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/MLsmoother1_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -104,6 +105,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -192,6 +194,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -280,6 +283,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Prolongator smoothing (MueLu::SaPFactory_kokkos) diff --git a/packages/muelu/test/interface/kokkos-complex/Output/MLsmoother2_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/MLsmoother2_tpetra.gold index f94c41792a83..dcf4769c29cc 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/MLsmoother2_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/MLsmoother2_tpetra.gold @@ -19,6 +19,7 @@ presmoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -104,6 +105,7 @@ presmoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -192,6 +194,7 @@ presmoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -280,6 +283,7 @@ presmoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Prolongator smoothing (MueLu::SaPFactory_kokkos) diff --git a/packages/muelu/test/interface/kokkos-complex/Output/MLsmoother3_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/MLsmoother3_tpetra.gold index 09019f343b2c..5de22e87f36b 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/MLsmoother3_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/MLsmoother3_tpetra.gold @@ -19,6 +19,7 @@ postsmoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -104,6 +105,7 @@ postsmoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -192,6 +194,7 @@ postsmoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -280,6 +283,7 @@ postsmoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Prolongator smoothing (MueLu::SaPFactory_kokkos) diff --git a/packages/muelu/test/interface/kokkos-complex/Output/MLsmoother4_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/MLsmoother4_tpetra.gold index 751b9ac5b8cc..21b14e9a707e 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/MLsmoother4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/MLsmoother4_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -104,6 +105,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -192,6 +194,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -280,6 +283,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Prolongator smoothing (MueLu::SaPFactory_kokkos) diff --git a/packages/muelu/test/interface/kokkos-complex/Output/MLunsmoothed1_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/MLunsmoothed1_tpetra.gold index c5d586e38dc9..20337fae49d7 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/MLunsmoothed1_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/MLunsmoothed1_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Build (MueLu::TentativePFactory_kokkos) @@ -97,6 +98,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Build (MueLu::TentativePFactory_kokkos) @@ -178,6 +180,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Build (MueLu::TentativePFactory_kokkos) @@ -259,6 +262,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Build (MueLu::TentativePFactory_kokkos) diff --git a/packages/muelu/test/interface/kokkos-complex/Output/driver_drekar1_np4_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/driver_drekar1_np4_tpetra.gold index fadf106e2c17..869dfca484fa 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/driver_drekar1_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/driver_drekar1_np4_tpetra.gold @@ -162,3 +162,287 @@ Smoother (level 2) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 3) pre : solver interface Smoother (level 3) post : no smoother +Setup Smoother (MueLu::Ifpack2Smoother{type = RELAXATION}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + relaxation: type = Symmetric Gauss-Seidel + relaxation: sweeps = 2 + relaxation: damping factor = 1 [default] + relaxation: zero starting solution = 1 [default] + relaxation: backward mode = 0 [default] + relaxation: use l1 = 0 [default] + relaxation: l1 eta = 1.5 [default] + relaxation: min diagonal value = 0 [default] + relaxation: fix tiny diagonal entries = 0 [default] + relaxation: check diagonal entries = 0 [default] + relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] + relaxation: symmetric matrix structure = 0 [default] + relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] + +Level 2 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory_kokkos) +Build (MueLu::CoalesceDropFactory_kokkos) +Build (MueLu::AmalgamationFactory_kokkos) +[empty list] + +algorithm = "distance laplacian": threshold = 0, blocksize = 1 +aggregation: drop tol = 0 [default] +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +filtered matrix: use lumping = 1 [unused] +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] +lightweight wrap = 1 + +Build (MueLu::TentativePFactory_kokkos) +Build (MueLu::UncoupledAggregationFactory_kokkos) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregatesRandom (Phase 1 (main)) +BuildAggregatesRandom (Phase 2a (secondary)) +BuildAggregatesRandom (Phase 2b (expansion)) +BuildAggregatesRandom (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: deterministic = 0 [default] +aggregation: coloring algorithm = serial [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory_kokkos) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory_kokkos) +[empty list] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Ifpack2Smoother{type = RELAXATION}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + relaxation: type = Symmetric Gauss-Seidel + relaxation: sweeps = 2 + relaxation: damping factor = 1 [default] + relaxation: zero starting solution = 1 [default] + relaxation: backward mode = 0 [default] + relaxation: use l1 = 0 [default] + relaxation: l1 eta = 1.5 [default] + relaxation: min diagonal value = 0 [default] + relaxation: fix tiny diagonal entries = 0 [default] + relaxation: check diagonal entries = 0 [default] + relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] + relaxation: symmetric matrix structure = 0 [default] + relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] + +Level 3 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory_kokkos) +Build (MueLu::CoalesceDropFactory_kokkos) +Build (MueLu::AmalgamationFactory_kokkos) +[empty list] + +algorithm = "distance laplacian": threshold = 0, blocksize = 1 +aggregation: drop tol = 0 [default] +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +filtered matrix: use lumping = 1 [unused] +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] +lightweight wrap = 1 + +Build (MueLu::TentativePFactory_kokkos) +Build (MueLu::UncoupledAggregationFactory_kokkos) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregatesRandom (Phase 1 (main)) +BuildAggregatesRandom (Phase 2a (secondary)) +BuildAggregatesRandom (Phase 2b (expansion)) +BuildAggregatesRandom (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: deterministic = 0 [default] +aggregation: coloring algorithm = serial [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory_kokkos) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory_kokkos) +[empty list] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Max coarse size (<= 1000) achieved +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos-complex/Output/driver_drekar2_np4_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/driver_drekar2_np4_tpetra.gold index 71f9480ebf61..45aa4b6cfc40 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/driver_drekar2_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/driver_drekar2_np4_tpetra.gold @@ -163,3 +163,289 @@ Smoother (level 2) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 3) pre : solver interface Smoother (level 3) post : no smoother +Setup Smoother (MueLu::Ifpack2Smoother{type = RELAXATION}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + relaxation: type = Symmetric Gauss-Seidel + relaxation: sweeps = 2 + relaxation: damping factor = 1 [default] + relaxation: zero starting solution = 1 [default] + relaxation: backward mode = 0 [default] + relaxation: use l1 = 0 [default] + relaxation: l1 eta = 1.5 [default] + relaxation: min diagonal value = 0 [default] + relaxation: fix tiny diagonal entries = 0 [default] + relaxation: check diagonal entries = 0 [default] + relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] + relaxation: symmetric matrix structure = 0 [default] + relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] + +Level 2 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory_kokkos) +Build (MueLu::CoalesceDropFactory_kokkos) +Build (MueLu::AmalgamationFactory_kokkos) +[empty list] + +algorithm = "distance laplacian": threshold = 0.02, blocksize = 1 +Lumping dropped entries +aggregation: drop tol = 0.02 +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +filtered matrix: use lumping = 1 +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] +lightweight wrap = 1 + +Build (MueLu::TentativePFactory_kokkos) +Build (MueLu::UncoupledAggregationFactory_kokkos) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregatesRandom (Phase 1 (main)) +BuildAggregatesRandom (Phase 2a (secondary)) +BuildAggregatesRandom (Phase 2b (expansion)) +BuildAggregatesRandom (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: deterministic = 0 [default] +aggregation: coloring algorithm = serial [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory_kokkos) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory_kokkos) +[empty list] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Ifpack2Smoother{type = RELAXATION}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + relaxation: type = Symmetric Gauss-Seidel + relaxation: sweeps = 2 + relaxation: damping factor = 1 [default] + relaxation: zero starting solution = 1 [default] + relaxation: backward mode = 0 [default] + relaxation: use l1 = 0 [default] + relaxation: l1 eta = 1.5 [default] + relaxation: min diagonal value = 0 [default] + relaxation: fix tiny diagonal entries = 0 [default] + relaxation: check diagonal entries = 0 [default] + relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] + relaxation: symmetric matrix structure = 0 [default] + relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] + +Level 3 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory_kokkos) +Build (MueLu::CoalesceDropFactory_kokkos) +Build (MueLu::AmalgamationFactory_kokkos) +[empty list] + +algorithm = "distance laplacian": threshold = 0.02, blocksize = 1 +Lumping dropped entries +aggregation: drop tol = 0.02 +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +filtered matrix: use lumping = 1 +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] +lightweight wrap = 1 + +Build (MueLu::TentativePFactory_kokkos) +Build (MueLu::UncoupledAggregationFactory_kokkos) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregatesRandom (Phase 1 (main)) +BuildAggregatesRandom (Phase 2a (secondary)) +BuildAggregatesRandom (Phase 2b (expansion)) +BuildAggregatesRandom (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: deterministic = 0 [default] +aggregation: coloring algorithm = serial [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory_kokkos) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory_kokkos) +[empty list] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Max coarse size (<= 1000) achieved +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos-complex/Output/repartition1_np4_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/repartition1_np4_tpetra.gold index c91ce053e6e7..7565c1f0967e 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/repartition1_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/repartition1_np4_tpetra.gold @@ -296,3 +296,14 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + + + diff --git a/packages/muelu/test/interface/kokkos-complex/Output/reuse-RAP-1_np4_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/reuse-RAP-1_np4_tpetra.gold index 430b04151da1..4941b458d3b3 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/reuse-RAP-1_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/reuse-RAP-1_np4_tpetra.gold @@ -339,3 +339,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos-complex/Output/reuse-RAP-2_np4_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/reuse-RAP-2_np4_tpetra.gold index f2ba8a8e3237..5f44cc509209 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/reuse-RAP-2_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/reuse-RAP-2_np4_tpetra.gold @@ -313,3 +313,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos-complex/Output/reuse-RP-2_np4_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/reuse-RP-2_np4_tpetra.gold index 9cd1cd2259f5..9190091225b3 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/reuse-RP-2_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/reuse-RP-2_np4_tpetra.gold @@ -400,3 +400,55 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Computing Ac (MueLu::RAPFactory) +Reusing previous AP data +Reusing previous RAP data +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +Reusing coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 1 +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother ( solver interface) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos-complex/Output/reuse-S-1_np4_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/reuse-S-1_np4_tpetra.gold index 4597285f188c..793bd89514f9 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/reuse-S-1_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/reuse-S-1_np4_tpetra.gold @@ -590,3 +590,96 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory_kokkos) +Build (MueLu::TentativePFactory_kokkos) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +repartition: rebalance P and R = 1 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +repartition: rebalance P and R = 1 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother ( solver interface) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos-complex/Output/reuse-full-1_np4_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/reuse-full-1_np4_tpetra.gold index cb0810665731..503079af5877 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/reuse-full-1_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/reuse-full-1_np4_tpetra.gold @@ -319,3 +319,14 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + + + diff --git a/packages/muelu/test/interface/kokkos-complex/Output/reuse-none_np4_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/reuse-none_np4_tpetra.gold index 47072fb729ab..dd9719be6d0b 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/reuse-none_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/reuse-none_np4_tpetra.gold @@ -594,3 +594,98 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory_kokkos) +Build (MueLu::TentativePFactory_kokkos) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos-complex/Output/reuse-tP-1_np4_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/reuse-tP-1_np4_tpetra.gold index 4eaed20dc288..0e9783d9d980 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/reuse-tP-1_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/reuse-tP-1_np4_tpetra.gold @@ -496,3 +496,78 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Prolongator smoothing (MueLu::SaPFactory_kokkos) +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +Using original restrictor +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Computing Ac (MueLu::RAPFactory) +Reusing previous AP data +Reusing previous RAP data +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +Reusing coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother ( solver interface) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + + + diff --git a/packages/muelu/test/interface/kokkos-complex/Output/reuse-tP-2_np4_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/reuse-tP-2_np4_tpetra.gold index bff0afcadfa5..59332efb633d 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/reuse-tP-2_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/reuse-tP-2_np4_tpetra.gold @@ -547,3 +547,100 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory_kokkos) +Build (MueLu::TentativePFactory_kokkos) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + + + diff --git a/packages/muelu/test/interface/kokkos-complex/Output/reuse-tP-3_np4_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/reuse-tP-3_np4_tpetra.gold index 0f99114ba64e..28e73e1ef664 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/reuse-tP-3_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/reuse-tP-3_np4_tpetra.gold @@ -545,3 +545,98 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory_kokkos) +Build (MueLu::TentativePFactory_kokkos) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos-complex/Output/transpose2_np4_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/transpose2_np4_tpetra.gold index 6baabb462fd8..00ac17495673 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/transpose2_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/transpose2_np4_tpetra.gold @@ -268,3 +268,13 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + + diff --git a/packages/muelu/test/interface/kokkos-complex/Output/transpose3_np4_tpetra.gold b/packages/muelu/test/interface/kokkos-complex/Output/transpose3_np4_tpetra.gold index 60f8e2894410..2d6708f117e2 100644 --- a/packages/muelu/test/interface/kokkos-complex/Output/transpose3_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos-complex/Output/transpose3_np4_tpetra.gold @@ -268,3 +268,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos/Output/MLaux_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/MLaux_tpetra.gold index c2407b59f549..6c5a973137c3 100644 --- a/packages/muelu/test/interface/kokkos/Output/MLaux_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/MLaux_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Build (MueLu::RebalanceTransferFactory) diff --git a/packages/muelu/test/interface/kokkos/Output/MLcoarse1_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/MLcoarse1_tpetra.gold index 8fba165664df..9ba523069cb0 100644 --- a/packages/muelu/test/interface/kokkos/Output/MLcoarse1_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/MLcoarse1_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -104,6 +105,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -192,6 +194,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Prolongator smoothing (MueLu::SaPFactory_kokkos) diff --git a/packages/muelu/test/interface/kokkos/Output/MLcoarse2_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/MLcoarse2_tpetra.gold index 55f44cbf18f5..cf0242a682ad 100644 --- a/packages/muelu/test/interface/kokkos/Output/MLcoarse2_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/MLcoarse2_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -104,6 +105,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -192,6 +194,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -280,6 +283,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -368,6 +372,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 5 Prolongator smoothing (MueLu::SaPFactory_kokkos) diff --git a/packages/muelu/test/interface/kokkos/Output/MLcoarse3_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/MLcoarse3_tpetra.gold index 751b9ac5b8cc..21b14e9a707e 100644 --- a/packages/muelu/test/interface/kokkos/Output/MLcoarse3_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/MLcoarse3_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -104,6 +105,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -192,6 +194,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -280,6 +283,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Prolongator smoothing (MueLu::SaPFactory_kokkos) diff --git a/packages/muelu/test/interface/kokkos/Output/MLcoarse4_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/MLcoarse4_tpetra.gold index d32094577d70..8aecb539fb8b 100644 --- a/packages/muelu/test/interface/kokkos/Output/MLcoarse4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/MLcoarse4_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -104,6 +105,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -192,6 +194,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -280,6 +283,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -369,6 +373,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] -------------------------------------------------------------------------------- diff --git a/packages/muelu/test/interface/kokkos/Output/MLcoarse5_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/MLcoarse5_tpetra.gold index 5cfb92971493..f73f0bf5f2aa 100644 --- a/packages/muelu/test/interface/kokkos/Output/MLcoarse5_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/MLcoarse5_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -104,6 +105,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Prolongator smoothing (MueLu::SaPFactory_kokkos) diff --git a/packages/muelu/test/interface/kokkos/Output/MLpgamg1_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/MLpgamg1_tpetra.gold index 51a8dc7b28f5..9bf542c5d1bf 100644 --- a/packages/muelu/test/interface/kokkos/Output/MLpgamg1_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/MLpgamg1_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Prolongator smoothing (PG-AMG) (MueLu::PgPFactory) @@ -106,6 +107,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Prolongator smoothing (PG-AMG) (MueLu::PgPFactory) @@ -196,6 +198,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Prolongator smoothing (PG-AMG) (MueLu::PgPFactory) @@ -286,6 +289,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Prolongator smoothing (PG-AMG) (MueLu::PgPFactory) diff --git a/packages/muelu/test/interface/kokkos/Output/MLrepartitioning1_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/MLrepartitioning1_tpetra.gold index ec0df019885e..e511f8d40ad3 100644 --- a/packages/muelu/test/interface/kokkos/Output/MLrepartitioning1_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/MLrepartitioning1_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Build (MueLu::RebalanceTransferFactory) @@ -152,6 +153,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Build (MueLu::RebalanceTransferFactory) @@ -285,6 +287,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Build (MueLu::RebalanceTransferFactory) @@ -418,6 +421,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Build (MueLu::RebalanceTransferFactory) @@ -551,6 +555,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 5 Build (MueLu::RebalanceTransferFactory) diff --git a/packages/muelu/test/interface/kokkos/Output/MLrepartitioning2_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/MLrepartitioning2_tpetra.gold index 91da09440612..3515cc13b696 100644 --- a/packages/muelu/test/interface/kokkos/Output/MLrepartitioning2_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/MLrepartitioning2_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Build (MueLu::RebalanceTransferFactory) @@ -152,6 +153,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Build (MueLu::RebalanceTransferFactory) @@ -285,6 +287,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Build (MueLu::RebalanceTransferFactory) @@ -418,6 +421,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Build (MueLu::RebalanceTransferFactory) diff --git a/packages/muelu/test/interface/kokkos/Output/MLrepartitioning3_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/MLrepartitioning3_tpetra.gold index 48388064cf13..a782b3986f91 100644 --- a/packages/muelu/test/interface/kokkos/Output/MLrepartitioning3_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/MLrepartitioning3_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Build (MueLu::RebalanceTransferFactory) @@ -152,6 +153,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Build (MueLu::RebalanceTransferFactory) @@ -285,6 +287,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Build (MueLu::RebalanceTransferFactory) @@ -418,6 +421,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Build (MueLu::RebalanceTransferFactory) diff --git a/packages/muelu/test/interface/kokkos/Output/MLsmoother1_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/MLsmoother1_tpetra.gold index 751b9ac5b8cc..21b14e9a707e 100644 --- a/packages/muelu/test/interface/kokkos/Output/MLsmoother1_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/MLsmoother1_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -104,6 +105,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -192,6 +194,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -280,6 +283,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Prolongator smoothing (MueLu::SaPFactory_kokkos) diff --git a/packages/muelu/test/interface/kokkos/Output/MLsmoother2_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/MLsmoother2_tpetra.gold index f94c41792a83..dcf4769c29cc 100644 --- a/packages/muelu/test/interface/kokkos/Output/MLsmoother2_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/MLsmoother2_tpetra.gold @@ -19,6 +19,7 @@ presmoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -104,6 +105,7 @@ presmoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -192,6 +194,7 @@ presmoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -280,6 +283,7 @@ presmoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Prolongator smoothing (MueLu::SaPFactory_kokkos) diff --git a/packages/muelu/test/interface/kokkos/Output/MLsmoother3_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/MLsmoother3_tpetra.gold index 09019f343b2c..5de22e87f36b 100644 --- a/packages/muelu/test/interface/kokkos/Output/MLsmoother3_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/MLsmoother3_tpetra.gold @@ -19,6 +19,7 @@ postsmoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -104,6 +105,7 @@ postsmoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -192,6 +194,7 @@ postsmoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Prolongator smoothing (MueLu::SaPFactory_kokkos) @@ -280,6 +283,7 @@ postsmoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Prolongator smoothing (MueLu::SaPFactory_kokkos) diff --git a/packages/muelu/test/interface/kokkos/Output/MLunsmoothed1_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/MLunsmoothed1_tpetra.gold index c5d586e38dc9..20337fae49d7 100644 --- a/packages/muelu/test/interface/kokkos/Output/MLunsmoothed1_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/MLunsmoothed1_tpetra.gold @@ -19,6 +19,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 1 Build (MueLu::TentativePFactory_kokkos) @@ -97,6 +98,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 2 Build (MueLu::TentativePFactory_kokkos) @@ -178,6 +180,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 3 Build (MueLu::TentativePFactory_kokkos) @@ -259,6 +262,7 @@ smoother -> relaxation: local smoothing indices = Teuchos::ArrayRCP{ptr=0,lowerOffset=0,upperOffset=-1,size=0,node=0,strong_count=0,weak_count=0} [default] relaxation: symmetric matrix structure = 0 [default] relaxation: ifpack2 dump matrix = 0 [default] + relaxation: mtgs cluster size = 1 [default] Level 4 Build (MueLu::TentativePFactory_kokkos) diff --git a/packages/muelu/test/interface/kokkos/Output/driver_drekar1_np4_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/driver_drekar1_np4_tpetra.gold index 9c4e2f2a8905..f7baca8bc461 100644 --- a/packages/muelu/test/interface/kokkos/Output/driver_drekar1_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/driver_drekar1_np4_tpetra.gold @@ -156,3 +156,276 @@ Smoother (level 2) both : "Ifpack2::Chebyshev": {Initialized: true, Computed: tr Smoother (level 3) pre : solver interface Smoother (level 3) post : no smoother +Setup Smoother (MueLu::Ifpack2Smoother{type = CHEBYSHEV}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + chebyshev: degree = 2 + chebyshev: ratio eigenvalue = 20 + chebyshev: min eigenvalue = 1 + chebyshev: zero starting solution = 1 + chebyshev: eigenvalue max iterations = 10 + chebyshev: boost factor = 1.1 [unused] + chebyshev: min diagonal value = 2.22045e-16 [default] + chebyshev: assume matrix does not change = 0 [default] + +Level 2 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory_kokkos) +Build (MueLu::CoalesceDropFactory_kokkos) +Build (MueLu::AmalgamationFactory_kokkos) +[empty list] + +algorithm = "distance laplacian": threshold = 0, blocksize = 1 +aggregation: drop tol = 0 [default] +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +filtered matrix: use lumping = 1 [unused] +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] +lightweight wrap = 1 + +Build (MueLu::TentativePFactory_kokkos) +Build (MueLu::UncoupledAggregationFactory_kokkos) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregatesRandom (Phase 1 (main)) +BuildAggregatesRandom (Phase 2a (secondary)) +BuildAggregatesRandom (Phase 2b (expansion)) +BuildAggregatesRandom (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: deterministic = 0 [default] +aggregation: coloring algorithm = serial [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory_kokkos) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory_kokkos) +[empty list] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Ifpack2Smoother{type = CHEBYSHEV}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + chebyshev: degree = 2 + chebyshev: ratio eigenvalue = 20 + chebyshev: min eigenvalue = 1 + chebyshev: zero starting solution = 1 + chebyshev: eigenvalue max iterations = 10 + chebyshev: boost factor = 1.1 [unused] + chebyshev: min diagonal value = 2.22045e-16 [default] + chebyshev: assume matrix does not change = 0 [default] + +Level 3 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory_kokkos) +Build (MueLu::CoalesceDropFactory_kokkos) +Build (MueLu::AmalgamationFactory_kokkos) +[empty list] + +algorithm = "distance laplacian": threshold = 0, blocksize = 1 +aggregation: drop tol = 0 [default] +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +filtered matrix: use lumping = 1 [unused] +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] +lightweight wrap = 1 + +Build (MueLu::TentativePFactory_kokkos) +Build (MueLu::UncoupledAggregationFactory_kokkos) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregatesRandom (Phase 1 (main)) +BuildAggregatesRandom (Phase 2a (secondary)) +BuildAggregatesRandom (Phase 2b (expansion)) +BuildAggregatesRandom (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: deterministic = 0 [default] +aggregation: coloring algorithm = serial [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory_kokkos) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory_kokkos) +[empty list] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Max coarse size (<= 1000) achieved +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + + diff --git a/packages/muelu/test/interface/kokkos/Output/driver_drekar2_np4_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/driver_drekar2_np4_tpetra.gold index 0fef21cfe543..4473bc752d5e 100644 --- a/packages/muelu/test/interface/kokkos/Output/driver_drekar2_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/driver_drekar2_np4_tpetra.gold @@ -157,3 +157,279 @@ Smoother (level 2) both : "Ifpack2::Chebyshev": {Initialized: true, Computed: tr Smoother (level 3) pre : solver interface Smoother (level 3) post : no smoother +Setup Smoother (MueLu::Ifpack2Smoother{type = CHEBYSHEV}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + chebyshev: degree = 2 + chebyshev: ratio eigenvalue = 20 + chebyshev: min eigenvalue = 1 + chebyshev: zero starting solution = 1 + chebyshev: eigenvalue max iterations = 10 + chebyshev: boost factor = 1.1 [unused] + chebyshev: min diagonal value = 2.22045e-16 [default] + chebyshev: assume matrix does not change = 0 [default] + +Level 2 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory_kokkos) +Build (MueLu::CoalesceDropFactory_kokkos) +Build (MueLu::AmalgamationFactory_kokkos) +[empty list] + +algorithm = "distance laplacian": threshold = 0.02, blocksize = 1 +Lumping dropped entries +aggregation: drop tol = 0.02 +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +filtered matrix: use lumping = 1 +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] +lightweight wrap = 1 + +Build (MueLu::TentativePFactory_kokkos) +Build (MueLu::UncoupledAggregationFactory_kokkos) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregatesRandom (Phase 1 (main)) +BuildAggregatesRandom (Phase 2a (secondary)) +BuildAggregatesRandom (Phase 2b (expansion)) +BuildAggregatesRandom (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: deterministic = 0 [default] +aggregation: coloring algorithm = serial [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory_kokkos) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory_kokkos) +[empty list] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Ifpack2Smoother{type = CHEBYSHEV}) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +smoother -> + chebyshev: degree = 2 + chebyshev: ratio eigenvalue = 20 + chebyshev: min eigenvalue = 1 + chebyshev: zero starting solution = 1 + chebyshev: eigenvalue max iterations = 10 + chebyshev: boost factor = 1.1 [unused] + chebyshev: min diagonal value = 2.22045e-16 [default] + chebyshev: assume matrix does not change = 0 [default] + +Level 3 +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory_kokkos) +Build (MueLu::CoalesceDropFactory_kokkos) +Build (MueLu::AmalgamationFactory_kokkos) +[empty list] + +algorithm = "distance laplacian": threshold = 0.02, blocksize = 1 +Lumping dropped entries +aggregation: drop tol = 0.02 +aggregation: Dirichlet threshold = 0 [default] +aggregation: drop scheme = distance laplacian +filtered matrix: use lumping = 1 +filtered matrix: reuse graph = 1 [default] +filtered matrix: reuse eigenvalue = 1 [default] +lightweight wrap = 1 + +Build (MueLu::TentativePFactory_kokkos) +Build (MueLu::UncoupledAggregationFactory_kokkos) +BuildAggregates (Phase - (Dirichlet)) +BuildAggregatesRandom (Phase 1 (main)) +BuildAggregatesRandom (Phase 2a (secondary)) +BuildAggregatesRandom (Phase 2b (expansion)) +BuildAggregatesRandom (Phase 3 (cleanup)) +aggregation: max agg size = -1 [default] +aggregation: min agg size = 2 [default] +aggregation: max selected neighbors = 0 [default] +aggregation: ordering = natural [default] +aggregation: deterministic = 0 [default] +aggregation: coloring algorithm = serial [default] +aggregation: enable phase 1 = 1 [default] +aggregation: enable phase 2a = 1 [default] +aggregation: enable phase 2b = 1 [default] +aggregation: enable phase 3 = 1 [default] +aggregation: preserve Dirichlet points = 0 [default] +aggregation: allow user-specified singletons = 0 [default] +OnePt aggregate map name = [default] +OnePt aggregate map factory = [default] + +Nullspace factory (MueLu::NullspaceFactory_kokkos) +Fine level nullspace = Nullspace + +Build (MueLu::CoarseMapFactory_kokkos) +[empty list] + +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 1 +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 2000 +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.327 + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +repartition: use subcommunicators = 1 [default] + +Max coarse size (<= 1000) achieved +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + + + diff --git a/packages/muelu/test/interface/kokkos/Output/repartition1_np4_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/repartition1_np4_tpetra.gold index c91ce053e6e7..0eca7857d700 100644 --- a/packages/muelu/test/interface/kokkos/Output/repartition1_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/repartition1_np4_tpetra.gold @@ -296,3 +296,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos/Output/reuse-RAP-1_np4_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/reuse-RAP-1_np4_tpetra.gold index 430b04151da1..4941b458d3b3 100644 --- a/packages/muelu/test/interface/kokkos/Output/reuse-RAP-1_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/reuse-RAP-1_np4_tpetra.gold @@ -339,3 +339,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos/Output/reuse-RAP-2_np4_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/reuse-RAP-2_np4_tpetra.gold index f2ba8a8e3237..5f44cc509209 100644 --- a/packages/muelu/test/interface/kokkos/Output/reuse-RAP-2_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/reuse-RAP-2_np4_tpetra.gold @@ -313,3 +313,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos/Output/reuse-RP-2_np4_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/reuse-RP-2_np4_tpetra.gold index 9cd1cd2259f5..9190091225b3 100644 --- a/packages/muelu/test/interface/kokkos/Output/reuse-RP-2_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/reuse-RP-2_np4_tpetra.gold @@ -400,3 +400,55 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Computing Ac (MueLu::RAPFactory) +Reusing previous AP data +Reusing previous RAP data +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +Reusing coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 1 +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother ( solver interface) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos/Output/reuse-S-1_np4_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/reuse-S-1_np4_tpetra.gold index 4597285f188c..793bd89514f9 100644 --- a/packages/muelu/test/interface/kokkos/Output/reuse-S-1_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/reuse-S-1_np4_tpetra.gold @@ -590,3 +590,96 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory_kokkos) +Build (MueLu::TentativePFactory_kokkos) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +repartition: rebalance P and R = 1 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +repartition: rebalance P and R = 1 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother ( solver interface) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos/Output/reuse-full-1_np4_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/reuse-full-1_np4_tpetra.gold index cb0810665731..73a80d2fd431 100644 --- a/packages/muelu/test/interface/kokkos/Output/reuse-full-1_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/reuse-full-1_np4_tpetra.gold @@ -319,3 +319,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos/Output/reuse-none_np4_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/reuse-none_np4_tpetra.gold index 47072fb729ab..dd9719be6d0b 100644 --- a/packages/muelu/test/interface/kokkos/Output/reuse-none_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/reuse-none_np4_tpetra.gold @@ -594,3 +594,98 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory_kokkos) +Build (MueLu::TentativePFactory_kokkos) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 [default] +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos/Output/reuse-tP-1_np4_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/reuse-tP-1_np4_tpetra.gold index 4eaed20dc288..8918a82eb1e5 100644 --- a/packages/muelu/test/interface/kokkos/Output/reuse-tP-1_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/reuse-tP-1_np4_tpetra.gold @@ -496,3 +496,76 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Prolongator smoothing (MueLu::SaPFactory_kokkos) +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +Using original restrictor +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Computing Ac (MueLu::RAPFactory) +Reusing previous AP data +Reusing previous RAP data +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +Reusing coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother ( solver interface) +keep smoother data = 1 +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos/Output/reuse-tP-2_np4_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/reuse-tP-2_np4_tpetra.gold index bff0afcadfa5..4f8d1991dd20 100644 --- a/packages/muelu/test/interface/kokkos/Output/reuse-tP-2_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/reuse-tP-2_np4_tpetra.gold @@ -547,3 +547,98 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory_kokkos) +Build (MueLu::TentativePFactory_kokkos) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos/Output/reuse-tP-3_np4_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/reuse-tP-3_np4_tpetra.gold index 0f99114ba64e..28e73e1ef664 100644 --- a/packages/muelu/test/interface/kokkos/Output/reuse-tP-3_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/reuse-tP-3_np4_tpetra.gold @@ -545,3 +545,98 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + +Build (MueLu::RebalanceTransferFactory) +Build (MueLu::RepartitionFactory) +Computing Ac (MueLu::RAPFactory) +Prolongator smoothing (MueLu::SaPFactory_kokkos) +Build (MueLu::TentativePFactory_kokkos) +tentative: calculate qr = 1 [default] +tentative: build coarse coordinates = 1 [default] +matrixmatrix: kernel params -> + [empty list] + +sa: damping factor = 1.33 [default] +sa: calculate eigenvalue estimate = 0 [default] +sa: eigenvalue estimate num iterations = 10 [default] +matrixmatrix: kernel params -> + [empty list] + +Transpose P (MueLu::TransPFactory) +matrixmatrix: kernel params -> + [empty list] + +RAPFactory: call transfer factory: MueLu::CoordinatesTransferFactory_kokkos +Build (MueLu::CoordinatesTransferFactory_kokkos) +Transferring coordinates +write start = -1 [default] +write end = -1 [default] +structured aggregation = 0 [default] + +transpose: use implicit = 0 [default] +rap: triple product = 0 [default] +rap: fix zero diagonals = 0 [default] +rap: relative diagonal floor = {} [default] +CheckMainDiagonal = 0 [default] +RepairMainDiagonal = 0 [default] +matrixmatrix: kernel params -> + [empty list] + +Build (MueLu::RepartitionHeuristicFactory) +repartition: start level = 2 [default] +repartition: node repartition level = -1 [default] +repartition: min rows per proc = 800 [default] +repartition: target rows per proc = 0 [default] +repartition: min rows per thread = 0 [default] +repartition: target rows per thread = 0 [default] +repartition: max imbalance = 1.2 [default] + +Build (MueLu::Zoltan2Interface) +ParameterList = Teuchos::RCP{} [unused] + +repartition: print partition distribution = 0 [default] +repartition: remap parts = 1 [default] +repartition: remap num values = 4 [default] +repartition: remap accept partition = 1 [default] +repartition: node repartition level = -1 [default] + +Using original prolongator +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Interpolation +write start = -1 [default] +write end = -1 [default] + +Build (MueLu::RebalanceTransferFactory) +Using original restrictor +repartition: rebalance P and R = 0 +repartition: rebalance Nullspace = 1 [default] +transpose: use implicit = 0 [default] +repartition: use subcommunicators = 1 [default] +type = Restriction +write start = -1 [default] +write end = -1 [default] + +Computing Ac (MueLu::RebalanceAcFactory) +Replacing maps with a subcommunicator +repartition: use subcommunicators = 1 [default] + +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos/Output/smoother12_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/smoother12_tpetra.gold index 2f8a1437a3cf..944799161b5f 100644 --- a/packages/muelu/test/interface/kokkos/Output/smoother12_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/smoother12_tpetra.gold @@ -445,3 +445,5 @@ Smoother (level 4) both : "Ifpack2::Chebyshev": {Initialized: true, Computed: tr Smoother (level 5) pre : solver interface Smoother (level 5) post : no smoother + + diff --git a/packages/muelu/test/interface/kokkos/Output/transpose2_np4_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/transpose2_np4_tpetra.gold index 6baabb462fd8..093215823442 100644 --- a/packages/muelu/test/interface/kokkos/Output/transpose2_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/transpose2_np4_tpetra.gold @@ -268,3 +268,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/muelu/test/interface/kokkos/Output/transpose3_np4_tpetra.gold b/packages/muelu/test/interface/kokkos/Output/transpose3_np4_tpetra.gold index 60f8e2894410..2d6708f117e2 100644 --- a/packages/muelu/test/interface/kokkos/Output/transpose3_np4_tpetra.gold +++ b/packages/muelu/test/interface/kokkos/Output/transpose3_np4_tpetra.gold @@ -268,3 +268,12 @@ Smoother (level 1) both : "Ifpack2::Relaxation": {Initialized: true, Computed: t Smoother (level 2) pre : solver interface Smoother (level 2) post : no smoother +Setup Smoother (MueLu::Amesos2Smoother{type = }) +keep smoother data = 0 [default] +PreSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +PostSmoother data = Teuchos::RCP >{ptr=0,node=0,strong_count=0,weak_count=0} [default] +presmoother -> + A = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + Nullspace = Teuchos::RCP{ptr=0,node=0,strong_count=0,weak_count=0} [default] + fix nullspace = 0 [default] + diff --git a/packages/rol/adapters/tpetra/src/mpi/ROL_PinTVectorCommunication_Tpetra.hpp b/packages/rol/adapters/tpetra/src/mpi/ROL_PinTVectorCommunication_Tpetra.hpp index 92baabcb8c7a..dafcee2f2cb5 100644 --- a/packages/rol/adapters/tpetra/src/mpi/ROL_PinTVectorCommunication_Tpetra.hpp +++ b/packages/rol/adapters/tpetra/src/mpi/ROL_PinTVectorCommunication_Tpetra.hpp @@ -66,9 +66,9 @@ class PinTVectorCommunication_Tpetra : public PinTVectorCommunication { void send(MPI_Comm comm,int rank,Vector & source,int tag=0) const override { auto & tp_source = *dynamic_cast&>(source).getVector(); - tp_source.template sync(); + tp_source.sync_host(); - auto view = tp_source.template getLocalView(); + auto view = tp_source.getLocalViewHost(); // int myRank = -1; // MPI_Comm_rank(comm, &myRank); @@ -82,7 +82,7 @@ class PinTVectorCommunication_Tpetra : public PinTVectorCommunication { void recv(MPI_Comm comm,int rank,Vector & dest,int tag=0) const override { auto & tp_dest = *dynamic_cast&>(dest).getVector(); - auto view = tp_dest.template getLocalView(); + auto view = tp_dest.getLocalViewHost(); // int myRank = -1; // MPI_Comm_rank(comm, &myRank); @@ -98,7 +98,7 @@ class PinTVectorCommunication_Tpetra : public PinTVectorCommunication { void recvSumInto(MPI_Comm comm,int rank,Vector & dest,int tag=0) const override { auto & tp_dest = *dynamic_cast&>(dest).getVector(); - auto view = tp_dest.template getLocalView(); + auto view = tp_dest.getLocalViewHost(); int myRank = -1; MPI_Comm_rank(comm, &myRank);