trilinos / Trilinos

Primary repository for the Trilinos Project
https://trilinos.org/
Other
1.2k stars 563 forks source link

Ifpack2: build errors with SC=complex<float> #11845

Closed jhux2 closed 1 year ago

jhux2 commented 1 year ago

Bug Report

Reported by @jennloe.

@trilinos/ifpack2 @GrahamBenHarper

GPU compile error ``` packages/ifpack2/src/CMakeFiles/ifpack2.dir/Ifpack2_Details_Chebyshev_OpenMP.cpp.o -c /ascldap/users/jloe/Software/AscicGPUTrilinosDev/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp /ascldap/users/jloe/TrilinosDev/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp(1346): error: no operator "/" matches these operands operand types are: double / std::complex detected during instantiation of "void Ifpack2::Details::Chebyshev::fourthKindApplyImpl(const Ifpack2::Details::Chebyshev::op_type &, const MV &, MV &, int, Ifpack2::Details::Chebyshev::ST, const Ifpack2::Details::Chebyshev::V &) [with ScalarType=std_complex0float0, MV=Tpetra::MultiVector]" (1045): here /ascldap/users/jloe/TrilinosDev/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp(1367): error: no operator "*" matches these operands operand types are: double * const std_complex0float0 detected during instantiation of "void Ifpack2::Details::Chebyshev::fourthKindApplyImpl(const Ifpack2::Details::Chebyshev::op_type &, const MV &, MV &, int, Ifpack2::Details::Chebyshev::ST, const Ifpack2::Details::Chebyshev::V &) [with ScalarType=std_complex0float0, MV=Tpetra::MultiVector]" (1045): here /ascldap/users/jloe/TrilinosDev/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp(1375): error: no operator "*" matches these operands operand types are: double * const std_complex0float0 detected during instantiation of "void Ifpack2::Details::Chebyshev::fourthKindApplyImpl(const Ifpack2::Details::Chebyshev::op_type &, const MV &, MV &, int, Ifpack2::Details::Chebyshev::ST, const Ifpack2::Details::Chebyshev::V &) [with ScalarType=std_complex0float0, MV=Tpetra::MultiVector]" (1045): here /ascldap/users/jloe/TrilinosDev/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp(1388): error: no operator "*" matches these operands operand types are: double * const std_complex0float0 detected during instantiation of "void Ifpack2::Details::Chebyshev::fourthKindApplyImpl(const Ifpack2::Details::Chebyshev::op_type &, const MV &, MV &, int, Ifpack2::Details::Chebyshev::ST, const Ifpack2::Details::Chebyshev::V &) [with ScalarType=std_complex0float0, MV=Tpetra::MultiVector]" (1045): here 4 errors detected in the compilation of "/ascldap/users/jloe/Software/AscicGPUTrilinosDev/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp". ninja: build stopped: subcommand failed. make: *** [all] Error 1 ```
CPU compile error ``` packages/ifpack2/src/CMakeFiles/ifpack2.dir/Ifpack2_DatabaseSchwarz_OpenMP.cpp.o -c /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_DatabaseSchwarz_OpenMP.cpp from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_DatabaseSchwarz_OpenMP.cpp:44: /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:395:5: note: candidate: ‘template std::complex<_Tp> std::operator*(const std::complex<_Tp>&, const _Tp&)’ operator*(const complex<_Tp>& __x, const _Tp& __y) ^~~~~~~~ /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:395:5: note: template argument deduction/substitution failed: In file included from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_DatabaseSchwarz_OpenMP.cpp:50: /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_DatabaseSchwarz_def.hpp:387:54: note: deduced conflicting types for parameter ‘const _Tp’ (‘float’ and ‘__gnu_cxx::__alloc_traits, double>::value_type’ {aka ‘double’}) Y_view(PatchIndices_[ipatch][i],c) += alpha*Weights_[PatchIndices_[ipatch][i]]*x_patch[i]; ~~~~~^~~~~~~~~~ In file included from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ConfigDefs.hpp:94, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ScalarTraits.hpp:56, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_ConfigDefs.hpp:47, from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_DatabaseSchwarz_OpenMP.cpp:44: /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:404:5: note: candidate: ‘template std::complex<_Tp> std::operator*(const _Tp&, const std::complex<_Tp>&)’ operator*(const _Tp& __x, const complex<_Tp>& __y) ^~~~~~~~ /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:404:5: note: template argument deduction/substitution failed: In file included from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_DatabaseSchwarz_OpenMP.cpp:50: /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_DatabaseSchwarz_def.hpp:387:54: note: mismatched types ‘const std::complex<_Tp>’ and ‘const value_type’ {aka ‘const double’} Y_view(PatchIndices_[ipatch][i],c) += alpha*Weights_[PatchIndices_[ipatch][i]]*x_patch[i]; ~~~~~^~~~~~~~~~ from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_DatabaseSchwarz_OpenMP.cpp:44: /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:395:5: note: candidate: ‘template std::complex<_Tp> std::operator*(const std::complex<_Tp>&, const _Tp&)’ operator*(const complex<_Tp>& __x, const _Tp& __y) ^~~~~~~~ /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:395:5: note: template argument deduction/substitution failed: In file included from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_DatabaseSchwarz_OpenMP.cpp:50: /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_DatabaseSchwarz_def.hpp:387:54: note: deduced conflicting types for parameter ‘const _Tp’ (‘float’ and ‘__gnu_cxx::__alloc_traits, double>::value_type’ {aka ‘double’}) Y_view(PatchIndices_[ipatch][i],c) += alpha*Weights_[PatchIndices_[ipatch][i]]*x_patch[i]; ~~~~~^~~~~~~~~~ In file included from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ConfigDefs.hpp:94, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ScalarTraits.hpp:56, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_ConfigDefs.hpp:47, from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_DatabaseSchwarz_OpenMP.cpp:44: /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:404:5: note: candidate: ‘template std::complex<_Tp> std::operator*(const _Tp&, const std::complex<_Tp>&)’ operator*(const _Tp& __x, const complex<_Tp>& __y) ^~~~~~~~ /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:404:5: note: template argument deduction/substitution failed: In file included from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_DatabaseSchwarz_OpenMP.cpp:50: /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_DatabaseSchwarz_def.hpp:387:54: note: mismatched types ‘const std::complex<_Tp>’ and ‘const value_type’ {aka ‘const double’} Y_view(PatchIndices_[ipatch][i],c) += alpha*Weights_[PatchIndices_[ipatch][i]]*x_patch[i]; ~~~~~^~~~~~~~~~ [2/43] Building CXX object packages/ifpack2/src/CMakeFiles/ifpack2.dir/Ifpack2_Details_Chebyshev_OpenMP.cpp.o FAILED: packages/ifpack2/src/CMakeFiles/ifpack2.dir/Ifpack2_Details_Chebyshev_OpenMP.cpp.o /projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/openmpi/1.10.1/bin/mpicxx -DKOKKOS_DEPENDENCE -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/belos/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/belos/src -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/teuchos/core/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/kokkos/core/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos/core/src -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/kokkos -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos/core/src/../../tpls/desul/include -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/parser/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/parameterlist/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/comm/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/numerics/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/remainder/src -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/teuchos/remainder/src -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/teuchos/kokkoscompat/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/kokkoscompat/src -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/teuchos/kokkoscomm/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/kokkoscomm/src -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/epetra/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/epetra/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/tpetra/tsqr/src -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/tpetra/tsqr/src -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/kokkos-kernels/common -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/common -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/kokkos-kernels/batched -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/batched -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/kokkos-kernels/blas -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/blas -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/kokkos-kernels/graph -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/graph -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/kokkos-kernels -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/common/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/common/src/impl -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/common/src/tpls -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/common/unit_test -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/batched/dense/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/batched/dense/impl -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/batched/dense/unit_test -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/batched/sparse/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/batched/sparse/impl -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/batched/sparse/unit_test -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/blas/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/blas/impl -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/blas/eti -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/kokkos-kernels/blas/eti -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/blas/tpls -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/graph/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/graph/impl -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/graph/eti -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/kokkos-kernels/graph/eti -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/sparse/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/sparse/impl -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/sparse/eti -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/kokkos-kernels/sparse/eti -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos-kernels/sparse/tpls -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/kokkos/containers/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos/containers/src -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/kokkos/algorithms/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/kokkos/algorithms/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/tpetra/core/compat -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/tpetra/core/compat -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/tpetra/core/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/tpetra/core/src/kokkos_refactor -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/tpetra/core/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/tpetra/core/inout -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/tpetra/core/inout -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/tpetra/core/ext -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/tpetra/core/ext -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/CrsGraph -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/CrsMatrix -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/BlockedCrsMatrix -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/DistObject -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/Export -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/Headers -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/Import -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/Map -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/BlockedMap -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/MultiVector -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/BlockedMultiVector -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/BlockedVector -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/Operator -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/Platform -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/RowGraph -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/RowMatrix -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/Utils -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/Utils/ForwardDeclaration -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/src/Vector -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/xpetra/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/thyra/core/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/thyra/core/src/interfaces/operator_vector/fundamental -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/thyra/core/src/interfaces/operator_vector/extended -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/thyra/core/src/support/operator_vector/client_support -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/thyra/core/src/support/operator_vector/adapter_support -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/thyra/core/src/interfaces/operator_solve/fundamental -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/thyra/core/src/interfaces/operator_solve/extended -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/thyra/core/src/support/operator_solve/client_support -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/thyra/core/src/interfaces/nonlinear/model_evaluator/fundamental -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/thyra/core/src/support/nonlinear/model_evaluator/client_support -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/thyra/core/src/interfaces/nonlinear/solvers/fundamental -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/thyra/core/src/support/nonlinear/solvers/client_support -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/thyra/core/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/thyra/core/example/operator_vector -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/rtop/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/rtop/src/interfaces -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/rtop/src/support -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/rtop/src/ops_lib -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/rtop/src/lapack -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/rtop/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/thyra/adapters/epetra/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/thyra/adapters/epetraext/src/model_evaluator -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/thyra/adapters/epetraext/src/transformer -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/epetraext/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/epetraext/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/epetraext/src/transform -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/epetraext/src/inout -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/epetraext/src/coloring -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/epetraext/src/model_evaluator -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/epetraext/src/block -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/epetraext/src/restrict -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/triutils/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/triutils/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/thyra/adapters/tpetra/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/sup/Matrix -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/sup/StridedMap -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/xpetra/sup/Utils -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/xpetra/sup -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/belos/epetra/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/belos/epetra/src -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/belos/tpetra/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/belos/tpetra/src -I/ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/belos/xpetra/src -I/ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/belos/xpetra/src -pedantic -Wall -Wno-long-long -Wwrite-strings -fopenmp -O3 -DNDEBUG -fopenmp -std=c++17 -MD -MT packages/ifpack2/src/CMakeFiles/ifpack2.dir/Ifpack2_Details_Chebyshev_OpenMP.cpp.o -MF packages/ifpack2/src/CMakeFiles/ifpack2.dir/Ifpack2_Details_Chebyshev_OpenMP.cpp.o.d -o packages/ifpack2/src/CMakeFiles/ifpack2.dir/Ifpack2_Details_Chebyshev_OpenMP.cpp.o -c /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp In file included from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:50: /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp: In instantiation of ‘void Ifpack2::Details::Chebyshev::fourthKindApplyImpl(const op_type&, const MV&, MV&, int, Ifpack2::Details::Chebyshev::ST, const V&) [with ScalarType = std::complex; MV = Tpetra::MultiVector, int, long long int, Tpetra::KokkosCompat::KokkosDeviceWrapperNode >; Ifpack2::Details::Chebyshev::op_type = Tpetra::Operator, int, long long int, Tpetra::KokkosCompat::KokkosDeviceWrapperNode >; typename MV::node_type = Tpetra::KokkosCompat::KokkosDeviceWrapperNode; typename MV::global_ordinal_type = long long int; typename MV::local_ordinal_type = int; typename MV::scalar_type = std::complex; Ifpack2::Details::Chebyshev::ST = std::complex; Ifpack2::Details::Chebyshev::V = Tpetra::Vector, int, long long int, Tpetra::KokkosCompat::KokkosDeviceWrapperNode >]’: /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:61:1: required from here /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp:1346:25: error: no match for ‘operator/’ (operand types are ‘double’ and ‘std::complex’) const ST invEig = 1.0 / (lambdaMax * boostFactor_); ~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~ In file included from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ConfigDefs.hpp:94, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ScalarTraits.hpp:56, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_ConfigDefs.hpp:47, from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:44: /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:416:5: note: candidate: ‘template std::complex<_Tp> std::operator/(const std::complex<_Tp>&, const std::complex<_Tp>&)’ operator/(const complex<_Tp>& __x, const complex<_Tp>& __y) ^~~~~~~~ /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:416:5: note: template argument deduction/substitution failed: In file included from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:50: /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp:1346:25: note: mismatched types ‘const std::complex<_Tp>’ and ‘double’ const ST invEig = 1.0 / (lambdaMax * boostFactor_); ~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~ In file included from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ConfigDefs.hpp:94, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ScalarTraits.hpp:56, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_ConfigDefs.hpp:47, from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:44: /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:425:5: note: candidate: ‘template std::complex<_Tp> std::operator/(const std::complex<_Tp>&, const _Tp&)’ operator/(const complex<_Tp>& __x, const _Tp& __y) ^~~~~~~~ /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:425:5: note: template argument deduction/substitution failed: In file included from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:50: /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp:1346:25: note: mismatched types ‘const std::complex<_Tp>’ and ‘double’ const ST invEig = 1.0 / (lambdaMax * boostFactor_); ~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~ In file included from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ConfigDefs.hpp:94, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ScalarTraits.hpp:56, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_ConfigDefs.hpp:47, from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:44: /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:434:5: note: candidate: ‘template std::complex<_Tp> std::operator/(const _Tp&, const std::complex<_Tp>&)’ operator/(const _Tp& __x, const complex<_Tp>& __y) ^~~~~~~~ /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:434:5: note: template argument deduction/substitution failed: In file included from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:50: /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp:1346:25: note: deduced conflicting types for parameter ‘_Tp’ (‘double’ and ‘float’) const ST invEig = 1.0 / (lambdaMax * boostFactor_); ~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~ /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp:1367:30: error: no match for ‘operator*’ (operand types are ‘double’ and ‘const ST’ {aka ‘const std::complex’}) ck_->compute (Z, 4.0/3.0 * invEig, const_cast (D_inv), ~~~~~~~~^~~~~~~~ In file included from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ConfigDefs.hpp:94, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ScalarTraits.hpp:56, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_ConfigDefs.hpp:47, from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:44: /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:386:5: note: candidate: ‘template std::complex<_Tp> std::operator*(const std::complex<_Tp>&, const std::complex<_Tp>&)’ operator*(const complex<_Tp>& __x, const complex<_Tp>& __y) ^~~~~~~~ /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:386:5: note: template argument deduction/substitution failed: In file included from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:50: /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp:1367:30: note: mismatched types ‘const std::complex<_Tp>’ and ‘double’ ck_->compute (Z, 4.0/3.0 * invEig, const_cast (D_inv), ~~~~~~~~^~~~~~~~ In file included from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ConfigDefs.hpp:94, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ScalarTraits.hpp:56, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_ConfigDefs.hpp:47, from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:44: /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:395:5: note: candidate: ‘template std::complex<_Tp> std::operator*(const std::complex<_Tp>&, const _Tp&)’ operator*(const complex<_Tp>& __x, const _Tp& __y) ^~~~~~~~ /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:395:5: note: template argument deduction/substitution failed: In file included from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:50: /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp:1367:30: note: mismatched types ‘const std::complex<_Tp>’ and ‘double’ ck_->compute (Z, 4.0/3.0 * invEig, const_cast (D_inv), ~~~~~~~~^~~~~~~~ In file included from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ConfigDefs.hpp:94, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ScalarTraits.hpp:56, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_ConfigDefs.hpp:47, from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:44: /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:404:5: note: candidate: ‘template std::complex<_Tp> std::operator*(const _Tp&, const std::complex<_Tp>&)’ operator*(const _Tp& __x, const complex<_Tp>& __y) ^~~~~~~~ /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:404:5: note: template argument deduction/substitution failed: In file included from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:50: /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp:1367:30: note: deduced conflicting types for parameter ‘_Tp’ (‘double’ and ‘float’) ck_->compute (Z, 4.0/3.0 * invEig, const_cast (D_inv), ~~~~~~~~^~~~~~~~ /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp:1375:56: error: no match for ‘operator*’ (operand types are ‘double’ and ‘const ST’ {aka ‘const std::complex’}) firstIterationWithZeroStartingSolution (Z, 4.0/3.0 * invEig, D_inv, B, X4); ~~~~~~~~^~~~~~~~ In file included from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ConfigDefs.hpp:94, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ScalarTraits.hpp:56, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_ConfigDefs.hpp:47, from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:44: /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:386:5: note: candidate: ‘template std::complex<_Tp> std::operator*(const std::complex<_Tp>&, const std::complex<_Tp>&)’ operator*(const complex<_Tp>& __x, const complex<_Tp>& __y) ^~~~~~~~ /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:386:5: note: template argument deduction/substitution failed: In file included from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:50: /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp:1375:56: note: mismatched types ‘const std::complex<_Tp>’ and ‘double’ firstIterationWithZeroStartingSolution (Z, 4.0/3.0 * invEig, D_inv, B, X4); ~~~~~~~~^~~~~~~~ In file included from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ConfigDefs.hpp:94, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ScalarTraits.hpp:56, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_ConfigDefs.hpp:47, from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:44: /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:395:5: note: candidate: ‘template std::complex<_Tp> std::operator*(const std::complex<_Tp>&, const _Tp&)’ operator*(const complex<_Tp>& __x, const _Tp& __y) ^~~~~~~~ /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:395:5: note: template argument deduction/substitution failed: In file included from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:50: /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp:1375:56: note: mismatched types ‘const std::complex<_Tp>’ and ‘double’ firstIterationWithZeroStartingSolution (Z, 4.0/3.0 * invEig, D_inv, B, X4); ~~~~~~~~^~~~~~~~ In file included from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ConfigDefs.hpp:94, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ScalarTraits.hpp:56, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_ConfigDefs.hpp:47, from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:44: /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:404:5: note: candidate: ‘template std::complex<_Tp> std::operator*(const _Tp&, const std::complex<_Tp>&)’ operator*(const _Tp& __x, const complex<_Tp>& __y) ^~~~~~~~ /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:404:5: note: template argument deduction/substitution failed: In file included from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:50: /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp:1375:56: note: deduced conflicting types for parameter ‘_Tp’ (‘double’ and ‘float’) firstIterationWithZeroStartingSolution (Z, 4.0/3.0 * invEig, D_inv, B, X4); ~~~~~~~~^~~~~~~~ /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp:1388:57: error: no match for ‘operator*’ (operand types are ‘double’ and ‘const ST’ {aka ‘const std::complex’}) const ST rScale = (8.0 * i + 4.0) / (2.0 * i + 3.0) * invEig; ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~ In file included from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ConfigDefs.hpp:94, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ScalarTraits.hpp:56, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_ConfigDefs.hpp:47, from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:44: /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:386:5: note: candidate: ‘template std::complex<_Tp> std::operator*(const std::complex<_Tp>&, const std::complex<_Tp>&)’ operator*(const complex<_Tp>& __x, const complex<_Tp>& __y) ^~~~~~~~ /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:386:5: note: template argument deduction/substitution failed: In file included from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:50: /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp:1388:57: note: mismatched types ‘const std::complex<_Tp>’ and ‘double’ const ST rScale = (8.0 * i + 4.0) / (2.0 * i + 3.0) * invEig; ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~ In file included from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ConfigDefs.hpp:94, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ScalarTraits.hpp:56, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_ConfigDefs.hpp:47, from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:44: /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:395:5: note: candidate: ‘template std::complex<_Tp> std::operator*(const std::complex<_Tp>&, const _Tp&)’ operator*(const complex<_Tp>& __x, const _Tp& __y) ^~~~~~~~ /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:395:5: note: template argument deduction/substitution failed: In file included from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:50: /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp:1388:57: note: mismatched types ‘const std::complex<_Tp>’ and ‘double’ const ST rScale = (8.0 * i + 4.0) / (2.0 * i + 3.0) * invEig; ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~ In file included from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ConfigDefs.hpp:94, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/teuchos/core/src/Teuchos_ScalarTraits.hpp:56, from /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_ConfigDefs.hpp:47, from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:44: /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:404:5: note: candidate: ‘template std::complex<_Tp> std::operator*(const _Tp&, const std::complex<_Tp>&)’ operator*(const _Tp& __x, const complex<_Tp>& __y) ^~~~~~~~ /net/sherlock.sandia.gov/storage/fast/projects/sems/install/rhel7-x86_64/sems/compiler/gcc/8.3.0/base/include/c++/8.3.0/complex:404:5: note: template argument deduction/substitution failed: In file included from /ascldap/users/jloe/TrilinosInstalls/DenseAbstractTest/packages/ifpack2/src/Ifpack2_Details_Chebyshev_OpenMP.cpp:50: /ascldap/users/jloe/TrilinosDenseRemove/Trilinos/packages/ifpack2/src/Ifpack2_Details_Chebyshev_def.hpp:1388:57: note: deduced conflicting types for parameter ‘_Tp’ (‘double’ and ‘float’) const ST rScale = (8.0 * i + 4.0) / (2.0 * i + 3.0) * invEig; ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~ ninja: build stopped: subcommand failed. make: *** [all] Error 1 ```
github-actions[bot] commented 1 year ago

