Skip to content

Commit

Permalink
Merge pull request #11953 from cgcgcg/ifpack2Cheby4Fix
Browse files Browse the repository at this point in the history
Xpetra,MueLu,Zoltan2: Fix build errors
  • Loading branch information
cgcgcg authored Jun 8, 2023
2 parents ad0cb07 + eca01ff commit 4becdfe
Show file tree
Hide file tree
Showing 5 changed files with 13 additions and 14 deletions.
4 changes: 2 additions & 2 deletions packages/muelu/src/Utils/MueLu_UtilitiesBase_def.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -346,8 +346,8 @@ namespace MueLu {
using local_vector_type = typename Vector::dual_view_type::t_dev_um;
using local_matrix_type = typename Matrix::local_matrix_type;
using execution_space = typename local_vector_type::execution_space;
using rowmap_type = typename local_matrix_type::row_map_type;
using entries_type = typename local_matrix_type::index_type;
// using rowmap_type = typename local_matrix_type::row_map_type;
// using entries_type = typename local_matrix_type::index_type;
using values_type = typename local_matrix_type::values_type;
using scalar_type = typename values_type::non_const_value_type;
using mag_type = typename Kokkos::ArithTraits<scalar_type>::mag_type;
Expand Down
2 changes: 1 addition & 1 deletion packages/muelu/src/Utils/MueLu_Utilities_def.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -580,7 +580,7 @@ namespace MueLu {
using XCrsMatrix = Xpetra::CrsMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node>;
using XCrsMatrixWrap = Xpetra::CrsMatrixWrap<Scalar, LocalOrdinal, GlobalOrdinal, Node>;
using BCRS = Tpetra::BlockCrsMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node>;
using CRS = Tpetra::CrsMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node>;
// using CRS = Tpetra::CrsMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node>;
const BCRS & tpetraOp = Utilities<Scalar, LocalOrdinal, GlobalOrdinal, Node>::Op2TpetraBlockCrs(Op);

RCP<BCRS> At;
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -1249,7 +1249,7 @@ namespace Xpetra {

/// \brief Access the local Kokkos::CrsMatrix data
typename local_matrix_type::HostMirror getLocalMatrixHost () const {
TEUCHOS_UNREACHABLE_RETURN(local_matrix_type::HostMirror());
TEUCHOS_UNREACHABLE_RETURN(typename local_matrix_type::HostMirror());
}
/// \brief Access the local Kokkos::CrsMatrix data
local_matrix_type getLocalMatrixDevice () const {
Expand Down
2 changes: 1 addition & 1 deletion packages/zoltan2/sphynx/src/Zoltan2_Sphynx.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -888,7 +888,7 @@ namespace Zoltan2 {
Teuchos::RCP<lproblem_t> innerPolyProblem(new lproblem_t());
innerPolyProblem->setOperator(laplacian_);

using btop_t = Belos::TpetraOperator<scalar_t>;
using btop_t = Belos::TpetraOperator<scalar_t, lno_t, gno_t, node_t>;
Teuchos::RCP<btop_t> polySolver(new btop_t(innerPolyProblem,
Teuchos::rcpFromRef(paramList),
"GmresPoly", true));
Expand Down
17 changes: 8 additions & 9 deletions packages/zoltan2/test/sphynx/Sphynx_Research_Driver.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -409,12 +409,14 @@ int main(int narg, char *arg[])
std::cout << "init = " << init << std::endl;
}

using scalar_type = double;
using local_ordinal_type = int;
using global_ordinal_type = long long;
using scalar_type = Tpetra::Details::DefaultTypes::scalar_type;
using local_ordinal_type = Tpetra::Details::DefaultTypes::local_ordinal_type;
using global_ordinal_type = Tpetra::Details::DefaultTypes::global_ordinal_type;
using node_type = Tpetra::Details::DefaultTypes::node_type;

using crs_matrix_type = Tpetra::CrsMatrix<scalar_type, local_ordinal_type, global_ordinal_type, node_type>;
using map_type = Tpetra::Map<local_ordinal_type, global_ordinal_type, node_type>;
using mv_type = Tpetra::MultiVector<scalar_type, local_ordinal_type, global_ordinal_type, node_type>;
using adapter_type = Zoltan2::XpetraCrsGraphAdapter<typename crs_matrix_type::crs_graph_type>;
using solution_type = Zoltan2::PartitioningSolution<adapter_type>;

Expand Down Expand Up @@ -457,14 +459,11 @@ int main(int narg, char *arg[])
std::cout << "Done with reading/creating the matrix." << std::endl;
}

Teuchos::RCP<const Tpetra::Map<> > map = tmatrix->getMap();
Teuchos::RCP<const map_type> map = tmatrix->getMap();

using ST = double;
using MultiVector = Tpetra::MultiVector<ST>;

Teuchos::RCP<MultiVector > V;
Teuchos::RCP<mv_type> V;
if (vector_file !=""){
V = Tpetra::MatrixMarket::Reader<MultiVector >::readDenseFile(vector_file,pComm,map);
V = Tpetra::MatrixMarket::Reader<mv_type >::readDenseFile(vector_file,pComm,map);
if(me == 0){
std::cout << "Done with reading user-provided eigenvectors." << std::endl;
}
Expand Down

0 comments on commit 4becdfe

Please sign in to comment.