Skip to content

Commit

Permalink
Run remove_kokkos_subpackages_change_test_names_r.sh (#11545)
Browse files Browse the repository at this point in the history
Again, this changes the names of tests that may not even exist in the Kokkos
test suite anymore since it changes the prefix for these test names.
  • Loading branch information
bartlettroscoe committed Apr 24, 2023
1 parent b26efde commit 5eeb6f6
Show file tree
Hide file tree
Showing 8 changed files with 27 additions and 27 deletions.
Original file line number Diff line number Diff line change
Expand Up @@ -89,7 +89,7 @@ MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER)
set (Trilinos_ENABLE_Epetra OFF CACHE BOOL "We do not want Epetra" FORCE)

# Select test disables
set (KokkosCore_UnitTest_CudaTimingBased_MPI_1_DISABLE ON CACHE BOOL "Not to be run in nightly testing" FORCE)
set (Kokkos_CoreUnitTest_CudaTimingBased_MPI_1_DISABLE ON CACHE BOOL "Not to be run in nightly testing" FORCE)

SET(EXTRA_SYSTEM_CONFIGURE_OPTIONS
"-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}"
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -89,7 +89,7 @@ MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER)
set (Trilinos_ENABLE_Epetra OFF CACHE BOOL "We do not want Epetra" FORCE)

# Select test disables
set (KokkosCore_UnitTest_CudaTimingBased_MPI_1_DISABLE ON CACHE BOOL "Not to be run in nightly testing" FORCE)
set (Kokkos_CoreUnitTest_CudaTimingBased_MPI_1_DISABLE ON CACHE BOOL "Not to be run in nightly testing" FORCE)