Automatic mention of the @trilinos/ifpack2 team

jhux2 commented 1 year ago

@jennloe I'm not able to reproduce with SC=complex (with either Serial or OpenMP node type). Could you please post a minimal module list and cmake configure line?

GrahamBenHarper commented 1 year ago

@jennloe the DatabaseSchwarz issues are definitely from #11517. I'm working on reproducing them, but please let me know if you can share a configure script.

cgcgcg commented 1 year ago

There are also Chebyshev errors. My best guess is that this is caused by other changes on @jennloe's branch.

cgcgcg commented 1 year ago

Oh, is it possible that this is building with complex<float> enabled?

jennloe commented 1 year ago

Yes, I am building with complex<float> enabled. I have not touched anything in ifpack2, so I don't think the issue is from any changes I've made. The GPU errors were directly from building Trilinos develop, without my changes. My config is as follows:

-D TPL_ENABLE_MPI=ON \
-D Trilinos_ENABLE_Belos:BOOL=ON \
-D Trilinos_ENABLE_Teuchos:BOOL=ON \
-D Trilinos_ENABLE_Epetra:BOOL=ON \
-D Trilinos_ENABLE_Ifpack:BOOL=ON \
-D Trilinos_ENABLE_EpetraExt:BOOL=ON \
-D Trilinos_ENABLE_Triutils:BOOL=ON \
-D Trilinos_ENABLE_Tpetra:BOOL=ON \
-D Trilinos_ENABLE_Xpetra:BOOL=ON \
-D Trilinos_ENABLE_Ifpack2:BOOL=ON \
-D Trilinos_ENABLE_Thyra:BOOL=ON \
-D Trilinos_ENABLE_Stratimikos:BOOL=ON \
-D Trilinos_ENABLE_ALL_OPTIONAL_PACKAGES:BOOL=OFF \
-D Teuchos_ENABLE_COMPLEX:BOOL=ON \
-D Trilinos_ENABLE_COMPLEX:BOOL=ON \
-D Trilinos_ENABLE_OpenMP:BOOL=ON \
-D Trilinos_ENABLE_EXAMPLES:BOOL=ON \
-D Trilinos_ENABLE_TESTS:BOOL=ON \
-D KokkosKernels_ENABLE_TPL_BLAS:BOOL=ON \
-D Trilinos_ENABLE_FLOAT:BOOL=ON \
-D Teuchos_ENABLE_FLOAT:BOOL=ON \
-D HAVE_TEUCHOS_BLASFLOAT:BOOL=ON \
-D KokkosKernels_INST_FLOAT:BOOL=ON \
-D TPL_ENABLE_BLAS:STRING=ON \
-D TPL_BLAS_LIBRARIES:STRING=${BLAS_LIBRARIES} \
-D TPL_ENABLE_LAPACK:STRING=ON \
-D TPL_LAPACK_LIBRARIES:STRING=${LAPACK_LIBRARIES} \
csiefer2 commented 1 year ago

