Skip to content

Commit

Permalink
Merge branch 'develop' into tpetra_6158
Browse files Browse the repository at this point in the history
  • Loading branch information
kddevin committed Jan 17, 2020
2 parents 8f1c2e0 + cfb8a10 commit 3e87db0
Show file tree
Hide file tree
Showing 1,865 changed files with 35,856 additions and 293,498 deletions.
7 changes: 0 additions & 7 deletions PackagesList.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -79,18 +79,15 @@ TRIBITS_REPOSITORY_DEFINE_PACKAGES(
AvatarT packages/avatart EX
Zoltan packages/zoltan PT
Shards packages/shards PT
GlobiPack packages/globipack PT
Triutils packages/triutils PT
EpetraExt packages/epetraext PT
Tpetra packages/tpetra PT
TrilinosSS packages/common/auxiliarySoftware/SuiteSparse PT # Auxiliary software.
Domi packages/domi PT
Thyra packages/thyra PT
Xpetra packages/xpetra PT
OptiPack packages/optipack PT
Isorropia packages/isorropia PT
Pliris packages/pliris ST
Claps packages/claps EX
AztecOO packages/aztecoo PT
Galeri packages/galeri PT
Amesos packages/amesos PT
Expand All @@ -102,7 +99,6 @@ TRIBITS_REPOSITORY_DEFINE_PACKAGES(
ShyLU_Node packages/shylu/shylu_node PT
Amesos2 packages/amesos2 PT
SEACAS packages/seacas PT # Depends on netcdf, optionally hdf5, xdmf, pamgen
Trios packages/trios EX #temporary
Komplex packages/komplex ST
Anasazi packages/anasazi PT
Ifpack2 packages/ifpack2 PT
Expand Down Expand Up @@ -138,7 +134,6 @@ TRIBITS_REPOSITORY_DEFINE_PACKAGES(
WebTrilinos packages/WebTrilinos EX # Should be ST
NewPackage packages/new_package EX # Should be ST
Optika packages/optika EX
Mesquite packages/mesquite ST
TrilinosCouplings packages/trilinoscouplings PT
Pike packages/pike PT
xSDKTrilinos packages/xSDKTrilinos ST
Expand Down Expand Up @@ -192,6 +187,4 @@ TRIBITS_DISABLE_PACKAGE_ON_PLATFORMS(Anasazi Windows)
TRIBITS_DISABLE_PACKAGE_ON_PLATFORMS(Isorropia Windows)
TRIBITS_DISABLE_PACKAGE_ON_PLATFORMS(Zoltan Windows)
TRIBITS_DISABLE_PACKAGE_ON_PLATFORMS(Teko Windows)
TRIBITS_DISABLE_PACKAGE_ON_PLATFORMS(Mesquite AIX)
TRIBITS_DISABLE_PACKAGE_ON_PLATFORMS(Trios Windows)
TRIBITS_DISABLE_PACKAGE_ON_PLATFORMS(Panzer Windows)
2 changes: 2 additions & 0 deletions TPLsList.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -58,6 +58,8 @@ TRIBITS_REPOSITORY_DEFINE_TPLS(
yaml-cpp "cmake/TPLs/" EX
Peano "cmake/TPLs/" EX
CUDA "${${PROJECT_NAME}_TRIBITS_DIR}/core/std_tpls/" PT
CUBLAS "cmake/TPLs/" PT
CUSOLVER "cmake/TPLs/" PT
CUSPARSE "cmake/TPLs/" PT
Thrust "cmake/TPLs/" ST
Cusp "cmake/TPLs/" ST
Expand Down
70 changes: 70 additions & 0 deletions cmake/TPLs/FindTPLCUBLAS.cmake
Original file line number Diff line number Diff line change
@@ -0,0 +1,70 @@
# @HEADER
# ************************************************************************
#
# Trilinos: An Object-Oriented Solver Framework
# Copyright (2001) Sandia Corporation
#
#
# Copyright (2001) Sandia Corporation. Under the terms of Contract
# DE-AC04-94AL85000, there is a non-exclusive license for use of this
# work by or on behalf of the U.S. Government. Export of this program
# may require a license from the United States Government.
#
# 1. Redistributions of source code must retain the above copyright
# notice, this list of conditions and the following disclaimer.
#
# 2. Redistributions in binary form must reproduce the above copyright
# notice, this list of conditions and the following disclaimer in the
# documentation and/or other materials provided with the distribution.
#
# 3. Neither the name of the Corporation nor the names of the
# contributors may be used to endorse or promote products derived from
# this software without specific prior written permission.
#
# THIS SOFTWARE IS PROVIDED BY SANDIA CORPORATION "AS IS" AND ANY
# EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE
# IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR
# PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL SANDIA CORPORATION OR THE
# CONTRIBUTORS BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL,
# EXEMPLARY, OR CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO,
# PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR
# PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND ON ANY THEORY OF
# LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT (INCLUDING
# NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF THIS
# SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE.
#
# NOTICE: The United States Government is granted for itself and others
# acting on its behalf a paid-up, nonexclusive, irrevocable worldwide
# license in this data to reproduce, prepare derivative works, and
# perform publicly and display publicly. Beginning five (5) years from
# July 25, 2001, the United States Government is granted for itself and
# others acting on its behalf a paid-up, nonexclusive, irrevocable
# worldwide license in this data to reproduce, prepare derivative works,
# distribute copies to the public, perform publicly and display
# publicly, and to permit others to do so.
#
# NEITHER THE UNITED STATES GOVERNMENT, NOR THE UNITED STATES DEPARTMENT
# OF ENERGY, NOR SANDIA CORPORATION, NOR ANY OF THEIR EMPLOYEES, MAKES
# ANY WARRANTY, EXPRESS OR IMPLIED, OR ASSUMES ANY LEGAL LIABILITY OR
# RESPONSIBILITY FOR THE ACCURACY, COMPLETENESS, OR USEFULNESS OF ANY
# INFORMATION, APPARATUS, PRODUCT, OR PROCESS DISCLOSED, OR REPRESENTS
# THAT ITS USE WOULD NOT INFRINGE PRIVATELY OWNED RIGHTS.
#
# ************************************************************************
# @HEADER

IF (NOT TPL_ENABLE_CUDA)
MESSAGE(FATAL_ERROR "\nCUBLAS: This TPL requires CUDA")
ELSE()
find_library(CUDA_cublas_LIBRARY
cublas
HINTS ${CUDA_TOOLKIT_ROOT_DIR}/lib
)
IF(CUDA_cublas_LIBRARY STREQUAL "CUDA_cublas_LIBRARY-NOTFOUND")
MESSAGE(FATAL_ERROR "\nCUBLAS: could not find cublas library.")
ENDIF()
GLOBAL_SET(TPL_CUBLAS_LIBRARY_DIRS)
GLOBAL_SET(TPL_CUBLAS_INCLUDE_DIRS ${TPL_CUDA_INCLUDE_DIRS})
GLOBAL_SET(TPL_CUBLAS_LIBRARIES ${CUDA_cublas_LIBRARY})
ENDIF()

70 changes: 70 additions & 0 deletions cmake/TPLs/FindTPLCUSOLVER.cmake
Original file line number Diff line number Diff line change
@@ -0,0 +1,70 @@
# @HEADER
# ************************************************************************
#
# Trilinos: An Object-Oriented Solver Framework
# Copyright (2001) Sandia Corporation
#
#
# Copyright (2001) Sandia Corporation. Under the terms of Contract
# DE-AC04-94AL85000, there is a non-exclusive license for use of this
# work by or on behalf of the U.S. Government. Export of this program
# may require a license from the United States Government.
#
# 1. Redistributions of source code must retain the above copyright
# notice, this list of conditions and the following disclaimer.
#
# 2. Redistributions in binary form must reproduce the above copyright
# notice, this list of conditions and the following disclaimer in the
# documentation and/or other materials provided with the distribution.
#
# 3. Neither the name of the Corporation nor the names of the
# contributors may be used to endorse or promote products derived from
# this software without specific prior written permission.
#
# THIS SOFTWARE IS PROVIDED BY SANDIA CORPORATION "AS IS" AND ANY
# EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE
# IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR
# PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL SANDIA CORPORATION OR THE
# CONTRIBUTORS BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL,
# EXEMPLARY, OR CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO,
# PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR
# PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND ON ANY THEORY OF
# LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT (INCLUDING
# NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF THIS
# SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE.
#
# NOTICE: The United States Government is granted for itself and others
# acting on its behalf a paid-up, nonexclusive, irrevocable worldwide
# license in this data to reproduce, prepare derivative works, and
# perform publicly and display publicly. Beginning five (5) years from
# July 25, 2001, the United States Government is granted for itself and
# others acting on its behalf a paid-up, nonexclusive, irrevocable
# worldwide license in this data to reproduce, prepare derivative works,
# distribute copies to the public, perform publicly and display
# publicly, and to permit others to do so.
#
# NEITHER THE UNITED STATES GOVERNMENT, NOR THE UNITED STATES DEPARTMENT
# OF ENERGY, NOR SANDIA CORPORATION, NOR ANY OF THEIR EMPLOYEES, MAKES
# ANY WARRANTY, EXPRESS OR IMPLIED, OR ASSUMES ANY LEGAL LIABILITY OR
# RESPONSIBILITY FOR THE ACCURACY, COMPLETENESS, OR USEFULNESS OF ANY
# INFORMATION, APPARATUS, PRODUCT, OR PROCESS DISCLOSED, OR REPRESENTS
# THAT ITS USE WOULD NOT INFRINGE PRIVATELY OWNED RIGHTS.
#
# ************************************************************************
# @HEADER

IF (NOT TPL_ENABLE_CUDA)
MESSAGE(FATAL_ERROR "\nCUSOLVER: This TPL requires CUDA")
ELSE()
find_library(CUDA_cusolver_LIBRARY
cusolver
HINTS ${CUDA_TOOLKIT_ROOT_DIR}/lib
)
IF(CUDA_cusolver_LIBRARY STREQUAL "CUDA_cusolver_LIBRARY-NOTFOUND")
MESSAGE(FATAL_ERROR "\nCUSOLVER: could not find cusolver library.")
ENDIF()
GLOBAL_SET(TPL_CUSOLVER_LIBRARY_DIRS)
GLOBAL_SET(TPL_CUSOLVER_INCLUDE_DIRS ${TPL_CUDA_INCLUDE_DIRS})
GLOBAL_SET(TPL_CUSOLVER_LIBRARIES ${CUDA_cusolver_LIBRARY})
ENDIF()

Original file line number Diff line number Diff line change
@@ -1,7 +1,5 @@
#!/bin/bash

if [ "${Trilinos_TRACK}" == "" ]; then
export Trilinos_TRACK=ATDM
fi

$WORKSPACE/Trilinos/cmake/ctest/drivers/atdm/cee-rhel6/local-driver.sh
Original file line number Diff line number Diff line change
@@ -1,3 +1,5 @@
#!/bin/bash
export Trilinos_TRACK=ATDM
if [ "${Trilinos_TRACK}" == "" ]; then
export Trilinos_TRACK=ATDM
fi
$WORKSPACE/Trilinos/cmake/ctest/drivers/atdm/cee-rhel6/local-driver.sh
Original file line number Diff line number Diff line change
@@ -0,0 +1,6 @@
#!/bin/bash
#export SLURM_CTEST_TIMEOUT=1:00:00
if [ "${Trilinos_TRACK}" == "" ] ; then
export Trilinos_TRACK=Specialized
fi
$WORKSPACE/Trilinos/cmake/ctest/drivers/atdm/cts1/local-driver.sh
Original file line number Diff line number Diff line change
@@ -0,0 +1,6 @@
#!/bin/bash
#export SLURM_CTEST_TIMEOUT=1:00:00
if [ "${Trilinos_TRACK}" == "" ] ; then
export Trilinos_TRACK=Specialized
fi
$WORKSPACE/Trilinos/cmake/ctest/drivers/atdm/cts1/local-driver.sh
Original file line number Diff line number Diff line change
@@ -0,0 +1,6 @@
#!/bin/bash
#export SLURM_CTEST_TIMEOUT=1:00:00
if [ "${Trilinos_TRACK}" == "" ] ; then
export Trilinos_TRACK=ATDM
fi
$WORKSPACE/Trilinos/cmake/ctest/drivers/atdm/cts1/local-driver.sh
Original file line number Diff line number Diff line change
@@ -0,0 +1,6 @@
#!/bin/bash
#export SLURM_CTEST_TIMEOUT=1:00:00
if [ "${Trilinos_TRACK}" == "" ] ; then
export Trilinos_TRACK=ATDM
fi
$WORKSPACE/Trilinos/cmake/ctest/drivers/atdm/cts1/local-driver.sh
Original file line number Diff line number Diff line change
@@ -1,7 +1,7 @@
#!/bin/bash -l

if [ "${SALLOC_CTEST_TIME_LIMIT_MINUTES}" == "" ] ; then
SALLOC_CTEST_TIME_LIMIT_MINUTES=1:30:00
if [ "${SLURM_CTEST_TIMEOUT}" == "" ] ; then
SLURM_CTEST_TIMEOUT=1:20:00
# This is just running tests, not the entire build!
fi

Expand All @@ -18,4 +18,4 @@ set -x
atdm_run_script_on_compute_node \
$WORKSPACE/Trilinos/cmake/ctest/drivers/atdm/ctest-s-driver-test.sh \
$PWD/ctest-s-driver-test.out \
${SALLOC_CTEST_TIME_LIMIT_MINUTES}
${SLURM_CTEST_TIMEOUT}

This file was deleted.

This file was deleted.

This file was deleted.

This file was deleted.

Original file line number Diff line number Diff line change
Expand Up @@ -67,8 +67,8 @@ SET(CTEST_TEST_TYPE EXPERIMENTAL)
#SET(CTEST_TEST_TIMEOUT 900)

# Explicitly enable the packages to be memory tested.
#SET(Trilinos_PACKAGES Teuchos RTOp Epetra GlobiPack Tpetra EpetraExt
# Sacado Thyra OptiPack AztecOO Ifpack ML Stratimikos Rythmos MOOCHO)
#SET(Trilinos_PACKAGES Teuchos RTOp Epetra Tpetra EpetraExt
# Sacado Thyra AztecOO Ifpack ML Stratimikos Rythmos MOOCHO)

SET(EXTRA_EXCLUDE_PACKAGES SEACAS)

Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -81,7 +81,7 @@ SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF)

SET(Trilinos_BRANCH develop)

SET(EXTRA_EXCLUDE_PACKAGES Claps Optika)
SET(EXTRA_EXCLUDE_PACKAGES Optika)

SET( EXTRA_CONFIGURE_OPTIONS
"-DTrilinos_ENABLE_COMPLEX=$ENV{JENKINS_DO_COMPLEX}"
Expand Down
2 changes: 1 addition & 1 deletion cmake/ctest/drivers/fissile4/checkin-test-fissile4.sh
Original file line number Diff line number Diff line change
Expand Up @@ -38,7 +38,7 @@ TRILINOS_BASE_DIR_ABS=$(readlink -f $TRILINOS_BASE_DIR)
DRIVERS_BASE_DIR="$TRILINOS_BASE_DIR_ABS/Trilinos/cmake/ctest/drivers/fissile4"

# Packages in Trilinos to disable (mostly for auotmated CI server)
DISABLE_PACKAGES=PyTrilinos,Pliris,Claps,STK,TriKota
DISABLE_PACKAGES=PyTrilinos,Pliris,STK,TriKota

# Check to make sure that the env has been loaded correctly
if [ "$LOADED_TRIBITS_DEV_ENV" != "gcc-4.8.3" ] ; then
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
"-j12",
"--ctest-timeout=180",
"--st-extra-builds=",
"--disable-packages=PyTrilinos,Pliris,Claps,STK,TriKota",
"--disable-packages=PyTrilinos,Pliris,STK,TriKota",
"--skip-case-no-email",
"--ctest-options=\"-E '(MueLu_ParameterListInterpreterEpetra|MueLu_ParameterListInterpreterTpetra)'\"",
]
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -75,29 +75,27 @@ SET(Trilinos_PACKAGES MueLu Xpetra Amesos2)

SET(EXTRA_CONFIGURE_OPTIONS
### ETI ###
"-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON"
"-DTpetra_INST_INT_LONG_LONG:BOOL=OFF"
"-DTrilinos_ENABLE_COMPLEX:BOOL=ON"
"-DTeuchos_ENABLE_COMPLEX:BOOL=OFF"
"-DTpetra_INST_COMPLEX_DOUBLE:BOOL=OFF"
"-DTpetra_INST_COMPLEX_FLOAT:BOOL=OFF"
"-DTpetra_INST_SERIAL=ON"
"-D Trilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON"
"-D Trilinos_ENABLE_COMPLEX:BOOL=OFF"
"-D Tpetra_INST_INT_LONG_LONG:BOOL=OFF"
"-D Tpetra_INST_INT_INT:BOOL=ON"
"-D Tpetra_INST_SERIAL=ON"

### MISC ###
"-DTrilinos_ENABLE_DEPENDENCY_UNIT_TESTS:BOOL=OFF"
"-DTeuchos_GLOBALLY_REDUCE_UNITTEST_RESULTS:BOOL=ON"
"-D Trilinos_ENABLE_DEPENDENCY_UNIT_TESTS:BOOL=OFF"
"-D Teuchos_GLOBALLY_REDUCE_UNITTEST_RESULTS:BOOL=ON"

### TPLS ###
"-DTPL_ENABLE_SuperLU:BOOL=ON"
"-DSuperLU_INCLUDE_DIRS:PATH=$ENV{SEMS_SUPERLU_INCLUDE_PATH}"
"-DSuperLU_LIBRARY_DIRS:PATH=$ENV{SEMS_SUPERLU_LIBRARY_PATH}"
"-D SuperLU_INCLUDE_DIRS:PATH=$ENV{SEMS_SUPERLU_INCLUDE_PATH}"
"-D SuperLU_LIBRARY_DIRS:PATH=$ENV{SEMS_SUPERLU_LIBRARY_PATH}"

### PACKAGES CONFIGURATION ###
"-DMueLu_ENABLE_Experimental:BOOL=ON"
"-DMueLu_ENABLE_Kokkos_Refactor:BOOL=ON"
"-DMueLu_ENABLE_Kokkos_Refactor_Use_By_Default:BOOL=ON"
"-DXpetra_ENABLE_Experimental:BOOL=ON"
"-DXpetra_ENABLE_Kokkos_Refactor:BOOL=ON"
"-D MueLu_ENABLE_Experimental:BOOL=ON"
"-D MueLu_ENABLE_Kokkos_Refactor:BOOL=ON"
"-D MueLu_ENABLE_Kokkos_Refactor_Use_By_Default:BOOL=ON"
"-D Xpetra_ENABLE_Experimental:BOOL=ON"
"-D Xpetra_ENABLE_Kokkos_Refactor:BOOL=ON"
)

#
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -68,8 +68,8 @@ SET(CTEST_TEST_TYPE Nightly)

SET(CTEST_DO_MEMORY_TESTING TRUE)

SET(Trilinos_PACKAGES Teuchos RTOp Epetra GlobiPack Tpetra EpetraExt
Sacado Thyra OptiPack AztecOO Ifpack ML Stratimikos Rythmos MOOCHO)
SET(Trilinos_PACKAGES Teuchos RTOp Epetra Tpetra EpetraExt
Sacado Thyra AztecOO Ifpack ML Stratimikos Rythmos MOOCHO)

SET( EXTRA_CONFIGURE_OPTIONS
"-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON"
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -66,7 +66,7 @@ SET(BUILD_DIR_NAME SERIAL_DEBUG_ICPC)
SET(CTEST_TEST_TYPE Experimental)
#SET(CTEST_TEST_TIMEOUT 900)

#SET(Trilinos_PACKAGES Teuchos RTOp GlobiPack Tpetra Thyra OptiPack Stratimikos Phalanx Rythmos MOOCHO)
#SET(Trilinos_PACKAGES Teuchos RTOp Tpetra Thyra Stratimikos Phalanx Rythmos MOOCHO)

SET( EXTRA_CONFIGURE_OPTIONS
"-DTrilinos_ENABLE_Fortran:BOOL=OFF"
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -68,8 +68,8 @@ SET(CTEST_TEST_TYPE Nightly)

SET(CTEST_DO_MEMORY_TESTING TRUE)

SET(Trilinos_PACKAGES Teuchos RTOp Epetra GlobiPack Tpetra EpetraExt
Sacado Thyra OptiPack AztecOO Ifpack ML Stratimikos Rythmos MOOCHO)
SET(Trilinos_PACKAGES Teuchos RTOp Epetra Tpetra EpetraExt
Sacado Thyra AztecOO Ifpack ML Stratimikos Rythmos MOOCHO)

SET( EXTRA_CONFIGURE_OPTIONS
"-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON"
Expand Down
Loading

0 comments on commit 3e87db0

Please sign in to comment.