SET(EXTRA_SYSTEM_CONFIGURE_OPTIONS
"-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}"
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -117,9 +117,9 @@ set (PanzerMiniEM_MiniEM-BlockPrec_Augmentation_MPI_4_DISABLE ON CACHE BOOL "Tem
set (PanzerMiniEM_MiniEM-BlockPrec_RefMaxwell_MPI_4_DISABLE ON CACHE BOOL "Temporary disable for CUDA PR testing")
set (ROL_example_PDE-OPT_poisson-boltzmann_example_01_MPI_4_DISABLE ON CACHE BOOL "Temporary disable for CUDA PR testing")

# Disable a couple of unit tests in test KokkosCore_UnitTest_Cuda_MPI_1 that
# Disable a couple of unit tests in test Kokkos_CoreUnitTest_Cuda_MPI_1 that
# are randomly failing in PR test iterations (#6799)
set (KokkosCore_UnitTest_Cuda_MPI_1_EXTRA_ARGS
set (Kokkos_CoreUnitTest_Cuda_MPI_1_EXTRA_ARGS
"--gtest_filter=-cuda.debug_pin_um_to_host:cuda.debug_serial_execution"
CACHE STRING "Temporary disable for CUDA PR testing")

Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -117,9 +117,9 @@ set (MueLu_UnitTestsIntrepid2Tpetra_MPI_4_DISABLE ON CACHE BOOL "Temporary disab
#set (PanzerMiniEM_MiniEM-BlockPrec_RefMaxwell_MPI_4_DISABLE ON CACHE BOOL "Temporary disable for CUDA PR testing")
set (ROL_example_PDE-OPT_poisson-boltzmann_example_01_MPI_4_DISABLE ON CACHE BOOL "Temporary disable for CUDA PR testing")

# Disable a couple of unit tests in test KokkosCore_UnitTest_Cuda_MPI_1 that
# Disable a couple of unit tests in test Kokkos_CoreUnitTest_Cuda_MPI_1 that
# are randomly failing in PR test iterations (#6799)
set (KokkosCore_UnitTest_Cuda_MPI_1_EXTRA_ARGS
set (Kokkos_CoreUnitTest_Cuda_MPI_1_EXTRA_ARGS
"--gtest_filter=-cuda.debug_pin_um_to_host:cuda.debug_serial_execution"
CACHE STRING "Temporary disable for CUDA PR testing")

Expand Down
20 changes: 10 additions & 10 deletions cmake/std/atdm/ATDMDisables.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -253,16 +253,16 @@ ATDM_SET_ENABLE(ROL_adapters_tpetra_test_vector_SimulatedVectorTpetraBatchManage
ATDM_SET_ENABLE(ROL_adapters_tpetra_test_vector_SimulatedVectorTpetraBatchManagerInterface_MPI_4_DISABLE ON)

# Disable Kokkos timing based test. See #8545.
ATDM_SET_ENABLE(KokkosCore_UnitTest_CudaTimingBased_MPI_1_DISABLE ON)
ATDM_SET_ENABLE(Kokkos_CoreUnitTest_CudaTimingBased_MPI_1_DISABLE ON)

# Disable serial.Random_XorShift64 due to random failures. See #3282.
ATDM_SET_CACHE(KokkosAlgorithms_UnitTest_MPI_1_EXTRA_ARGS
ATDM_SET_CACHE(Kokkos_AlgorithmsUnitTest_MPI_1_EXTRA_ARGS
"--gtest_filter=-*Random_XorShift64:-*Random_XorShift1024" CACHE STRING)

IF (ATDM_NODE_TYPE STREQUAL "OPENMP")

# Disable ctest DISABLED test (otherwise, this shows up on CDash as "NotRun")
ATDM_SET_ENABLE(KokkosContainers_PerformanceTest_OpenMP_DISABLE ON)
ATDM_SET_ENABLE(Kokkos_ContainersPerformanceTest_OpenMP_DISABLE ON)

ENDIF()

Expand All @@ -272,13 +272,13 @@ IF ("${ATDM_CMAKE_BUILD_TYPE}" STREQUAL "DEBUG")
ATDM_SET_ENABLE(PanzerAdaptersSTK_MixedPoissonExample-ConvTest-Hex-Order-3_DISABLE ON)

# Too expensive for full debug builds after Kokkos 2.99 upgrade
ATDM_SET_ENABLE(KokkosCore_UnitTest_Serial_MPI_1_DISABLE ON)
ATDM_SET_ENABLE(Kokkos_CoreUnitTest_Serial_MPI_1_DISABLE ON)
ATDM_SET_ENABLE(KokkosKernels_blas_serial_MPI_1_DISABLE ON)

IF (ATDM_USE_OPENMP)

# Too expensive for full debug builds after Kokkos 2.99 upgrade
ATDM_SET_ENABLE(KokkosCore_UnitTest_OpenMP_MPI_1_DISABLE ON)
ATDM_SET_ENABLE(Kokkos_CoreUnitTest_OpenMP_MPI_1_DISABLE ON)
ATDM_SET_ENABLE(KokkosKernels_blas_openmp_MPI_1_DISABLE ON)

ENDIF()
Expand Down Expand Up @@ -313,11 +313,11 @@ IF (ATDM_NODE_TYPE STREQUAL "CUDA")
ATDM_SET_ENABLE(Zoltan_ch_simple_zoltan_parallel_DISABLE ON)

# Disable ctest DISABLED test (otherwise, this shows up on CDash as "NotRun")
ATDM_SET_ENABLE(KokkosContainers_PerformanceTest_Cuda_DISABLE ON)
ATDM_SET_ENABLE(Kokkos_ContainersPerformanceTest_Cuda_DISABLE ON)

# Disable a couple of unit tests in test KokkosCore_UnitTest_Cuda_MPI_1
# Disable a couple of unit tests in test Kokkos_CoreUnitTest_Cuda_MPI_1
# (#6799)
ATDM_SET_CACHE(KokkosCore_UnitTest_Cuda_MPI_1_EXTRA_ARGS
ATDM_SET_CACHE(Kokkos_CoreUnitTest_Cuda_MPI_1_EXTRA_ARGS
"--gtest_filter=-cuda.debug_pin_um_to_host:cuda.debug_serial_execution"
CACHE STRING )

Expand All @@ -326,9 +326,9 @@ IF (ATDM_NODE_TYPE STREQUAL "CUDA")
# that this Kokkos inter operability test runs in serial, we ensure that the
# GPU ID is not swapped upon initialize resulting in an invalid Cuda stream.
# See #8544.
ATDM_SET_ENABLE(KokkosCore_UnitTest_CudaInterOpStreams_MPI_1_SET_RUN_SERIAL ON)
ATDM_SET_ENABLE(Kokkos_CoreUnitTest_CudaInterOpStreams_MPI_1_SET_RUN_SERIAL ON)
# See #8543.
ATDM_SET_ENABLE(KokkosCore_UnitTest_CudaInterOpInit_MPI_1_SET_RUN_SERIAL ON)
ATDM_SET_ENABLE(Kokkos_CoreUnitTest_CudaInterOpInit_MPI_1_SET_RUN_SERIAL ON)

# Attempt to address intermittent timeouts reported in #6805
ATDM_SET_ENABLE(KokkosKernels_sparse_cuda_MPI_1_SET_RUN_SERIAL ON)
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -2,7 +2,7 @@
ATDM_SET_ENABLE(TeuchosNumerics_DISABLE_STEQR_TEST ON)

# Disable timing out unit test in this debug build (#3336)
ATDM_SET_ENABLE(KokkosContainers_UnitTest_Serial_MPI_1_DISABLE ON)
ATDM_SET_ENABLE(Kokkos_ContainersUnitTest_Serial_MPI_1_DISABLE ON)

# Disable some unit tests that run too slow in this DEBUG build (#2827)
ATDM_SET_CACHE(KokkosKernels_sparse_serial_MPI_1_EXTRA_ARGS
Expand Down
18 changes: 9 additions & 9 deletions packages/framework/ini-files/config-specs.ini
Original file line number Diff line number Diff line change
Expand Up @@ -349,14 +349,14 @@ opt-set-cmake-var Anasazi_Epetra_OrthoManagerGenTester_0_MPI_4_DISABLE BOOL : ON


# Disable Random_XorShift64 and Random_XorShift1024 due to random failures. See #3282.
opt-set-cmake-var KokkosAlgorithms_UnitTest_MPI_1_EXTRA_ARGS STRING : --gtest_filter=-*Random_XorShift64:-*Random_XorShift1024
opt-set-cmake-var Kokkos_AlgorithmsUnitTest_MPI_1_EXTRA_ARGS STRING : --gtest_filter=-*Random_XorShift64:-*Random_XorShift1024

# Disable this test due to temporary requirement on Kokkos_ENABLE_DEPRECATED_CODE_3
opt-set-cmake-var KokkosCore_UnitTest_Serial1_MPI_1_EXTRA_ARGS STRING : --gtest_filter=-*join_backward_compatibility
opt-set-cmake-var KokkosCore_UnitTest_Serial1_EXTRA_ARGS STRING : --gtest_filter=-*join_backward_compatibility
opt-set-cmake-var Kokkos_CoreUnitTest_Serial1_MPI_1_EXTRA_ARGS STRING : --gtest_filter=-*join_backward_compatibility
opt-set-cmake-var Kokkos_CoreUnitTest_Serial1_EXTRA_ARGS STRING : --gtest_filter=-*join_backward_compatibility
# Disable this test to avoid spurious failures, see kokkos/kokkos#5502
opt-set-cmake-var KokkosCore_UnitTest_Default_MPI_1_EXTRA_ARGS STRING : --gtest_filter=-*defaultdevicetype.shared_space
opt-set-cmake-var KokkosCore_UnitTest_Default_EXTRA_ARGS STRING : --gtest_filter=-*defaultdevicetype.shared_space
opt-set-cmake-var Kokkos_CoreUnitTest_Default_MPI_1_EXTRA_ARGS STRING : --gtest_filter=-*defaultdevicetype.shared_space
opt-set-cmake-var Kokkos_CoreUnitTest_Default_EXTRA_ARGS STRING : --gtest_filter=-*defaultdevicetype.shared_space

# Options from SEMSDevEnv.cmake
opt-set-cmake-var Trilinos_ENABLE_PyTrilinos BOOL : OFF
Expand Down Expand Up @@ -1117,9 +1117,9 @@ opt-set-cmake-var PanzerMiniEM_MiniEM-BlockPrec_Augmentation_MPI_4_DISABLE BOOL
opt-set-cmake-var PanzerMiniEM_MiniEM-BlockPrec_RefMaxwell_MPI_4_DISABLE BOOL : ON
opt-set-cmake-var ROL_example_PDE-OPT_poisson-boltzmann_example_01_MPI_4_DISABLE BOOL : ON

# Disable a couple of unit tests in test KokkosCore_UnitTest_Cuda_MPI_1 that
# Disable a couple of unit tests in test Kokkos_CoreUnitTest_Cuda_MPI_1 that
# are randomly failing in PR test iterations (#6799)
opt-set-cmake-var KokkosCore_UnitTest_Cuda_MPI_1_EXTRA_ARGS STRING : "--gtest_filter=-cuda.debug_pin_um_to_host:cuda.debug_serial_execution"
opt-set-cmake-var Kokkos_CoreUnitTest_Cuda_MPI_1_EXTRA_ARGS STRING : "--gtest_filter=-cuda.debug_pin_um_to_host:cuda.debug_serial_execution"

# Disable a few failing tests for initial release of Cuda 10.1.105 PR build
opt-set-cmake-var EpetraExt_inout_test_LL_MPI_4_DISABLE BOOL : ON
Expand Down Expand Up @@ -1263,7 +1263,7 @@ opt-set-cmake-var Intrepid_test_Discretization_Basis_HGRAD_TRI_Cn_FEM_ORTH_Test_
opt-set-cmake-var Intrepid_test_Discretization_Basis_HGRAD_TRI_Cn_FEM_Test_02_MPI_1_DISABLE BOOL : ON
opt-set-cmake-var Intrepid_test_Discretization_Basis_HGRAD_WEDGE_C1_FEM_Test_02_MPI_1_DISABLE BOOL : ON
opt-set-cmake-var Intrepid_test_Discretization_Basis_HGRAD_WEDGE_I2_FEM_Test_02_MPI_1_DISABLE BOOL : ON
opt-set-cmake-var KokkosCore_UnitTest_CudaTimingBased_MPI_1_DISABLE BOOL : ON
opt-set-cmake-var Kokkos_CoreUnitTest_CudaTimingBased_MPI_1_DISABLE BOOL : ON
opt-set-cmake-var MueLu_UnitTestsTpetra_MPI_1_DISABLE BOOL : ON
opt-set-cmake-var MueLu_UnitTestsTpetra_MPI_4_DISABLE BOOL : ON
opt-set-cmake-var NOX_LOCA_AnasaziJacobianInverse_MPI_1_DISABLE BOOL : ON
Expand Down Expand Up @@ -2057,7 +2057,7 @@ opt-set-cmake-var ROL_example_PDE-OPT_topo-opt_poisson_example_01_MPI_4_DISABLE
opt-set-cmake-var ROL_test_elementwise_TpetraMultiVector_MPI_4_DISABLE BOOL : ON
opt-set-cmake-var STKUnit_tests_stk_mesh_unit_tests_MPI_4_DISABLE BOOL : ON
# This was failing fairly reliably and Nate said it should be okay to disable (https://github.com/trilinos/Trilinos/issues/11678)
opt-set-cmake-var KokkosCore_UnitTest_CudaTimingBased_MPI_1_DISABLE BOOL : ON
opt-set-cmake-var Kokkos_CoreUnitTest_CudaTimingBased_MPI_1_DISABLE BOOL : ON

use RHEL7_POST

Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -332,7 +332,7 @@ opt-set-cmake-var Zoltan2_orderingTestDriverExample_MPI_1_DISABLE BOOL : ON
opt-set-cmake-var Piro_EpetraSolver_MPI_4_DISABLE BOOL : ON
opt-set-cmake-var PanzerAdaptersSTK_PoissonInterfaceExample_2d_diffsideids_MPI_1_DISABLE BOOL : ON
opt-set-cmake-var Anasazi_Epetra_OrthoManagerGenTester_0_MPI_4_DISABLE BOOL : ON
opt-set-cmake-var KokkosAlgorithms_UnitTest_MPI_1_EXTRA_ARGS STRING : --gtest_filter=-*Random_XorShift64:-*Random_XorShift1024
opt-set-cmake-var Kokkos_AlgorithmsUnitTest_MPI_1_EXTRA_ARGS STRING : --gtest_filter=-*Random_XorShift64:-*Random_XorShift1024
opt-set-cmake-var CMAKE_C_COMPILER FILEPATH : ${MPICC|ENV}
opt-set-cmake-var CMAKE_CXX_COMPILER FILEPATH : ${MPICXX|ENV}
opt-set-cmake-var CMAKE_Fortran_COMPILER FILEPATH : ${MPIF90|ENV}
Expand Down

0 comments on commit 5eeb6f6

Please sign in to comment.