complex is not something we test. And the last time I tried it, lots of thing didn't work.

jhux2 commented 1 year ago

Yes, I am building with complex<float> enabled. I have not touched anything in ifpack2, so I don't think the issue is from any changes I've made. The GPU errors were directly from building Trilinos develop, without my changes. My config is as follows:

Ah, this explains how we didn't see this. PR testing enablescomplex<double> -- is this sufficient for your needs? @csiefer2's comment makes me wonder if this is just the tip of the iceberg.

cgcgcg commented 1 year ago

We test complex<double> I think? I don't think anyone uses complex<float>, and there is no testing for it.

jennloe commented 1 year ago

I guess my question would be whether this still shows up with float on but complex<float> off?

jhux2 commented 1 year ago

I guess my question would be whether this still shows up with float on but complex<float> off?

Good question -- I don't believe PR testing covers float, either.

cgcgcg commented 1 year ago

We added a nightly build for float on lightsaber for that reason.

jhux2 commented 1 year ago

@cgcgcg Ah, that's right, thanks. @jennloe that build looks clean, and covers these packages:

KokkosCore KokkosContainers KokkosAlgorithms KokkosSimd Kokkos TeuchosCore TeuchosParser TeuchosParameterList TeuchosComm TeuchosNumerics TeuchosRemainder TeuchosKokkosCompat TeuchosKokkosComm Teuchos KokkosKernels RTOp Sacado Zoltan Shards Triutils TpetraTSQR TpetraCore Tpetra TrilinosSS ThyraCore ThyraTpetraAdapters Thyra Xpetra Galeri Pamgen Zoltan2Core Belos ShyLU_NodeHTS ShyLU_NodeTacho ShyLU_Node Amesos2 Anasazi Ifpack2 Stratimikos Teko Intrepid2 MueLu

jennloe commented 1 year ago

Okay, that sounds fine. We can close the issue, then.