diff --git a/cmake/ctest/drivers/apollo/CMakeLists.txt b/cmake/ctest/drivers/apollo/CMakeLists.txt deleted file mode 100644 index 22986c246b2b..000000000000 --- a/cmake/ctest/drivers/apollo/CMakeLists.txt +++ /dev/null @@ -1,11 +0,0 @@ -TRILINOS_DRIVER_SETUP() - -TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_Downstream_ETI_SERIAL-${Tpetra_INST_SERIAL}_OPENMP-${Tpetra_INST_OPENMP}_PTHREAD-${Tpetra_INST_PTHREAD}_CUDA-${Tpetra_INST_CUDA}_COMPLEX-${Teuchos_ENABLE_COMPLEX} - ctest_linux_nightly_mpi_release_downstream_ETI_generic_perseus.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 420 -) - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/apollo/TrilinosCTestDriverCore.perseus.generic.cmake b/cmake/ctest/drivers/apollo/TrilinosCTestDriverCore.perseus.generic.cmake deleted file mode 100644 index 0236b2380880..000000000000 --- a/cmake/ctest/drivers/apollo/TrilinosCTestDriverCore.perseus.generic.cmake +++ /dev/null @@ -1,130 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for typhon using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - SET(Trilinos_REPOSITORY_LOCATION_NIGHTLY_DEFAULT "git@github.com:muelu/Trilinos.git") - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j16 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "1" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENDENCY_UNIT_TESTS:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=ON" - - "-D Trilinos_ENABLE_CXX11=ON" - - "-DTPL_ENABLE_BLAS:BOOL=ON" - "-DTPL_ENABLE_LAPACK:BOOL=ON" - "-DSuperLU_INCLUDE_DIRS:PATH=$ENV{SEMS_SUPERLU_INCLUDE_PATH}" - "-DSuperLU_LIBRARY_DIRS:PATH=$ENV{SEMS_SUPERLU_LIBRARY_PATH}" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu" - "-DBoost_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_BOOST_INCLUDE_PATH}" - "-DBoost_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_BOOST_LIBRARY_PATH}" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_BOOST_INCLUDE_PATH}" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_BOOST_LIBRARY_PATH}" - "-DHDF5_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_HDF5_INCLUDE_PATH}" - "-DHDF5_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_HDF5_LIBRARY_PATH}" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_NETCDF_INCLUDE_PATH}" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_NETCDF_LIBRARY_PATH}" - "-DZlib_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_ZLIB_INCLUDE_PATH}" - "-DZlib_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_ZLIB_LIBRARY_PATH}" - "-DTPL_ENABLE_X11:BOOL=OFF" - - ) - - SET_DEFAULT(COMPILER_VERSION "$ENV{SEMS_COMPILER_NAME}-$ENV{SEMS_COMPILER_VERSION}") - - #Ensuring that MPI is on for all parallel builds that might be run. - IF(COMM_TYPE STREQUAL MPI) - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR=$ENV{SEMS_OPENMPI_ROOT}" - "-D MPI_CXX_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicxx" - "-D MPI_C_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicc" - "-D MPI_FORTRAN_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpifort" - "-D CMAKE_CXX_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicxx" - "-D CMAKE_C_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicc" - "-D CMAKE_FORTRAN_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpifort" - "-D MPI_EXEC:FILEPATH=${MPI_BASE_DIR}/bin/mpirun" - "-DMPI_EXEC_POST_NUMPROCS_FLAGS:STRING=--bind-to-socket" - - ) - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/apollo/TrilinosCTestDriverCore.perseus.jenkins.cmake b/cmake/ctest/drivers/apollo/TrilinosCTestDriverCore.perseus.jenkins.cmake deleted file mode 100644 index 015cf0c001d1..000000000000 --- a/cmake/ctest/drivers/apollo/TrilinosCTestDriverCore.perseus.jenkins.cmake +++ /dev/null @@ -1,123 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for typhon using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET(Trilinos_REPOSITORY_LOCATION "$ENV{WORKSPACE}/Trilinos") - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j8 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "1" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENDENCY_UNIT_TESTS:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=ON" - - "-DMPI_BASE_DIR=$ENV{SEMS_OPENMPI_ROOT}" - "-D MPI_CXX_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicxx" - "-D MPI_C_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicc" - "-D MPI_FORTRAN_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpifort" - "-D CMAKE_CXX_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicxx" - "-D CMAKE_C_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicc" - "-D CMAKE_FORTRAN_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpifort" - "-D MPI_EXEC:FILEPATH=${MPI_PATH}/bin/mpirun" - "-D MPI_EXEC_POST_NUMPROCS_FLAGS:STRING=-bind-to-socket" - - "-DTPL_ENABLE_BLAS:BOOL=ON" - "-DTPL_ENABLE_LAPACK:BOOL=ON" - "-DTPL_SuperLU_LIBRARIES=${SEMS_SUPERLU_LIBRARY_PATH}/libsuperlu.a" - "-DTPL_SuperLU_INCLUDE_DIRS=$SEMS_SUPERLU_INCLUDE_PATH" - "-DTPL_ENABLE_X11:BOOL=OFF" - - - "-DCUDA_TOOLKIT_ROOT_DIR=$ENV{CUDA_ROOT}" - ) - - IF ($ENV{SEMS_COMPILER_NAME} STREQUAL gcc) - SET_DEFAULT(COMPILER_VERSION "GCC-$ENV{SEMS_COMPILER_VERSION}") - ELSE () - SET_DEFAULT(COMPILER_VERSION "Intel-$ENV{SEMS_COMPILER_VERSION}") - ENDIF() - - #Ensuring that MPI is on for all parallel builds that might be run. - IF(COMM_TYPE STREQUAL MPI) - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - ) - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/apollo/cron_driver.sh b/cmake/ctest/drivers/apollo/cron_driver.sh deleted file mode 100755 index ee137d81a9cc..000000000000 --- a/cmake/ctest/drivers/apollo/cron_driver.sh +++ /dev/null @@ -1,68 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on typhon: `date`" -echo - -# -# TrilinosDriver settings: -# - -export TDD_PARALLEL_LEVEL=1 - -# Trilinos settings: -# - -# Submission mode for the *TrilinosDriver* dashboard -export TDD_CTEST_TEST_TYPE=${JENKINS_JOB_TYPE} - -#export CTEST_DO_SUBMIT=FALSE -#export CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=FALSE - -# Machine specific environment -# -source /projects/sems/modulefiles/utils/sems-modules-init.sh -module purge -module load sems-env -module load kokkos-env - -module load sems-python/2.7.9 -module load sems-cmake/3.10.3 -module load sems-git/2.1.3 -module load sems-${COMPILER_SUFFIX} - -export TRIBITS_TDD_USE_SYSTEM_CTEST=1 -export TDD_HTTP_PROXY="http://sonproxy.sandia.gov:80" -export http_proxy="http://sonproxy.sandia.gov:80" -export CUDA_LAUNCH_BLOCKING=1 -export CUDA_MANAGED_FORCE_DEVICE_ALLOC=1 -export OMP_NUM_THREADS=2 -export OMP_PROC_BIND=false - -# Machine independent cron_driver: -# -#openmpi-1.7-cuda6 - -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` - -if [ "${JENKINS_DO_CUDA}" == 'ON' ]; then - module load kokkos-${CUDA_SUFFIX} - module load kokkos-${MPI_SUFFIX}/cuda - export OMPI_CXX=$WORKSPACE/Trilinos/packages/kokkos/bin/nvcc_wrapper -else - module load sems-${MPI_SUFFIX} -fi - - -module load sems-${BOOST_SUFFIX}/base -module load sems-${HDF5_SUFFIX}/parallel -module load sems-${NETCDF_SUFFIX}/exo_parallel -module load sems-${ZLIB_SUFFIX}/base - -module list - -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on typhon: `date`" -echo diff --git a/cmake/ctest/drivers/apollo/ctest_linux_nightly_mpi_debug_muelu_extratypes_ei_negima_jenkins.cmake b/cmake/ctest/drivers/apollo/ctest_linux_nightly_mpi_debug_muelu_extratypes_ei_negima_jenkins.cmake deleted file mode 100644 index 8d253a322d58..000000000000 --- a/cmake/ctest/drivers/apollo/ctest_linux_nightly_mpi_debug_muelu_extratypes_ei_negima_jenkins.cmake +++ /dev/null @@ -1,84 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.perseus.jenkins.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME OPENMPI_1.8.7_DEBUG_DEV_MueLu_ExtraTypes_EI_WITH_KOKKOS_$ENV{KOKKOS_BRANCH}) -SET(CTEST_PARALLEL_LEVEL 8) -SET(CTEST_TEST_TYPE Nightly) -SET(CTEST_TEST_TIMEOUT 1800) - -SET(Trilinos_PACKAGES MueLu Xpetra Amesos2) - -SET(EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTpetra_ENABLE_INT_LONG_LONG:BOOL=ON" - - "-DZoltan2_ENABLE_Experimental:BOOL=ON" - "-DTPL_ENABLE_SuperLU:BOOL=ON" -) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/apollo/ctest_linux_nightly_mpi_release_downstream_ETI_generic_perseus.cmake b/cmake/ctest/drivers/apollo/ctest_linux_nightly_mpi_release_downstream_ETI_generic_perseus.cmake deleted file mode 100644 index b9de8211a05a..000000000000 --- a/cmake/ctest/drivers/apollo/ctest_linux_nightly_mpi_release_downstream_ETI_generic_perseus.cmake +++ /dev/null @@ -1,102 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.perseus.generic.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_RELEASE_DEV_DownStream_ETI_SERIAL-$ENV{JENKINS_DO_SERIAL}_OPENMP-$ENV{JENKINS_DO_OPENMP}_PTHREAD-$ENV{JENKINS_DO_PTHREAD}_CUDA-$ENV{JENKINS_DO_CUDA}_COMPLEX-$ENV{JENKINS_DO_COMPLEX}) -SET(CTEST_PARALLEL_LEVEL 1) -SET(CTEST_TEST_TYPE $ENV{JENKINS_JOB_TYPE}) -SET(Trilinos_TRACK Nightly) # set the CDash track -SET(CTEST_TEST_TIMEOUT 300) - -SET(Trilinos_PACKAGES Kokkos Tpetra Belos Ifpack2 MueLu Amesos Amesos2 Ifpack Epetra EpetraExt Zoltan Zoltan2 Xpetra Panzer Intrepid Intrepid2 STK Seacas Anasazi Phalanx Sacado Stokhos Shylu Stratimikos Thyra) - -SET(EXTRA_CONFIGURE_OPTIONS - "-DTPL_ENABLE_SuperLU=OFF" - "-DTPL_ENABLE_Matio=OFF" - - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTeuchos_ENABLE_COMPLEX:BOOL=$ENV{JENKINS_DO_COMPLEX}" - "-DTrilinos_ENABLE_OpenMP:BOOL=$ENV{JENKINS_DO_OPENMP}" - "-DTPL_ENABLE_HWLOC:STRING=OFF" - "-DTPL_ENABLE_CUDA:STRING=$ENV{JENKINS_DO_CUDA}" - - "-DKokkos_ENABLE_Pthread:BOOL=$ENV{JENKINS_DO_PTHREAD}" - "-DKokkos_ENABLE_Cuda_UVM:BOOL=$ENV{JENKINS_DO_CUDA}" - "-DKokkos_ENABLE_Cuda_Lambda:BOOL=$ENV{JENKINS_DO_CUDA}" - - "-DTpetra_INST_SERIAL:BOOL=$ENV{JENKINS_DO_SERIAL}" - "-DTpetra_INST_OPENMP:BOOL=$ENV{JENKINS_DO_OPENMP}" - "-DTpetra_INST_PTHREAD:BOOL=$ENV{JENKINS_DO_PTHREAD}" - "-DTpetra_INST_CUDA:BOOL=$ENV{JENKINS_DO_CUDA}" - "-D Tpetra_INST_COMPLEX_DOUBLE:BOOL=$ENV{JENKINS_DO_COMPLEX}" - "-D MueLu_INST_DOUBLE_INT_LONGINT:BOOL=ON" - - "-DCMAKE_CXX_FLAGS=$ENV{JENKINS_CMAKE_FLAGS}" -) - -#"-DMPI_EXEC_POST_NUMPROCS_FLAGS:STRING=-bind-to;socket;--map-by;socket" -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/apollo/jenkins_driver.sh b/cmake/ctest/drivers/apollo/jenkins_driver.sh deleted file mode 100755 index 51cdc1aaab1b..000000000000 --- a/cmake/ctest/drivers/apollo/jenkins_driver.sh +++ /dev/null @@ -1,81 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on typhon: `date`" -echo - -# snapshot_kokkos_into_trilinos -snapshot_kokkos_into_trilinos() { - cd $WORKSPACE/Trilinos && git reset --hard HEAD && cd - - cd $WORKSPACE/kokkos && git reset --hard origin/$1 && cd - - $WORKSPACE/kokkos/config/snapshot.py -n $WORKSPACE/kokkos $WORKSPACE/Trilinos/packages || { echo "SNAPSHOT FAILED!" && exit 1; } - export KOKKOS_BRANCH=$1 -} - -# -# TrilinosDriver settings: -# - -export TDD_PARALLEL_LEVEL=2 - -# Trilinos settings: -# - -# Submission mode for the *TrilinosDriver* dashboard -export TDD_CTEST_TEST_TYPE=Nightly -export TRIBITS_TDD_USE_SYSTEM_CTEST=1 - -#export CTEST_DO_SUBMIT=FALSE -#export CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=FALSE - -# Machine specific environment -# - -source /projects/modulefiles/utils/sems-modules-init.sh -source /projects/modulefiles/utils/kokkos-modules-init.sh - -module load python/2.7.9 -module load cuda/6.5.14 -module load cmake/2.8.11 -module load git - -export FROM_JENKINS=1 -export TDD_HTTP_PROXY="http://sonproxy.sandia.gov:80" -export http_proxy="http://sonproxy.sandia.gov:80" -export CUDA_LAUNCH_BLOCKING=1 -export OMP_NUM_THREADS=2 - -# Machine independent cron_driver: -# -#openmpi-1.7-cuda6 - -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` - -module load intel/15.0.2/openmpi/1.8.7/cuda/6.5.14 -module load superlu/4.3/intel/15.0.2/base - -export KOKKOS_BRANCH=master -$SCRIPT_DIR/../cron_driver.py - -snapshot_kokkos_into_trilinos develop -$SCRIPT_DIR/../cron_driver.py - -# module unload intel/15.0.2/openmpi/1.8.7/cuda/6.5.14 -# module unload superlu/4.3/intel/15.0.2/base - -# module load gcc/4.8.4/openmpi/1.8.7/cuda/6.5.14 -# module load superlu/4.3/gcc/4.8.4/base - -# cd $WORKSPACE/Trilinos && git reset --hard HEAD && cd - -# $SCRIPT_DIR/../cron_driver.py - -# snapshot_kokkos_into_trilinos develop -# $SCRIPT_DIR/../cron_driver.py - -git status - -cd $WORKSPACE/Trilinos && git reset --hard HEAD && cd - - -echo -echo "Ending nightly Trilinos development testing on typhon: `date`" -echo diff --git a/cmake/ctest/drivers/artemis/CMakeLists.txt b/cmake/ctest/drivers/artemis/CMakeLists.txt deleted file mode 100644 index 18939031cbf4..000000000000 --- a/cmake/ctest/drivers/artemis/CMakeLists.txt +++ /dev/null @@ -1,11 +0,0 @@ -TRILINOS_DRIVER_SETUP() - -TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_Downstream_ETI_SERIAL-${Tpetra_INST_SERIAL}_OPENMP-${Tpetra_INST_OPENMP}_PTHREAD-${Tpetra_INST_PTHREAD}_CUDA-${Tpetra_INST_CUDA}_COMPLEX-${Teuchos_ENABLE_COMPLEX} - ctest_linux_nightly_mpi_release_downstream_ETI_generic_artemis.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 420 -) - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/artemis/TrilinosCTestDriverCore.artemis.generic.cmake b/cmake/ctest/drivers/artemis/TrilinosCTestDriverCore.artemis.generic.cmake deleted file mode 100644 index 29ea0042a302..000000000000 --- a/cmake/ctest/drivers/artemis/TrilinosCTestDriverCore.artemis.generic.cmake +++ /dev/null @@ -1,129 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for typhon using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j16 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "1" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENDENCY_UNIT_TESTS:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=ON" - - "-D Trilinos_ENABLE_CXX11=ON" - "-D Trilinos_CXX11_FLAGS:STRING=--std=c++11" - - "-DTPL_ENABLE_BLAS:BOOL=ON" - "-DTPL_ENABLE_LAPACK:BOOL=ON" - "-DSuperLU_INCLUDE_DIRS:PATH=$ENV{SEMS_SUPERLU_INCLUDE_PATH}" - "-DSuperLU_LIBRARY_DIRS:PATH=$ENV{SEMS_SUPERLU_LIBRARY_PATH}" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu" - "-DBoost_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_BOOST_INCLUDE_PATH}" - "-DBoost_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_BOOST_LIBRARY_PATH}" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_BOOST_INCLUDE_PATH}" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_BOOST_LIBRARY_PATH}" - "-DHDF5_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_HDF5_INCLUDE_PATH}" - "-DHDF5_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_HDF5_LIBRARY_PATH}" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_NETCDF_INCLUDE_PATH}" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_NETCDF_LIBRARY_PATH}" - "-DZlib_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_ZLIB_INCLUDE_PATH}" - "-DZlib_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_ZLIB_LIBRARY_PATH}" - "-DTPL_ENABLE_X11:BOOL=OFF" - - ) - - SET_DEFAULT(COMPILER_VERSION "$ENV{SEMS_COMPILER_NAME}-$ENV{SEMS_COMPILER_VERSION}") - - #Ensuring that MPI is on for all parallel builds that might be run. - IF(COMM_TYPE STREQUAL MPI) - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR=$ENV{SEMS_OPENMPI_ROOT}" - "-D MPI_CXX_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicxx" - "-D MPI_C_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicc" - "-D MPI_FORTRAN_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpifort" - "-D CMAKE_CXX_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicxx" - "-D CMAKE_C_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicc" - "-D CMAKE_FORTRAN_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpifort" - "-D MPI_EXEC:FILEPATH=${MPI_BASE_DIR}/bin/mpirun" - "-DMPI_EXEC_POST_NUMPROCS_FLAGS:STRING=--bind-to-socket" - - ) - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/artemis/TrilinosCTestDriverCore.artemis.jenkins.cmake b/cmake/ctest/drivers/artemis/TrilinosCTestDriverCore.artemis.jenkins.cmake deleted file mode 100644 index 015cf0c001d1..000000000000 --- a/cmake/ctest/drivers/artemis/TrilinosCTestDriverCore.artemis.jenkins.cmake +++ /dev/null @@ -1,123 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for typhon using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET(Trilinos_REPOSITORY_LOCATION "$ENV{WORKSPACE}/Trilinos") - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j8 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "1" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENDENCY_UNIT_TESTS:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=ON" - - "-DMPI_BASE_DIR=$ENV{SEMS_OPENMPI_ROOT}" - "-D MPI_CXX_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicxx" - "-D MPI_C_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicc" - "-D MPI_FORTRAN_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpifort" - "-D CMAKE_CXX_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicxx" - "-D CMAKE_C_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicc" - "-D CMAKE_FORTRAN_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpifort" - "-D MPI_EXEC:FILEPATH=${MPI_PATH}/bin/mpirun" - "-D MPI_EXEC_POST_NUMPROCS_FLAGS:STRING=-bind-to-socket" - - "-DTPL_ENABLE_BLAS:BOOL=ON" - "-DTPL_ENABLE_LAPACK:BOOL=ON" - "-DTPL_SuperLU_LIBRARIES=${SEMS_SUPERLU_LIBRARY_PATH}/libsuperlu.a" - "-DTPL_SuperLU_INCLUDE_DIRS=$SEMS_SUPERLU_INCLUDE_PATH" - "-DTPL_ENABLE_X11:BOOL=OFF" - - - "-DCUDA_TOOLKIT_ROOT_DIR=$ENV{CUDA_ROOT}" - ) - - IF ($ENV{SEMS_COMPILER_NAME} STREQUAL gcc) - SET_DEFAULT(COMPILER_VERSION "GCC-$ENV{SEMS_COMPILER_VERSION}") - ELSE () - SET_DEFAULT(COMPILER_VERSION "Intel-$ENV{SEMS_COMPILER_VERSION}") - ENDIF() - - #Ensuring that MPI is on for all parallel builds that might be run. - IF(COMM_TYPE STREQUAL MPI) - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - ) - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/artemis/cron_driver.sh b/cmake/ctest/drivers/artemis/cron_driver.sh deleted file mode 100755 index 7c9279853fb5..000000000000 --- a/cmake/ctest/drivers/artemis/cron_driver.sh +++ /dev/null @@ -1,65 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on typhon: `date`" -echo - -# -# TrilinosDriver settings: -# - -export TDD_PARALLEL_LEVEL=1 - -# Trilinos settings: -# - -# Submission mode for the *TrilinosDriver* dashboard -export TDD_CTEST_TEST_TYPE=${JENKINS_JOB_TYPE} - -#export CTEST_DO_SUBMIT=FALSE -#export CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=FALSE - -# Machine specific environment -# -module purge -module load sems-env -module load kokkos-env - -module load sems-python/2.7.9 -module load sems-cmake/3.10.3 -module load sems-git/2.1.3 -module load sems-${COMPILER_SUFFIX} - -export TRIBITS_TDD_USE_SYSTEM_CTEST=1 -export TDD_HTTP_PROXY="http://sonproxy.sandia.gov:80" -export http_proxy="http://sonproxy.sandia.gov:80" -export CUDA_LAUNCH_BLOCKING=1 -export CUDA_MANAGED_FORCE_DEVICE_ALLOC=1 -export OMP_NUM_THREADS=2 - -# Machine independent cron_driver: -# -#openmpi-1.7-cuda6 - -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` - -if [ "${JENKINS_DO_CUDA}" == 'ON' ]; then - module load kokkos-${CUDA_SUFFIX} - module load kokkos-${MPI_SUFFIX}/cuda - export OMPI_CXX=$WORKSPACE/Trilinos/packages/kokkos/config/nvcc_wrapper -else - module load sems-${MPI_SUFFIX} -fi - -module load sems-${BOOST_SUFFIX}/base -module load sems-${HDF5_SUFFIX}/parallel -module load sems-${NETCDF_SUFFIX}/exo_parallel -module load sems-${ZLIB_SUFFIX}/base - -module list - -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on typhon: `date`" -echo diff --git a/cmake/ctest/drivers/artemis/ctest_linux_nightly_mpi_debug_muelu_extratypes_ei_negima_jenkins.cmake b/cmake/ctest/drivers/artemis/ctest_linux_nightly_mpi_debug_muelu_extratypes_ei_negima_jenkins.cmake deleted file mode 100644 index 454dbf8ed014..000000000000 --- a/cmake/ctest/drivers/artemis/ctest_linux_nightly_mpi_debug_muelu_extratypes_ei_negima_jenkins.cmake +++ /dev/null @@ -1,84 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.artemis.jenkins.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME OPENMPI_1.8.7_DEBUG_DEV_MueLu_ExtraTypes_EI_WITH_KOKKOS_$ENV{KOKKOS_BRANCH}) -SET(CTEST_PARALLEL_LEVEL 8) -SET(CTEST_TEST_TYPE Nightly) -SET(CTEST_TEST_TIMEOUT 1800) - -SET(Trilinos_PACKAGES MueLu Xpetra Amesos2) - -SET(EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTpetra_ENABLE_INT_LONG_LONG:BOOL=ON" - - "-DZoltan2_ENABLE_Experimental:BOOL=ON" - "-DTPL_ENABLE_SuperLU:BOOL=ON" -) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/artemis/ctest_linux_nightly_mpi_release_downstream_ETI_generic_artemis.cmake b/cmake/ctest/drivers/artemis/ctest_linux_nightly_mpi_release_downstream_ETI_generic_artemis.cmake deleted file mode 100644 index af61746ff4fa..000000000000 --- a/cmake/ctest/drivers/artemis/ctest_linux_nightly_mpi_release_downstream_ETI_generic_artemis.cmake +++ /dev/null @@ -1,99 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.artemis.generic.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_RELEASE_DEV_DownStream_ETI_SERIAL-$ENV{JENKINS_DO_SERIAL}_OPENMP-$ENV{JENKINS_DO_OPENMP}_PTHREAD-$ENV{JENKINS_DO_PTHREAD}_CUDA-$ENV{JENKINS_DO_CUDA}_COMPLEX-$ENV{JENKINS_DO_COMPLEX}) -SET(CTEST_PARALLEL_LEVEL 1) -SET(CTEST_TEST_TYPE $ENV{JENKINS_JOB_TYPE}) -SET(Trilinos_TRACK Nightly) # Set the CDash track to Nightly. -SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_PACKAGES Kokkos Tpetra Belos Ifpack2 MueLu Amesos Amesos2 Ifpack Epetra EpetraExt Zoltan Zoltan2 Xpetra Panzer Intrepid STK Seacas Anasazi Phalanx Sacado Stokhos Shylu Stratimikos Thyra) - -SET(EXTRA_CONFIGURE_OPTIONS - "-DTPL_ENABLE_SuperLU=OFF" - "-DTPL_ENABLE_Matio=OFF" - - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTeuchos_ENABLE_COMPLEX:BOOL=$ENV{JENKINS_DO_COMPLEX}" - "-DTrilinos_ENABLE_OpenMP:BOOL=$ENV{JENKINS_DO_OPENMP}" - "-DTPL_ENABLE_HWLOC:STRING=OFF" - "-DTPL_ENABLE_CUDA:STRING=$ENV{JENKINS_DO_CUDA}" - - "-DKokkos_ENABLE_Pthread:BOOL=$ENV{JENKINS_DO_PTHREAD}" - "-DKokkos_ENABLE_Cuda_UVM:BOOL=$ENV{JENKINS_DO_CUDA}" - - "-DTpetra_INST_SERIAL:BOOL=$ENV{JENKINS_DO_SERIAL}" - "-DTpetra_INST_OPENMP:BOOL=$ENV{JENKINS_DO_OPENMP}" - "-DTpetra_INST_PTHREAD:BOOL=$ENV{JENKINS_DO_PTHREAD}" - "-DTpetra_INST_CUDA:BOOL=$ENV{JENKINS_DO_CUDA}" - "-D Tpetra_INST_COMPLEX_DOUBLE:BOOL=$ENV{JENKINS_DO_COMPLEX}" - "-D MueLu_INST_DOUBLE_INT_LONGINT:BOOL=ON" -) - -#"-DMPI_EXEC_POST_NUMPROCS_FLAGS:STRING=-bind-to;socket;--map-by;socket" -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/artemis/jenkins_driver.sh b/cmake/ctest/drivers/artemis/jenkins_driver.sh deleted file mode 100755 index 51cdc1aaab1b..000000000000 --- a/cmake/ctest/drivers/artemis/jenkins_driver.sh +++ /dev/null @@ -1,81 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on typhon: `date`" -echo - -# snapshot_kokkos_into_trilinos -snapshot_kokkos_into_trilinos() { - cd $WORKSPACE/Trilinos && git reset --hard HEAD && cd - - cd $WORKSPACE/kokkos && git reset --hard origin/$1 && cd - - $WORKSPACE/kokkos/config/snapshot.py -n $WORKSPACE/kokkos $WORKSPACE/Trilinos/packages || { echo "SNAPSHOT FAILED!" && exit 1; } - export KOKKOS_BRANCH=$1 -} - -# -# TrilinosDriver settings: -# - -export TDD_PARALLEL_LEVEL=2 - -# Trilinos settings: -# - -# Submission mode for the *TrilinosDriver* dashboard -export TDD_CTEST_TEST_TYPE=Nightly -export TRIBITS_TDD_USE_SYSTEM_CTEST=1 - -#export CTEST_DO_SUBMIT=FALSE -#export CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=FALSE - -# Machine specific environment -# - -source /projects/modulefiles/utils/sems-modules-init.sh -source /projects/modulefiles/utils/kokkos-modules-init.sh - -module load python/2.7.9 -module load cuda/6.5.14 -module load cmake/2.8.11 -module load git - -export FROM_JENKINS=1 -export TDD_HTTP_PROXY="http://sonproxy.sandia.gov:80" -export http_proxy="http://sonproxy.sandia.gov:80" -export CUDA_LAUNCH_BLOCKING=1 -export OMP_NUM_THREADS=2 - -# Machine independent cron_driver: -# -#openmpi-1.7-cuda6 - -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` - -module load intel/15.0.2/openmpi/1.8.7/cuda/6.5.14 -module load superlu/4.3/intel/15.0.2/base - -export KOKKOS_BRANCH=master -$SCRIPT_DIR/../cron_driver.py - -snapshot_kokkos_into_trilinos develop -$SCRIPT_DIR/../cron_driver.py - -# module unload intel/15.0.2/openmpi/1.8.7/cuda/6.5.14 -# module unload superlu/4.3/intel/15.0.2/base - -# module load gcc/4.8.4/openmpi/1.8.7/cuda/6.5.14 -# module load superlu/4.3/gcc/4.8.4/base - -# cd $WORKSPACE/Trilinos && git reset --hard HEAD && cd - -# $SCRIPT_DIR/../cron_driver.py - -# snapshot_kokkos_into_trilinos develop -# $SCRIPT_DIR/../cron_driver.py - -git status - -cd $WORKSPACE/Trilinos && git reset --hard HEAD && cd - - -echo -echo "Ending nightly Trilinos development testing on typhon: `date`" -echo diff --git a/cmake/ctest/drivers/billmp1/CMakeLists.txt b/cmake/ctest/drivers/billmp1/CMakeLists.txt deleted file mode 100644 index 1b485df47960..000000000000 --- a/cmake/ctest/drivers/billmp1/CMakeLists.txt +++ /dev/null @@ -1,21 +0,0 @@ -TRILINOS_DRIVER_SETUP() - -# Set a timeout of 6 hours for an individual build run in parallel with other -# builds -SET(TIMEOUT_MINUTES 120) - -TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_DEBUG_PS - ctest_osx_nightly_mpi_debug_billmp1.cmake - CTEST_INSTALLER_TYPE release - TIMEOUT_MINUTES ${TIMEOUT_MINUTES} - ) - -TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_RELEASE_PS - ctest_osx_nightly_serial_release_billmp1.cmake - CTEST_INSTALLER_TYPE release - TIMEOUT_MINUTES ${TIMEOUT_MINUTES} - ) - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/billmp1/TrilinosCTestDriverCore.billmp1.gcc.cmake b/cmake/ctest/drivers/billmp1/TrilinosCTestDriverCore.billmp1.gcc.cmake deleted file mode 100644 index 1b47d47fd039..000000000000 --- a/cmake/ctest/drivers/billmp1/TrilinosCTestDriverCore.billmp1.gcc.cmake +++ /dev/null @@ -1,106 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for billmp1 using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j8 -i" ) - - SET( CTEST_PARALLEL_LEVEL "2" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - ) - - SET_DEFAULT(COMPILER_VERSION "GCC-4.6.0") - - IF (COMM_TYPE STREQUAL MPI) - - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/usr/local" - ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/usr/local/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/usr/local/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/usr/local/bin/gfortran" - ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/billmp1/bash_profile b/cmake/ctest/drivers/billmp1/bash_profile deleted file mode 100644 index ed6e93bc902d..000000000000 --- a/cmake/ctest/drivers/billmp1/bash_profile +++ /dev/null @@ -1,15 +0,0 @@ -# .bash_profile -# echo bash_profile: path is $PATH -# echo bash_profile: git is `which git` -PATH=${PATH}:/usr/local/git/bin; export PATH - -# Get the aliases and functions -if [ -f ~/.bashrc ]; then - . ~/.bashrc -fi - -unset USERNAME - -export CVS_RSH=ssh - -# User specific environment and startup programs diff --git a/cmake/ctest/drivers/billmp1/cron_driver_billmp1.sh b/cmake/ctest/drivers/billmp1/cron_driver_billmp1.sh deleted file mode 100755 index 0be93850a467..000000000000 --- a/cmake/ctest/drivers/billmp1/cron_driver_billmp1.sh +++ /dev/null @@ -1,26 +0,0 @@ -#!/bin/bash - -# This script must be run from this directory! - -echo -echo "Starting nightly Trilinos testing on billmp1: `date`" -echo - -SCRIPT_DIR=$PWD -cd $HOME -source $SCRIPT_DIR/bash_profile -cd - - -export TDD_PARALLEL_LEVEL=1 -export TDD_CTEST_TEST_TYPE=Experimental - -export CTEST_DROP_SITE=casl-dev.ornl.gov -export CTEST_DROP_LOCATION="/CDash/submit.php?project=Trilinos" - -time /usr/bin/python ../cron_driver.py - -echo -echo "Ending nightly Trilinos testing on billmp1: `date`" -echo - -echo "Finished nightly Trilinos CMake tests billmp1: http://casl-dev.ornl.gov/CDash/index.php?project=Trilinos" | mailx -s "Nightly CTest: billmp1" bakercg@ornl.gov diff --git a/cmake/ctest/drivers/billmp1/ctest_osx_nightly_mpi_debug_billmp1.cmake b/cmake/ctest/drivers/billmp1/ctest_osx_nightly_mpi_debug_billmp1.cmake deleted file mode 100644 index 20f928d472c9..000000000000 --- a/cmake/ctest/drivers/billmp1/ctest_osx_nightly_mpi_debug_billmp1.cmake +++ /dev/null @@ -1,77 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.billmp1.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG_PS) -#SET(CTEST_TEST_TIMEOUT 900) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/billmp1/ctest_osx_nightly_serial_release_billmp1.cmake b/cmake/ctest/drivers/billmp1/ctest_osx_nightly_serial_release_billmp1.cmake deleted file mode 100644 index 77eb08cd3c6b..000000000000 --- a/cmake/ctest/drivers/billmp1/ctest_osx_nightly_serial_release_billmp1.cmake +++ /dev/null @@ -1,76 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.billmp1.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_RELEASE_PS) -#SET(CTEST_TEST_TIMEOUT 900) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/brain/CMakeLists.txt b/cmake/ctest/drivers/brain/CMakeLists.txt deleted file mode 100644 index 2d7534cc78d5..000000000000 --- a/cmake/ctest/drivers/brain/CMakeLists.txt +++ /dev/null @@ -1,44 +0,0 @@ -TRILINOS_DRIVER_SETUP() - -#TRILINOS_DRIVER_ADD_DASHBOARD( -# MPI_OPT_DEV2 -# ctest_linux_nightly_mpi_development_opt_gcc_4.6.3_brain.cmake -# CTEST_INSTALLER_TYPE release -# RUN_SERIAL -# TIMEOUT_MINUTES 300 -#) - -TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG - ctest_linux_nightly_serial_debug_gcc-4.6.3_cxx11_brain.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 360 -) - -TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG_MEMCHECK - ctest_linux_nightly_serial_debug_gcc-4.1.2_memcheck_brain.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 360 -) - -TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG_NOEI - ctest_linux_nightly_serial_development_debug_gcc_4.6.3_noei_brain.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 360 -) - -TRILINOS_DRIVER_ADD_DASHBOARD( - OPENMP_OPT - ctest_linux_nightly_openmp_development_opt_brain.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 180 -) - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() - diff --git a/cmake/ctest/drivers/brain/TrilinosCTestDriverCore.brain.common.cmake b/cmake/ctest/drivers/brain/TrilinosCTestDriverCore.brain.common.cmake deleted file mode 100644 index c2fedbd1ffae..000000000000 --- a/cmake/ctest/drivers/brain/TrilinosCTestDriverCore.brain.common.cmake +++ /dev/null @@ -1,38 +0,0 @@ - -# -# Build settings that are independent of compiler version. -# - -# Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - -SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - -SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - -SET( CTEST_BUILD_FLAGS "-j10 -i" ) - -SET_DEFAULT( CTEST_PARALLEL_LEVEL "11" ) - -SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -# Only turn on PyTrilinos for shared libraries -SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} PyTrilinos TriKota Optika) - -IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) -ENDIF() - -SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENCENCY_UNIT_TESTS:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DSuperLU_INCLUDE_DIRS:PATH=/home/trilinos/tpl/gcc/SuperLU_4.3/SRC" - "-DSuperLU_LIBRARY_DIRS:PATH=/home/trilinos/tpl/gcc/SuperLU_4.3/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu_4.3" - "-DTPL_ENABLE_BinUtils=ON" - "-DTPL_ENABLE_Matio=OFF" - "-DTPL_ENABLE_SuperLU=ON" - "-DIntrepid_ENABLE_DEBUG_INF_CHECK=OFF" - ) - diff --git a/cmake/ctest/drivers/brain/TrilinosCTestDriverCore.brain.gcc-4.1.2.cmake b/cmake/ctest/drivers/brain/TrilinosCTestDriverCore.brain.gcc-4.1.2.cmake deleted file mode 100644 index 44c63d726a49..000000000000 --- a/cmake/ctest/drivers/brain/TrilinosCTestDriverCore.brain.gcc-4.1.2.cmake +++ /dev/null @@ -1,46 +0,0 @@ - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for brain.sandia.gov using gcc 4.1.2 -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.brain.common.cmake") - - SET_DEFAULT(COMPILER_VERSION "GCC-4.1.2") - - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DMEMORYCHECK_COMMAND:FILEPATH=/usr/bin/valgrind" - ) - - IF (COMM_TYPE STREQUAL MPI) - - # Set MPI_BASE_DIR to use the wrapper compilers. - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR=/usr/local" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_brain_openmpi_1.2.7.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_brain_gcc-4.1.2.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/brain/TrilinosCTestDriverCore.brain.gcc-4.6.3.cmake b/cmake/ctest/drivers/brain/TrilinosCTestDriverCore.brain.gcc-4.6.3.cmake deleted file mode 100644 index 0b2e7cb36471..000000000000 --- a/cmake/ctest/drivers/brain/TrilinosCTestDriverCore.brain.gcc-4.6.3.cmake +++ /dev/null @@ -1,41 +0,0 @@ - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for brain.sandia.gov using gcc 4.6.3 -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.brain.common.cmake") - - # Set up the compiler environment. - SET(brain_GCC_ROOT "$ENV{HOME}/compilers/gcc/4.6.3") - SET(ENV{LD_LIBRARY_PATH} "${brain_GCC_ROOT}/lib64:$ENV{LD_LIBRARY_PATH}") - - SET_DEFAULT(COMPILER_VERSION "GCC-4.6.3") - - IF (COMM_TYPE STREQUAL MPI) - - # Set MPI_BASE_DIR to use the wrapper compilers. - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR=$ENV{HOME}/tpls/gcc/4.6.3/openmpi/1.4.3" - ) - - ELSE() - - # Explicitly set the compiler variables. - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_C_COMPILER:FILEPATH=${brain_GCC_ROOT}/bin/gcc" - "-DCMAKE_CXX_COMPILER:FILEPATH=${brain_GCC_ROOT}/bin/g++" - "-DCMAKE_Fortran_COMPILER:FILEPATH=${brain_GCC_ROOT}/bin/gfortran" - ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/brain/cron_driver.sh b/cmake/ctest/drivers/brain/cron_driver.sh deleted file mode 100755 index 9bb167c97a64..000000000000 --- a/cmake/ctest/drivers/brain/cron_driver.sh +++ /dev/null @@ -1,31 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on brain: `date`" -echo - -# TrilinosDriver settings: -# - -export TDD_GIT_EXE=/usr/local/bin/git -export TDD_PARALLEL_LEVEL=2 -export TDD_CTEST_TEST_TYPE=Nightly - -# CTest Settings -# - -# Trilinos settings: -# - -# Machine specific environment: -# - -# Machine independent cron_driver: -# - -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on brain: `date`" -echo diff --git a/cmake/ctest/drivers/brain/ctest_linux_continuous_mpi_development_opt_brain.cmake b/cmake/ctest/drivers/brain/ctest_linux_continuous_mpi_development_opt_brain.cmake deleted file mode 100644 index 2f7adbbdbe80..000000000000 --- a/cmake/ctest/drivers/brain/ctest_linux_continuous_mpi_development_opt_brain.cmake +++ /dev/null @@ -1,100 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.brain.gcc-4.6.3.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME CONTINUOUS_MPI_OPT_DEV) -SET(COMPILER_VERSION "GCC-4.6.3") -SET(CTEST_TEST_TYPE Continuous) - -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) -#Stokhos is explicitly disabled below to prevent the package from being -#implicitly enabled. Sundance depends on Stokhos. -#SET(EXTRA_EXCLUDE_PACKAGES Phalanx Stokhos Sundance) -#SET_DEFAULT(Trilinos_ENABLE_KNOWN_EXTERNAL_REPOS_TYPE Continuous) - -SET(Trilinos_PACKAGES Zoltan2) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=OFF" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DMPI_BASE_DIR:PATH=$ENV{HOME}/tpls/gcc/4.6.3/openmpi/1.4.3" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc/pnetcdf_4.2/include" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc/pnetcdf_4.2/lib" - "-DHDF5_INCLUDE_DIRS=/home/trilinos/tpl/gcc/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS=/home/trilinos/tpl/gcc/phdf5-1.8.6/lib" - "-DBoost_INCLUDE_DIRS=/home/trilinos/tpl/gcc/boost_1_49_0" - "-DZoltan2_ENABLE_Experimental=ON" - ) - -# Put MPI in the LD_LIBRARY_PATH for testing. -SET(ENV{LD_LIBRARY_PATH} "$ENV{HOME}/tpls/gcc/4.6.3/openmpi/1.4.3/lib:$ENV{LD_LIBRARY_PATH}") - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/brain/ctest_linux_nightly_mpi_development_opt_gcc_4.6.3_brain.cmake b/cmake/ctest/drivers/brain/ctest_linux_nightly_mpi_development_opt_gcc_4.6.3_brain.cmake deleted file mode 100644 index ea7209ca7857..000000000000 --- a/cmake/ctest/drivers/brain/ctest_linux_nightly_mpi_development_opt_gcc_4.6.3_brain.cmake +++ /dev/null @@ -1,96 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.brain.gcc-4.6.3.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV2) -SET(COMPILER_VERSION "GCC-4.6.3") -SET(CTEST_TEST_TYPE NIGHTLY) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) -#Stokhos is explicitly disabled below to prevent the package from being -#implicitly enabled. Sundance depends on Stokhos. -#SET(EXTRA_EXCLUDE_PACKAGES Phalanx Stokhos Sundance) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DMPI_BASE_DIR:PATH=$ENV{HOME}/tpls/gcc/4.6.3/openmpi/1.4.3" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc/pnetcdf_4.2/include" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc/pnetcdf_4.2/lib" - "-DHDF5_INCLUDE_DIRS=/home/trilinos/tpl/gcc/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS=/home/trilinos/tpl/gcc/phdf5-1.8.6/lib" - "-DBoost_INCLUDE_DIRS=/home/trilinos/tpl/gcc/boost_1_49_0" - "-DZoltan2_ENABLE_Experimental:BOOL=ON" - ) - -# Put MPI in the LD_LIBRARY_PATH for testing. -SET(ENV{LD_LIBRARY_PATH} "$ENV{HOME}/tpls/gcc/4.6.3/openmpi/1.4.3/lib:$ENV{LD_LIBRARY_PATH}") - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/brain/ctest_linux_nightly_openmp_development_opt_brain.cmake b/cmake/ctest/drivers/brain/ctest_linux_nightly_openmp_development_opt_brain.cmake deleted file mode 100644 index 3b06b44784c6..000000000000 --- a/cmake/ctest/drivers/brain/ctest_linux_nightly_openmp_development_opt_brain.cmake +++ /dev/null @@ -1,83 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.brain.gcc-4.1.2.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME OPENMP_OPT) -SET(CTEST_TEST_TYPE Nightly) -SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_PACKAGES Epetra Kokkos Amesos AztecOO Ifpack Tpetra) - -SET(CTEST_PARALLEL_LEVEL 1) -SET(CTEST_DO_TEST TRUE) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_OpenMP:BOOL=ON" - "-DTrilinos_ENABLE_CXX11=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/brain/ctest_linux_nightly_serial_debug_gcc-4.1.2_memcheck_brain.cmake b/cmake/ctest/drivers/brain/ctest_linux_nightly_serial_debug_gcc-4.1.2_memcheck_brain.cmake deleted file mode 100644 index ea5aa1eb3e0e..000000000000 --- a/cmake/ctest/drivers/brain/ctest_linux_nightly_serial_debug_gcc-4.1.2_memcheck_brain.cmake +++ /dev/null @@ -1,89 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.brain.gcc-4.1.2.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_MEMCHECK) -SET(CTEST_TEST_TYPE EXPERIMENTAL) -#SET(CTEST_TEST_TIMEOUT 900) - -# Explicitly enable the packages to be memory tested. -#SET(Trilinos_PACKAGES Teuchos RTOp Epetra Tpetra EpetraExt -# Sacado Thyra AztecOO Ifpack ML Stratimikos Rythmos MOOCHO) - -SET(EXTRA_EXCLUDE_PACKAGES SEACAS) - -SET(CTEST_PARALLEL_LEVEL 12) -SET(CTEST_DO_TEST TRUE) -SET(CTEST_DO_MEMORY_TESTING TRUE) -SET(CTEST_MEMORYCHECK_COMMAND "/usr/bin/valgrind") - -SET( EXTRA_CONFIGURE_OPTIONS - "-DMueLu_ENABLE_MEMORY_TESTING=ON" - "-DTPL_ENABLE_Netcdf:BOOL=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/brain/ctest_linux_nightly_serial_debug_gcc-4.6.3_cxx11_brain.cmake b/cmake/ctest/drivers/brain/ctest_linux_nightly_serial_debug_gcc-4.6.3_cxx11_brain.cmake deleted file mode 100644 index d34446054139..000000000000 --- a/cmake/ctest/drivers/brain/ctest_linux_nightly_serial_debug_gcc-4.6.3_cxx11_brain.cmake +++ /dev/null @@ -1,28 +0,0 @@ - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.brain.gcc-4.6.3.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME "SERIAL_DEBUG_CXX11_DEV") -SET(COMPILER_VERSION "GCC-4.6.3-CXX11") -SET(CTEST_TEST_TYPE EXPERIMENTAL) - -SET(EXTRA_EXCLUDE_PACKAGES Panzer) - -SET( EXTRA_CONFIGURE_OPTIONS - "${EXTRA_CONFIGURE_OPTIONS}" - "-DTrilinos_ENABLE_CXX11:BOOL=ON" - "-DCMAKE_CXX_FLAGS:STRING=-std=c++0x" -) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() - diff --git a/cmake/ctest/drivers/brain/ctest_linux_nightly_serial_development_debug_gcc_4.6.3_brain.cmake b/cmake/ctest/drivers/brain/ctest_linux_nightly_serial_development_debug_gcc_4.6.3_brain.cmake deleted file mode 100644 index 8f4572a1e04c..000000000000 --- a/cmake/ctest/drivers/brain/ctest_linux_nightly_serial_development_debug_gcc_4.6.3_brain.cmake +++ /dev/null @@ -1,91 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.brain.gcc-4.6.3.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_DEV2) -SET(COMPILER_VERSION "GCC-4.6.3") -SET(CTEST_TEST_TYPE EXPERIMENTAL) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) -#Stokhos is explicitly disabled below to prevent the package from being -#implicitly enabled. Sundance depends on Stokhos. -#SET(EXTRA_EXCLUDE_PACKAGES Phalanx Stokhos Sundance Panzer) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc/netcdf_4.2/include" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc/netcdf_4.2/lib" - "-DHDF5_INCLUDE_DIRS=/home/trilinos/tpl/gcc/hdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS=/home/trilinos/tpl/gcc/hdf5-1.8.6/lib" - "-DBoost_INCLUDE_DIRS=/home/trilinos/tpl/gcc/boost_1_49_0" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/brain/ctest_linux_nightly_serial_development_debug_gcc_4.6.3_noei_brain.cmake b/cmake/ctest/drivers/brain/ctest_linux_nightly_serial_development_debug_gcc_4.6.3_noei_brain.cmake deleted file mode 100644 index 15324ded0e52..000000000000 --- a/cmake/ctest/drivers/brain/ctest_linux_nightly_serial_development_debug_gcc_4.6.3_noei_brain.cmake +++ /dev/null @@ -1,91 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.brain.gcc-4.6.3.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_DEV_NOEI) -SET(COMPILER_VERSION "GCC-4.6.3") -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) -SET(EXTRA_EXCLUDE_PACKAGES STK MOOCHO Piro Sundance Panzer) -SET_DEFAULT(Trilinos_ENABLE_KNOWN_EXTERNAL_REPOS_TYPE Nightly) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=OFF" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DMPI_BASE_DIR:PATH=$ENV{HOME}/tpls/gcc/4.6.3/openmpi/1.4.3" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc/netcdf_4.2/include" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc/netcdf_4.2/lib" - "-DHDF5_INCLUDE_DIRS=/home/trilinos/tpl/gcc/hdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS=/home/trilinos/tpl/gcc/hdf5-1.8.6/lib" - "-DBoost_INCLUDE_DIRS=/home/trilinos/tpl/gcc/boost_1_49_0" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/brain/valgrind_suppressions_brain_gcc-4.1.2.txt b/cmake/ctest/drivers/brain/valgrind_suppressions_brain_gcc-4.1.2.txt deleted file mode 100644 index b28b04f64312..000000000000 --- a/cmake/ctest/drivers/brain/valgrind_suppressions_brain_gcc-4.1.2.txt +++ /dev/null @@ -1,3 +0,0 @@ - - - diff --git a/cmake/ctest/drivers/brain/valgrind_suppressions_brain_openmpi_1.2.7.txt b/cmake/ctest/drivers/brain/valgrind_suppressions_brain_openmpi_1.2.7.txt deleted file mode 100644 index f035ef524389..000000000000 --- a/cmake/ctest/drivers/brain/valgrind_suppressions_brain_openmpi_1.2.7.txt +++ /dev/null @@ -1,133 +0,0 @@ -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send - fun:orte_iof_proxy_svc_publish - fun:orte_iof_proxy_publish - fun:orte_iof_base_setup_parent - fun:orte_odls_default_launch_local_procs - obj:/usr/lib64/openmpi/1.2.7-gcc/bin/orted - fun:orte_gpr_proxy_deliver_notify_msg - fun:orte_gpr_proxy_notify_recv - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 -} - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - fun:_orte_iof_base_frag_ack - fun:orte_iof_base_endpoint_forward - fun:orte_iof_svc_proxy_recv - fun:mca_oob_tcp_msg_recv_complete - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/openmpi/mca_oob_tcp.so - fun:opal_event_base_loop - fun:opal_progress - obj:/usr/lib64/openmpi/1.2.7-gcc/bin/orterun -} - -{ - - Memcheck:Cond - fun:__strcpy_chk - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libmpi.so.0.0.0 - fun:orte_gpr_proxy_deliver_notify_msg - fun:mca_oob_xcast - fun:ompi_mpi_init - fun:PMPI_Init - fun:_ZN7Teuchos16GlobalMPISessionC1EPiPPPcPSo - fun:main -} - -{ - - Memcheck:Cond - fun:__strcpy_chk - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libmpi.so.0.0.0 - fun:orte_gpr_proxy_deliver_notify_msg - fun:mca_oob_xcast - fun:ompi_mpi_init - fun:PMPI_Init - fun:main -} - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - fun:orte_iof_svc_sub_forward - fun:orte_iof_svc_proxy_recv - fun:mca_oob_tcp_msg_recv_complete - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/openmpi/mca_oob_tcp.so - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 - fun:opal_event_base_loop - fun:opal_progress - obj:/usr/lib64/openmpi/1.2.7-gcc/bin/orterun -} - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 - fun:opal_event_base_loop - fun:opal_progress - fun:mca_oob_tcp_msg_wait - fun:mca_oob_tcp_recv - fun:mca_oob_recv_packed - fun:orte_gpr_proxy_exec_compound_cmd - fun:orte_odls_base_report_spawn -} - - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - fun:orte_iof_svc_sub_forward - fun:orte_iof_svc_proxy_recv - fun:mca_oob_tcp_msg_recv_complete - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/openmpi/mca_oob_tcp.so - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 - fun:opal_event_base_loop - fun:opal_progress - obj:/usr/lib64/openmpi/1.2.7-gcc/bin/orterun -} - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 - fun:opal_event_base_loop - fun:opal_progress - fun:mca_oob_tcp_msg_wait - fun:mca_oob_tcp_recv - fun:mca_oob_recv_packed - fun:orte_gpr_proxy_exec_compound_cmd - fun:orte_odls_base_report_spawn -} diff --git a/cmake/ctest/drivers/continuous/TrilinosCTestDriverCore.generic.cmake b/cmake/ctest/drivers/continuous/TrilinosCTestDriverCore.generic.cmake deleted file mode 100644 index 01558f4f655e..000000000000 --- a/cmake/ctest/drivers/continuous/TrilinosCTestDriverCore.generic.cmake +++ /dev/null @@ -1,141 +0,0 @@ -# @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 - -SET(PythonInterp_FIND_VERSION 2.7) -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for typhon using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "16" ) - SET_DEFAULT( CTEST_BUILD_FLAGS "-j${CTEST_PARALLEL_LEVEL} -i" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} PyTrilinos TriKota ) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_COMPLEX:BOOL=ON" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=ON" - "-DBUILD_SHARED_LIBS:BOOL=ON" - "-DIntrepid2_ENABLE_DEBUG_INF_CHECK:BOOL=OFF" - "-DPythonInterp_FIND_VERSION=${PythonInterp_FIND_VERSION}" - - "-DTPL_ENABLE_BLAS:BOOL=ON" - "-DTPL_ENABLE_LAPACK:BOOL=ON" - - "-DParMETIS_INCLUDE_DIRS:PATH=$ENV{SEMS_PARMETIS_INCLUDE_PATH}" - "-DParMETIS_LIBRARY_DIRS:PATH=$ENV{SEMS_PARMETIS_LIBRARY_PATH}" - - "-DSuperLU_INCLUDE_DIRS:PATH=$ENV{SEMS_SUPERLU_ROOT}/include" - "-DSuperLU_LIBRARY_DIRS:PATH=$ENV{SEMS_SUPERLU_ROOT}/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu" - - "-DBoost_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_BOOST_ROOT}/include" - "-DBoost_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_BOOST_ROOT}/lib" - - "-DBoostLib_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_BOOST_ROOT}/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_BOOST_ROOT}/lib" - - "-DHDF5_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_HDF5_ROOT}/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_HDF5_ROOT}/lib" - - "-DNetcdf_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_NETCDF_ROOT}/include" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_NETCDF_ROOT}/lib" - - "-DZlib_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_ZLIB_ROOT}/include" - "-DZlib_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_ZLIB_ROOT}/lib" - - ) - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - SET_DEFAULT(COMPILER_VERSION "$ENV{SEMS_COMPILER_NAME}-$ENV{SEMS_COMPILER_VERSION}") - - #Ensuring that MPI is on for all parallel builds that might be run. - IF(COMM_TYPE STREQUAL MPI) - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR=$ENV{SEMS_OPENMPI_ROOT}" - ) - ELSE() - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=$ENV{CXX}" - "-DCMAKE_C_COMPILER:FILEPATH=$ENV{CC}" - "-DCMAKE_Fortran_COMPILER:FILEPATH=$ENV{FC}" - ) - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/continuous/ctest_linux_continuous_generic.cmake b/cmake/ctest/drivers/continuous/ctest_linux_continuous_generic.cmake deleted file mode 100644 index 64b4ec835bef..000000000000 --- a/cmake/ctest/drivers/continuous/ctest_linux_continuous_generic.cmake +++ /dev/null @@ -1,164 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.generic.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE $ENV{JENKINS_COMM_TYPE}) -SET(BUILD_TYPE $ENV{JENKINS_BUILD_TYPE}) -STRING(REPLACE "sems-" "" COMPILER_DIR $ENV{COMPILER_MODULE}) -STRING(REPLACE "/" "_" COMPILER_DIR ${COMPILER_DIR}) -SET(COMM_DIR "") -IF(COMM_TYPE STREQUAL MPI) - STRING(REPLACE "sems-" "" COMM_DIR $ENV{MPI_MODULE}) - STRING(REPLACE "/" "_" COMM_DIR ${COMM_DIR}) -ENDIF() -SET(BUILD_DIR_NAME CONTINUOUS_${COMM_TYPE}_${BUILD_TYPE}_${COMPILER_DIR}_${COMM_DIR}_DEV) - -#SET(CTEST_TEST_TIMEOUT 900) - -#override the default number of processors to run on. -SET( CTEST_BUILD_FLAGS "-j16 -i" ) -SET( CTEST_PARALLEL_LEVEL "16" ) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - -SET(Trilinos_BRANCH develop) - -SET(EXTRA_EXCLUDE_PACKAGES Optika) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_COMPLEX=$ENV{JENKINS_DO_COMPLEX}" - "-DTrilinos_TEST_CATEGORIES=BASIC" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - "-DTrilinos_ENABLE_DEBUG_SYMBOLS=OFF" - "-DBUILD_SHARED_LIBS:BOOL=ON" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DTPL_ENABLE_BoostLib:BOOL=ON" - "-DTPL_ENABLE_ParMETIS:BOOL=ON" - "-DTPL_ENABLE_Zlib:BOOL=ON" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DTPL_ENABLE_Netcdf:BOOL=ON" - "-DTPL_ENABLE_SuperLU:BOOL=ON" -# "-DTPL_ENABLE_CppUnit:BOOL=ON" - "-DAmesos2_ENABLE_KLU2=ON" - "-DTeuchos_ENABLE_DEFAULT_STACKTRACE=OFF" - "-DTrilinos_TRACE_ADD_TEST=ON" - "-DPiro_EpetraSolver_MPI_4_DISABLE=ON" - "-DSTK_stk_mesh_unit_tests_MPI_4_DISABLE=ON" - "-DSTK_util_parallel_UnitTest_MPI_4_DISABLE=ON" - ) - -# Previous option to disable long-failing Pir test until it can be fixed (#826) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -SET(CTEST_TEST_TYPE Continuous) - -# Set the following variables to reasonable values so the Jenkins job -# provides useful feedback, rather then always returning an error -# because they aren't defined. - -# The Jenkins checkout of the scripts repository. -SET(CTEST_SOURCE_DIRECTORY "$ENV{WORKSPACE}/Trilinos") -# The location where the Jenkins script gets run. -SET(CTEST_BINARY_DIRECTORY "$ENV{WORKSPACE}/continuous-development") -# The CTest command being used by Jenkins. -SET(CTEST_COMMAND "ctest") - -function(VISIBLE_MESSAGE message) - message("\n***") - message("*** ${message}") - message("***\n") -endfunction() - -# Check to see if we need to start with an empty binary directory or enabling -# modified packages only. First, get the current time in seconds past the -# epoch. -execute_process( - COMMAND date +%s - OUTPUT_VARIABLE _current_time -) -set(_timestamp_file timestamp.txt) -if(NOT EXISTS ${_timestamp_file}) - VISIBLE_MESSAGE("No timestamp file exists, performing a clean build.") - SET(CTEST_START_WITH_EMPTY_BINARY_DIRECTORY ON) - SET(CTEST_ENABLE_MODIFIED_PACKAGES_ONLY OFF) - file(WRITE ${_timestamp_file} ${_current_time}) -else() - file(READ ${_timestamp_file} _last_time) - math(EXPR _difference "${_current_time} - ${_last_time}") - if(${_difference} GREATER 72000) # 20 hours - VISIBLE_MESSAGE("Timestamp is more than 20 hours old, performing a clean build.") - SET(CTEST_START_WITH_EMPTY_BINARY_DIRECTORY ON) - SET(CTEST_ENABLE_MODIFIED_PACKAGES_ONLY OFF) - file(WRITE ${_timestamp_file} ${_current_time}) - else() - VISIBLE_MESSAGE("Timestamp is less than 20 hours old, performing an incremental build.") - SET(CTEST_START_WITH_EMPTY_BINARY_DIRECTORY OFF) - SET(CTEST_ENABLE_MODIFIED_PACKAGES_ONLY ON) - endif() -endif() - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() - diff --git a/cmake/ctest/drivers/corrin/CMakeLists.txt b/cmake/ctest/drivers/corrin/CMakeLists.txt deleted file mode 100644 index d323069403a2..000000000000 --- a/cmake/ctest/drivers/corrin/CMakeLists.txt +++ /dev/null @@ -1,13 +0,0 @@ -# corrin driver - -set(CTEST_EXE "${CMAKE_CTEST_COMMAND}") -set(workingdir "${TrilinosDriver_BINARY_DIR}") - -add_test(serial_release - "${CTEST_EXE}" - -S - "${CMAKE_CURRENT_SOURCE_DIR}/ctest_windows_nightly_serial_release.cmake" - -VV - --output-log - "${TrilinosDriver_BINARY_DIR}/ctest_msvc_nightly_serial_optimized_corrin.out" -) diff --git a/cmake/ctest/drivers/corrin/TrilinosCTestDriverCore.corrin.msvc.cmake b/cmake/ctest/drivers/corrin/TrilinosCTestDriverCore.corrin.msvc.cmake deleted file mode 100755 index ccc4a8345720..000000000000 --- a/cmake/ctest/drivers/corrin/TrilinosCTestDriverCore.corrin.msvc.cmake +++ /dev/null @@ -1,87 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for godel using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - # convert CVS_EXE path to a cmake style path and store - # in CVS_EXECUTABLE. CVS_EXE is an environment variable - # that should be set before running this script. - FILE(TO_CMAKE_PATH "$ENV{CVS_EXE}" CVS_EXECUTABLE) - SET( CTEST_CMAKE_GENERATOR "NMake Makefiles") - SET( CTEST_BUILD_FLAGS " -i" ) - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON ) - SET(COMPILER_VERSION "MSVC9") - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - ENDIF() - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - ) - - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/corrin/ctest_windows_nightly_serial_release.cmake b/cmake/ctest/drivers/corrin/ctest_windows_nightly_serial_release.cmake deleted file mode 100755 index 93b17d4f2ce7..000000000000 --- a/cmake/ctest/drivers/corrin/ctest_windows_nightly_serial_release.cmake +++ /dev/null @@ -1,70 +0,0 @@ -# @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 - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.corrin.msvc.cmake") - -# -# Set the options specific to this build case -# -#SET(CTEST_DO_UPDATES FALSE) -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_RELEASE_PS) -#SET(CTEST_TEST_TIMEOUT 900) -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/corrin/task_driver_corrin.bat b/cmake/ctest/drivers/corrin/task_driver_corrin.bat deleted file mode 100755 index 40992e0c180e..000000000000 --- a/cmake/ctest/drivers/corrin/task_driver_corrin.bat +++ /dev/null @@ -1,30 +0,0 @@ -rem Call this script and pass in the base directory for the dashboard -rem save state before changing anything -setlocal -set foo=%1% - -rem cygwin CVS needs to know to use ssh -set CVS_RSH=C:/cygwin/bin/ssh.exe -rem Driver script for dashboards on Corrin -rem Set location of CTEST_EXE, and CVS_EXE -set CVS_EXE=C:\cygwin\bin\cvs.exe -set CTEST_EXE="c:\hoffman\My Builds\CMake-build26-rel\bin\ctest.exe" - -rem Set the base directory which is one above where Trilinos will be -rem checked out. - -set BASEDIR=%1% - -rem setup the environment for command line cl to run -call "C:\Program Files\Microsoft Visual Studio 9.0\Common7\Tools\vsvars32.bat" - -rem change into the basedir -cd %BASEDIR% -rem checkout the basics from Trilinos needed to run the dashboard including -rem this script. -%CVS_EXE% -q -d :ext:software.sandia.gov:/space/CVS co Trilinos/cmake Trilinos/CTestConfig.cmake - -rem Now run ctest on each of the ctest build scripts for this machine - -%CTEST_EXE% -S %BASEDIR%\Trilinos\cmake\ctest\drivers\corrin\ctest_windows_nightly_serial_release.cmake -VV > %BASEDIR%\ctest_msvc_nightly_serial_optimized_corrin.out -endlocal diff --git a/cmake/ctest/drivers/exetazo/TrilinosCTestDriverCore.exetazo.gcc.cmake b/cmake/ctest/drivers/exetazo/TrilinosCTestDriverCore.exetazo.gcc.cmake deleted file mode 100644 index 1a29bb99e030..000000000000 --- a/cmake/ctest/drivers/exetazo/TrilinosCTestDriverCore.exetazo.gcc.cmake +++ /dev/null @@ -1,118 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for exetazo using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j5 -i" ) - - SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES PyTrilinos TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DCOVERAGE_COMMAND:FILEPATH=/usr/bin/gcov" - "-DMEMORYCHECK_COMMAND:FILEPATH=/usr/bin/valgrind" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - ) - - SET_DEFAULT(COMPILER_VERSION "GCC-4.1.2") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/usr/alt/" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_exetazo_openmpi_1.2.7.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/usr/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/usr/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/usr/bin/gfortran" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_exetazo_gcc-4.1.2.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/exetazo/cron_driver_continuous_exetazo.sh b/cmake/ctest/drivers/exetazo/cron_driver_continuous_exetazo.sh deleted file mode 100755 index 617e8200971e..000000000000 --- a/cmake/ctest/drivers/exetazo/cron_driver_continuous_exetazo.sh +++ /dev/null @@ -1,42 +0,0 @@ -#!/bin/bash - -CTEST_EXE=/home/jmwille/install/cmake/bin/ctest -BASEDIR=/space/jmwille/TrilinosTestHarness/TrilinosDevelopment -DRIVER_SCRIPT_DIR=$BASEDIR/Trilinos/cmake/ctest/drivers/exetazo - -# Source the -cd $HOME -source .bash_profile - -if [ "$_DAYOFWEEK" == "" ] ; then - _DAYOFWEEK=`date +%A` -fi - -echo "_DAYOFWEEK=$_DAYOFWEEK" - -echo -echo "Starting Trilinos continuous integration testing on exetazo: `date`" -echo - - -echo -echo "Checking out just the skeleton cmake/ctest code: `date`" -echo - -cd $BASEDIR -cvs -q -d :ext:software:/space/CVS co Trilinos/cmake Trilinos/CTestConfig.cmake - - -echo -echo "Doing mpi debug continuous builds: `date`" -echo - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_continuous_mpi_debug_shared_exetazo.cmake -VV \ - &> $BASEDIR/ctest_linux_continuous_mpi_debug_shared_exetazo.out - -echo -echo "Ending Trilinos continuous integration testing on exetazo: `date`" -echo - - -#/home/rabartl/mailmsg.py "Finished nightly Trilinos tests exetazo: http://trilinos-dev.sandia.gov/cdash/index.php?project=Trilinos" diff --git a/cmake/ctest/drivers/exetazo/cron_driver_exetazo.sh b/cmake/ctest/drivers/exetazo/cron_driver_exetazo.sh deleted file mode 100755 index a7666a2c772a..000000000000 --- a/cmake/ctest/drivers/exetazo/cron_driver_exetazo.sh +++ /dev/null @@ -1,192 +0,0 @@ -#!/bin/bash - -CTEST_EXE=/home/jmwille/install/cmake/bin/ctest -BASEDIR=/space/jmwille/TrilinosTestHarness/TrilinosDevelopment -DRIVER_SCRIPT_DIR=$BASEDIR/Trilinos/cmake/ctest/drivers/exetazo - -# Source the -cd $HOME -source .bash_profile - -if [ "$_DAYOFWEEK" == "" ] ; then - _DAYOFWEEK=`date +%A` -fi - -echo "_DAYOFWEEK=$_DAYOFWEEK" - -if [ "$_DAYOFWEEK" == "Saturday" ] ; then - _RUN_REGULAR_TESTS=1 - _RUN_COVERAGE_TESTS=1 - _RUN_MEMCHECK_TESTS=0 -elif [ "$_DAYOFWEEK" == "Sunday" ] ; then - _RUN_REGULAR_TESTS=0 - _RUN_COVERAGE_TESTS=0 - _RUN_MEMCHECK_TESTS=1 -else - _RUN_REGULAR_TESTS=1 - _RUN_COVERAGE_TESTS=0 - _RUN_MEMCHECK_TESTS=0 -fi - -echo "_RUN_REGULAR_TESTS=$_RUN_REGULAR_TESTS" -echo "_RUN_COVERAGE_TESTS=$_RUN_COVERAGE_TESTS" -echo "_RUN_MEMCHECK_TESTS=$_RUN_MEMCHECK_TESTS" - -#exit - - -echo -echo "Starting nightly Trilinos testing on exetazo: `date`" -echo - - -echo -echo "Checking out just the skeleton cmake/ctest code: `date`" -echo - -cd $BASEDIR -cvs -q -d :ext:software:/space/CVS co Trilinos/cmake Trilinos/CTestConfig.cmake - - -# -# Weekday tests -# - -if [ "$_RUN_REGULAR_TESTS" == "1" ] ; then - -echo -echo "Running weekday tests ..." -echo - -#echo -#echo "Doing serial performance build: `date`" -#echo - -#time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_serial_performance_godel.cmake -VV \ -# &> $BASEDIR/ctest_linux_nightly_serial_performance_godel.out - -#echo -#echo "Doing mpi optimized build: `date`" -#echo - -#time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_mpi_optimized_exetazo.cmake -VV \ -# &> $BASEDIR/ctest_linux_nightly_mpi_optimized_exetazo.out - -#echo -#echo "Doing serial debug build: `date`" -#echo - -#time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_serial_debug_godel.cmake -VV \ -# &> $BASEDIR/ctest_linux_nightly_serial_debug_godel.out - -#echo -#echo "Doing mpi optimized shared library build: `date`" -#echo - -#time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_mpi_optimized_shared_godel.cmake -VV \ -# &> $BASEDIR/ctest_linux_nightly_mpi_optimized_shared_godel.out - -#echo -#echo "Doing serial optimized implicit instantiation build: `date`" -#echo - -#time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_serial_opt_impl_instant_godel.cmake -VV \ -# &> $BASEDIR/ctest_linux_nightly_serial_opt_impl_instant_godel.out - -echo -echo "Doing mpi debug build: `date`" -echo - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_mpi_debug_exetazo.cmake -VV \ - &> $BASEDIR/ctest_linux_nightly_mpi_debug_exetazo.out - -#echo -#echo "Doing mpi optimized zoltan c-only build: `date`" -#echo - -#time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_mpi_opt_zoltan_c_godel.cmake -VV \ -# &> $BASEDIR/ctest_linux_nightly_mpi_opt_zoltan_c_godel.out - -#echo -#echo "Doing serial debug intel build: `date`" -#echo - -#time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_serial_debug_icpc_godel.cmake -VV \ -# &> $BASEDIR/ctest_linux_nightly_serial_debug_icpc_godel.out - -#echo -#echo "Doing serial release intel build: `date`" -#echo - -#time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_serial_release_icpc_godel.cmake -VV \ -# &> $BASEDIR/ctest_linux_nightly_serial_release_icpc_godel.out - -fi - - -# -# Coverage tests -# - -if [ "$_RUN_COVERAGE_TESTS" == "1" ] ; then - -#echo -#echo "Running coverage tests ..." -echo - -#echo -#echo "Doing serial debug coverage build: `date`" -#echo - -#time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_serial_debug_coverage_godel.cmake -VV \ -# &> $BASEDIR/ctest_linux_nightly_serial_debug_coverage_godel.out - -#echo -#echo "Doing mpi debug coverage build: `date`" -#echo - -#time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_mpi_debug_coverage_godel.cmake -VV \ -# &> $BASEDIR/ctest_linux_nightly_mpi_debug_coverage_godel.out - -fi - - -# -# Memcheck tests -# - -if [ "$_RUN_MEMCHECK_TESTS" == "1" ] ; then - -echo -echo "Running memcheck tests ..." -echo - -#echo -#echo "Doing serial debug memcheck build: `date`" -#echo - -#time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_serial_debug_memcheck_godel.cmake -VV \ -# &> $BASEDIR/ctest_linux_nightly_serial_debug_memcheck_godel.out - -#echo -#echo "Doing mpi debug memcheck build: `date`" -#echo - -#time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_mpi_debug_memcheck_godel.cmake -VV \ -# &> $BASEDIR/ctest_linux_nightly_mpi_debug_memcheck_godel.out - -echo -echo "Kill remaining 'memcheck' processes: `date`" -echo - -killall -s 9 memcheck - -fi - - -echo -echo "Ending nightly Trilinos testing on exetazo: `date`" -echo - - -#/home/rabartl/mailmsg.py "Finished nightly Trilinos tests exetazo: http://trilinos-dev.sandia.gov/cdash/index.php?project=Trilinos" diff --git a/cmake/ctest/drivers/exetazo/ctest_linux_continuous_mpi_debug_shared_exetazo.cmake b/cmake/ctest/drivers/exetazo/ctest_linux_continuous_mpi_debug_shared_exetazo.cmake deleted file mode 100644 index 40be4dc73eba..000000000000 --- a/cmake/ctest/drivers/exetazo/ctest_linux_continuous_mpi_debug_shared_exetazo.cmake +++ /dev/null @@ -1,92 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.exetazo.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG_CONTINUOUS) -SET(CTEST_TEST_TYPE CONTINUOUS) -#SET(CTEST_TEST_TYPE EXPERIMENTAL) -# Wipe binary tree once per script invocation -SET (CTEST_START_WITH_EMPTY_BINARY_DIRECTORY_ONCE TRUE) -# How long to run in minutes -SET (CTEST_CONTINUOUS_DURATION 600) -SET (CTEST_CONTINUOUS_INTERVAL 20) -SET (CTEST_TEST_TIMEOUT 720) -#SET(CTEST_DO_COVERAGE_TESTING TRUE) -#SET(CTEST_DO_MEMORY_TESTING TRUE) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DBUILD_SHARED_LIBS:BOOL=ON" - ) -# "-DTPL_ENABLE_ParMETIS:BOOL=ON" -# "-DParMETIS_LIBRARY_DIRS:PATH=/home/kddevin/code/ParMETIS3_1" -# "-DTPL_ENABLE_Scotch:BOOL=ON" -# "-DScotch_INCLUDE_DIRS:PATH=/home/kddevin/code/scotch_5.1/include" -# "-DScotch_LIBRARY_DIRS:PATH=/home/kddevin/code/scotch_5.1/lib" -# ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/exetazo/ctest_linux_nightly_mpi_debug_exetazo.cmake b/cmake/ctest/drivers/exetazo/ctest_linux_nightly_mpi_debug_exetazo.cmake deleted file mode 100644 index 1252f76b1586..000000000000 --- a/cmake/ctest/drivers/exetazo/ctest_linux_nightly_mpi_debug_exetazo.cmake +++ /dev/null @@ -1,88 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.exetazo.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG) -#SET(CTEST_TEST_TYPE CONTINUOUS) -SET(CTEST_TEST_TYPE EXPERIMENTAL) -#SET(CTEST_TEST_TIMEOUT 900) - -#SET(CTEST_DO_COVERAGE_TESTING TRUE) -#SET(CTEST_DO_MEMORY_TESTING TRUE) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DBUILD_SHARED_LIBS:BOOL=ON" - ) -# "-DTPL_ENABLE_ParMETIS:BOOL=ON" -# "-DParMETIS_LIBRARY_DIRS:PATH=/home/kddevin/code/ParMETIS3_1" -# "-DTPL_ENABLE_Scotch:BOOL=ON" -# "-DScotch_INCLUDE_DIRS:PATH=/home/kddevin/code/scotch_5.1/include" -# "-DScotch_LIBRARY_DIRS:PATH=/home/kddevin/code/scotch_5.1/lib" -# ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/exetazo/ctest_linux_nightly_mpi_optimized_exetazo.cmake b/cmake/ctest/drivers/exetazo/ctest_linux_nightly_mpi_optimized_exetazo.cmake deleted file mode 100644 index a648274f33ad..000000000000 --- a/cmake/ctest/drivers/exetazo/ctest_linux_nightly_mpi_optimized_exetazo.cmake +++ /dev/null @@ -1,87 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.exetazo.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT) -#SET(CTEST_TEST_TYPE CONTINUOUS) -SET(CTEST_TEST_TYPE EXPERIMENTAL) -#SET(CTEST_TEST_TIMEOUT 900) - -#SET(CTEST_DO_COVERAGE_TESTING TRUE) -#SET(CTEST_DO_MEMORY_TESTING TRUE) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - ) -# "-DTPL_ENABLE_ParMETIS:BOOL=ON" -# "-DParMETIS_LIBRARY_DIRS:PATH=/home/kddevin/code/ParMETIS3_1" -# "-DTPL_ENABLE_Scotch:BOOL=ON" -# "-DScotch_INCLUDE_DIRS:PATH=/home/kddevin/code/scotch_5.1/include" -# "-DScotch_LIBRARY_DIRS:PATH=/home/kddevin/code/scotch_5.1/lib" -# ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/exetazo/ctest_linux_nightly_serial_debug_exetazo.cmake b/cmake/ctest/drivers/exetazo/ctest_linux_nightly_serial_debug_exetazo.cmake deleted file mode 100644 index dfc5f3535e88..000000000000 --- a/cmake/ctest/drivers/exetazo/ctest_linux_nightly_serial_debug_exetazo.cmake +++ /dev/null @@ -1,94 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.exetazo.gcc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME "SERIAL_DEBUG_RELEASE_${Trilinos_VERSION}") -#SET(CTEST_TEST_TYPE EXPERIMENTAL) -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -set(CTEST_TEST_TIMEOUT "720") - -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_VERBOSE_CONFIGURE:BOOL=ON" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_UMFPACK:BOOL=ON" - "-DTPL_ENABLE_SuperLU:BOOL=ON" - "-DSuperLU_INCLUDE_DIRS:PATH=/home/jmwille/lib/SuperLU_3.0/SRC" - "-DSuperLU_LIBRARY_DIRS:PATH=/home/jmwille/lib/SuperLU_3.0" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu_3.0" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DBoost_INCLUDE_DIRS:FILEPATH=/home/jmwille/boost_1_35_0" - "-DTPL_ENABLE_Oski:BOOL=ON" - "-DTPL_ENABLE_y12m:BOOL=ON" - "-Dy12m_LIBRARY_DIRS:FILEPATH=/home/jmwille/install/y12m/lib" -) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/fissile4/checkin-test-fissile4.sh b/cmake/ctest/drivers/fissile4/checkin-test-fissile4.sh deleted file mode 100755 index b9696556a658..000000000000 --- a/cmake/ctest/drivers/fissile4/checkin-test-fissile4.sh +++ /dev/null @@ -1,123 +0,0 @@ -#!/bin/bash - -# Used to test Trilinos on any of the ORNL CASL Fissile/Spy machines -# -# This script requires that the VERA dev env be loaded by sourcing the script: -# -# . /projects/vera/gcc-4.8.3/load_dev_env.[sh,csh] -# -# You can source this script either in your shell startup script -# (e.g. .bash_profile) or you can source it manually whenever you need to set -# up to build VERA software. -# -# NOTE: This script should not be directly modified by typical CASL -# developers except, perhaps to add new extra builds. -# -# NOTE: You can pass through arguments with spaces using quotes like: -# -# --ctest-options="-E '(Test1|Test2)'" -# -# and it will preserve the spaces correctly. If you want to pass along -# quotes, you have to escape them like: -# -# --ctest-options="-E \"(Test1|Test2)\"" -# -# The default location for this directory tree is: -# -# Trilinos.base -# Trilinos (your Trilinos soruce tree) -# BUILDS -# CHECKIN (where you run this script from) -# -if [ "$TRILINOS_BASE_DIR" == "" ] ; then - TRILINOS_BASE_DIR=../.. -fi - -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,STK,TriKota - -# Check to make sure that the env has been loaded correctly -if [ "$LOADED_TRIBITS_DEV_ENV" != "gcc-4.8.3" ] ; then - echo "Error, must source /projects/vera/gcc-4.8.3/load_dev_env.[sh,csh] before running checkin-test-vera.sh!" - exit 1 -fi - -echo " --DTrilinos_DISABLE_ENABLED_FORWARD_DEP_PACKAGES=ON -" > COMMON.config - -# -# Built-in Primary Tested (PT) --default-builds (DO NOT MODIFY) -# - -echo " --DTrilinos_CONFIGURE_OPTIONS_FILE:FILEPATH='$DRIVERS_BASE_DIR/gcc-4.8.3-base-options.cmake,$DRIVERS_BASE_DIR/trilinos-tpls-gcc.4.8.3.cmake' -" > MPI_DEBUG.config - -echo " --DTrilinos_CONFIGURE_OPTIONS_FILE:FILEPATH='$DRIVERS_BASE_DIR/gcc-4.8.3-base-options.cmake,$DRIVERS_BASE_DIR/trilinos-tpls-gcc.4.8.3.cmake' -" > SERIAL_RELEASE.config - -# -# Standard Secondary Tested (ST) --st-extra-builds (DO NOT MODIFY) -# - -echo " --DTrilinos_CONFIGURE_OPTIONS_FILE:FILEPATH='$DRIVERS_BASE_DIR/gcc-4.8.3-base-options.cmake,$DRIVERS_BASE_DIR/trilinos-tpls-gcc.4.8.3.cmake' --DCMAKE_BUILD_TYPE=RELEASE --DTrilinos_ENABLE_DEBUG=ON --DTPL_ENABLE_MPI=ON -" > MPI_DEBUG_ST.config - -echo " --DTrilinos_CONFIGURE_OPTIONS_FILE:FILEPATH='$DRIVERS_BASE_DIR/gcc-4.8.3-base-options.cmake,$DRIVERS_BASE_DIR/trilinos-tpls-gcc.4.8.3.cmake' --DCMAKE_BUILD_TYPE=RELEASE --DTrilinos_ENABLE_DEBUG=OFF --DTPL_ENABLE_MPI=OFF -" > SERIAL_RELEASE_ST.config - -# -# --extra-builds -# - -echo " --DTrilinos_CONFIGURE_OPTIONS_FILE:FILEPATH='$DRIVERS_BASE_DIR/gcc-4.8.3-base-options.cmake,$DRIVERS_BASE_DIR/trilinos-tpls-gcc.4.8.3.cmake' --DCMAKE_BUILD_TYPE:STRING=RELEASE --DTrilinos_ENABLE_DEBUG:BOOL=OFF -" > MPI_RELEASE.config - -# Create local defaults file if one does not exist -_LOCAL_CHECKIN_TEST_DEFAULTS=local-checkin-test-defaults.py -if [ -f $_LOCAL_CHECKIN_TEST_DEFAULTS ] ; then - echo "File $_LOCAL_CHECKIN_TEST_DEFAULTS already exists, leaving it!" -else - echo "Creating default file $_LOCAL_CHECKIN_TEST_DEFAULTS!" - echo " -defaults = [ - \"-j16\", - \"--ctest-timeout=180\", - \"--st-extra-builds=MPI_DEBUG_ST,SERIAL_RELEASE_ST\", - \"--disable-packages=$DISABLE_PACKAGES\", - \"--skip-case-no-email\", - \"--ctest-options=-E '(MueLu_ParameterListInterpreterEpetra|MueLu_ParameterListInterpreterTpetra|Belos_pseudo_ptfqmr_hb_1_MPI_4|Belos_pseudo_ptfqmr_hb_3_MPI_4)'\", - ] - " > $_LOCAL_CHECKIN_TEST_DEFAULTS -fi - -# -# Invocation -# - -$TRILINOS_BASE_DIR/Trilinos/checkin-test.py \ -"$@" - - -# --ctest-options="-E '(Piro_AnalysisDriver|Stokhos_Linear2D_Diffusion_GMRES_KLR|Panzer_STK_ResponseLibraryTest|MueLu_|Amesos2_|Rythmos_ImplicitRK_UnitTest_MPI_1|SEACASExodus_exodus_unit_tests|Intrepid_test_Discretization_Basis_HGRAD_TRI_Cn_FEM_Test_02_MPI_1|Intrepid_test_Discretization_Basis_HDIV_TET_In_FEM_Test_02_MPI_1|Intrepid_test_Discretization_Basis_HGRAD_TET_Cn_FEM_Test_02_MPI_1|Sundance_BesselTest2D_MPI_1|ThyraTpetraAdapters_TpetraThyraWrappersUnitTests_serial|Ifpack2_RILUKSingleProcessUnitTests)'" - -# NOTE: By default we use 16 processes which is 1/2 of the 32 processes on a -# fissile 4 machine. This way two people can build and test without taxing -# the machine too much. diff --git a/cmake/ctest/drivers/fissile4/do-configure.MPI_DEBUG_DEBUG_SHARED_GCC483 b/cmake/ctest/drivers/fissile4/do-configure.MPI_DEBUG_DEBUG_SHARED_GCC483 deleted file mode 100755 index 7ed4ea766965..000000000000 --- a/cmake/ctest/drivers/fissile4/do-configure.MPI_DEBUG_DEBUG_SHARED_GCC483 +++ /dev/null @@ -1,38 +0,0 @@ -#!/bin/bash - -EXTRA_ARGS=$@ - -if [ "$TRILINOS_DIR" == "" ] ; then - _ABS_FILE_PATH=`readlink -f $0` - _SCRIPT_DIR=`dirname $_ABS_FILE_PATH` - TRILINOS_DIR=$_SCRIPT_DIR/../../../.. -fi - -TRILINOS_DIR_ABS=$(readlink -f $TRILINOS_DIR) -echo "TRILINOS_DIR_ABS = $TRILINOS_DIR_ABS" - -DRIVERS_BASE_DIR=$TRILINOS_DIR_ABS/cmake/ctest/drivers/fissile4 - -cmake \ --D Trilinos_CONFIGURE_OPTIONS_FILE:FILEPATH="$DRIVERS_BASE_DIR/gcc-4.8.3-base-options.cmake,$DRIVERS_BASE_DIR/trilinos-tpls-gcc.4.8.3.cmake" \ --D TPL_ENABLE_MPI=ON \ --D CMAKE_BUILD_TYPE=DEBUG \ --D Trilinos_ENABLE_DEBUG=ON \ --D BUILD_SHARED_LIBS:BOOL=ON \ --D Trilinos_ENABLE_TESTS=ON \ --D Trilinos_ENABLE_EXPLICIT_INSTANTIATION=ON \ --D DART_TESTING_TIMEOUT=180.0 \ --D CTEST_BUILD_FLAGS="-j12" \ --D CTEST_PARALLEL_LEVEL="12" \ --D TPL_ENABLE_BinUtils:BOOL=OFF \ --D Teuchos_ENABLE_COMPLEX=OFF \ --D Tpetra_INST_COMPLEX_DOUBLE=OFF \ --D Tpetra_INST_COMPLEX_FLOAT=OFF \ --D Tpetra_INST_FLOAT=OFF \ --D Teuchos_ENABLE_FLOAT=OFF \ --D Trilinos_ENABLE_TESTS:BOOL=ON \ --D Trilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON \ --D Trilinos_ENABLE_CONFIGURE_TIMING:BOOL=ON \ --D Teuchos_ENABLE_DEFAULT_STACKTRACE:BOOL=ON \ -$EXTRA_ARGS \ -${TRILINOS_DIR_ABS} diff --git a/cmake/ctest/drivers/fissile4/do-configure.MPI_DEBUG_DEBUG_STATIC_GCC483 b/cmake/ctest/drivers/fissile4/do-configure.MPI_DEBUG_DEBUG_STATIC_GCC483 deleted file mode 100755 index 80bf55451e6b..000000000000 --- a/cmake/ctest/drivers/fissile4/do-configure.MPI_DEBUG_DEBUG_STATIC_GCC483 +++ /dev/null @@ -1,41 +0,0 @@ -#!/bin/bash - -EXTRA_ARGS=$@ - -if [ "$TRILINOS_DIR" == "" ] ; then - _ABS_FILE_PATH=`readlink -f $0` - _SCRIPT_DIR=`dirname $_ABS_FILE_PATH` - TRILINOS_DIR=$_SCRIPT_DIR/../../../.. -fi - -TRILINOS_DIR_ABS=$(readlink -f $TRILINOS_DIR) -echo "TRILINOS_DIR_ABS = $TRILINOS_DIR_ABS" - -DRIVERS_BASE_DIR=$TRILINOS_DIR_ABS/cmake/ctest/drivers/fissile4 - -cmake \ --D Trilinos_CONFIGURE_OPTIONS_FILE:FILEPATH="$DRIVERS_BASE_DIR/gcc-4.8.3-base-options.cmake,$DRIVERS_BASE_DIR/trilinos-tpls-gcc.4.8.3.cmake" \ --D TPL_ENABLE_MPI=ON \ --D CMAKE_BUILD_TYPE=DEBUG \ --D Trilinos_ENABLE_DEBUG=ON \ --D Trilinos_ENABLE_TESTS=ON \ --D Trilinos_ENABLE_EXPLICIT_INSTANTIATION=ON \ --D DART_TESTING_TIMEOUT=180.0 \ --D CTEST_BUILD_FLAGS="-j16" \ --D CTEST_PARALLEL_LEVEL="16" \ --D BUILD_SHARED_LIBS:BOOL=OFF \ --D TPL_ENABLE_BinUtils:BOOL=ON \ --D Teuchos_ENABLE_COMPLEX=OFF \ --D Tpetra_INST_COMPLEX_DOUBLE=OFF \ --D Tpetra_INST_COMPLEX_FLOAT=OFF \ --D Tpetra_INST_FLOAT=OFF \ --D Teuchos_ENABLE_FLOAT=OFF \ --D Trilinos_ENABLE_TESTS:BOOL=ON \ --D Trilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON \ --D Trilinos_ENABLE_CONFIGURE_TIMING:BOOL=ON \ --D Teuchos_ENABLE_DEFAULT_STACKTRACE:BOOL=ON \ -$EXTRA_ARGS \ -${TRILINOS_DIR_ABS} - -# Above, I am using the core build options for CASL development but I am doing -# a true debug, with explicit instantiation, stack tracing, etc. diff --git a/cmake/ctest/drivers/fissile4/do-configure.MPI_RELEASE_DEBUG_SHARED_GCC483 b/cmake/ctest/drivers/fissile4/do-configure.MPI_RELEASE_DEBUG_SHARED_GCC483 deleted file mode 100755 index 4805e7f171c0..000000000000 --- a/cmake/ctest/drivers/fissile4/do-configure.MPI_RELEASE_DEBUG_SHARED_GCC483 +++ /dev/null @@ -1,41 +0,0 @@ -#!/bin/bash - -EXTRA_ARGS=$@ - -if [ "$TRILINOS_DIR" == "" ] ; then - _ABS_FILE_PATH=`readlink -f $0` - _SCRIPT_DIR=`dirname $_ABS_FILE_PATH` - TRILINOS_DIR=$_SCRIPT_DIR/../../../.. -fi - -TRILINOS_DIR_ABS=$(readlink -f $TRILINOS_DIR) -echo "TRILINOS_DIR_ABS = $TRILINOS_DIR_ABS" - -DRIVERS_BASE_DIR=$TRILINOS_DIR_ABS/cmake/ctest/drivers/fissile4 - -cmake \ --D Trilinos_CONFIGURE_OPTIONS_FILE:FILEPATH="$DRIVERS_BASE_DIR/gcc-4.8.3-base-options.cmake,$DRIVERS_BASE_DIR/trilinos-tpls-gcc.4.8.3.cmake" \ --D TPL_ENABLE_MPI=ON \ --D CMAKE_BUILD_TYPE=RELEASE \ --D Trilinos_ENABLE_DEBUG=ON \ --D Trilinos_ENABLE_TESTS=ON \ --D Trilinos_ENABLE_EXPLICIT_INSTANTIATION=ON \ --D DART_TESTING_TIMEOUT=180.0 \ --D CTEST_BUILD_FLAGS="-j16" \ --D CTEST_PARALLEL_LEVEL="16" \ --D BUILD_SHARED_LIBS:BOOL=ON \ --D TPL_ENABLE_BinUtils:BOOL=OFF \ --D Teuchos_ENABLE_COMPLEX=OFF \ --D Tpetra_INST_COMPLEX_DOUBLE=OFF \ --D Tpetra_INST_COMPLEX_FLOAT=OFF \ --D Tpetra_INST_FLOAT=OFF \ --D Teuchos_ENABLE_FLOAT=OFF \ --D Trilinos_ENABLE_TESTS:BOOL=ON \ --D Trilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON \ --D Trilinos_ENABLE_CONFIGURE_TIMING:BOOL=ON \ --D Teuchos_ENABLE_DEFAULT_STACKTRACE:BOOL=ON \ -$EXTRA_ARGS \ -${TRILINOS_DIR_ABS} - -# Above, I am using the core build options for CASL development but I am doing -# a true debug, with explicit instantiation, stack tracing, etc. diff --git a/cmake/ctest/drivers/fissile4/do-configure.SERIAL_RELEASE_SHARED_GCC483 b/cmake/ctest/drivers/fissile4/do-configure.SERIAL_RELEASE_SHARED_GCC483 deleted file mode 100755 index e92cd745a36e..000000000000 --- a/cmake/ctest/drivers/fissile4/do-configure.SERIAL_RELEASE_SHARED_GCC483 +++ /dev/null @@ -1,41 +0,0 @@ -#!/bin/bash - -EXTRA_ARGS=$@ - -if [ "$TRILINOS_DIR" == "" ] ; then - _ABS_FILE_PATH=`readlink -f $0` - _SCRIPT_DIR=`dirname $_ABS_FILE_PATH` - TRILINOS_DIR=$_SCRIPT_DIR/../../../.. -fi - -TRILINOS_DIR_ABS=$(readlink -f $TRILINOS_DIR) -echo "TRILINOS_DIR_ABS = $TRILINOS_DIR_ABS" - -DRIVERS_BASE_DIR=$TRILINOS_DIR_ABS/cmake/ctest/drivers/fissile4 - -cmake \ --D Trilinos_CONFIGURE_OPTIONS_FILE:FILEPATH="$DRIVERS_BASE_DIR/gcc-4.8.3-base-options.cmake,$DRIVERS_BASE_DIR/trilinos-tpls-gcc.4.8.3.cmake" \ --D TPL_ENABLE_MPI=OFF \ --D CMAKE_BUILD_TYPE=RELEASE \ --D Trilinos_ENABLE_DEBUG=OFF \ --D Trilinos_ENABLE_TESTS=ON \ --D Trilinos_ENABLE_EXPLICIT_INSTANTIATION=ON \ --D DART_TESTING_TIMEOUT=180.0 \ --D CTEST_BUILD_FLAGS="-j16" \ --D CTEST_PARALLEL_LEVEL="16" \ --D BUILD_SHARED_LIBS:BOOL=ON \ --D TPL_ENABLE_BinUtils:BOOL=OFF \ --D Teuchos_ENABLE_COMPLEX=OFF \ --D Tpetra_INST_COMPLEX_DOUBLE=OFF \ --D Tpetra_INST_COMPLEX_FLOAT=OFF \ --D Tpetra_INST_FLOAT=OFF \ --D Teuchos_ENABLE_FLOAT=OFF \ --D Trilinos_ENABLE_TESTS:BOOL=ON \ --D Trilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON \ --D Trilinos_ENABLE_CONFIGURE_TIMING:BOOL=ON \ --D Teuchos_ENABLE_DEFAULT_STACKTRACE:BOOL=ON \ -$EXTRA_ARGS \ -${TRILINOS_DIR_ABS} - -# Above, I am using the core build options for CASL development but I am doing -# a true debug, with explicit instantiation, stack tracing, etc. diff --git a/cmake/ctest/drivers/fissile4/gcc-4.8.3-base-options.cmake b/cmake/ctest/drivers/fissile4/gcc-4.8.3-base-options.cmake deleted file mode 100644 index 3b04d177ca11..000000000000 --- a/cmake/ctest/drivers/fissile4/gcc-4.8.3-base-options.cmake +++ /dev/null @@ -1,45 +0,0 @@ -# -# Base options for all GCC 4.8.3 builds -# - -# Define the core compilers -IF (NOT TRILINOS_TOOLSET_BASE) - SET(TRILINOS_TOOLSET_BASE /projects/vera/gcc-4.8.3/toolset) -ENDIF() -SET(GCC_BASE_DIR ${TRILINOS_TOOLSET_BASE}/gcc-4.8.3) - -# Point to the right MPI -SET(MPI_BASE_DIR "${TRILINOS_TOOLSET_BASE}/mpich-3.1.3" CACHE PATH "") - -IF (NOT TPL_ENABLE_MPI) - SET(CMAKE_C_COMPILER gcc) - SET(CMAKE_CXX_COMPILER g++) - SET(CMAKE_Fortran_COMPILER gfortran) -ENDIF() - -# Add rpath for compiler libraries and gomp for parts built with OpenMP -SET(${PROJECT_NAME}_EXTRA_LINK_FLAGS - "-lgomp -Wl,-rpath,${GCC_BASE_DIR}/lib64" - CACHE STRING "") - -# Build shared libs by default to save massive amounts of disk space -SET(BUILD_SHARED_LIBS ON CACHE BOOL - "Set by default in gcc-4.8.3-base-options.cmake") - -# Turn on explicit template instantaition by default -SET(Trilinos_ENABLE_EXPLICIT_INSTANTIATION ON CACHE BOOL - "Set by default in gcc-4.8.3-base-options.cmake") - -# Turn on KLU2 in Amesos2 -SET(Amesos2_ENABLE_KLU2 ON CACHE BOOL - "Set by default in gcc-4.8.3-base-options.cmake") - -# Set up valgrind options -SET( MEMORYCHECK_COMMAND - /projects/vera/common_tools/valgrind-3.9.0/bin/valgrind - CACHE FILEPATH - "Set by default in gcc-4.8.3-base-options.cmake") -SET( MEMORYCHECK_COMMAND_OPTIONS - "-q --trace-children=yes --tool=memcheck --leak-check=yes --leak-check=full --workaround-gcc296-bugs=yes --num-callers=50" - CACHE STRING - "Set by default in gcc-4.8.3-base-options.cmake") diff --git a/cmake/ctest/drivers/fissile4/local-checkin-test-defaults.th232.py b/cmake/ctest/drivers/fissile4/local-checkin-test-defaults.th232.py deleted file mode 100644 index 74da8d94554b..000000000000 --- a/cmake/ctest/drivers/fissile4/local-checkin-test-defaults.th232.py +++ /dev/null @@ -1,12 +0,0 @@ - -defaults = [ - "-j12", - "--ctest-timeout=180", - "--st-extra-builds=", - "--disable-packages=PyTrilinos,Pliris,STK,TriKota", - "--skip-case-no-email", - "--ctest-options=\"-E '(MueLu_ParameterListInterpreterEpetra|MueLu_ParameterListInterpreterTpetra)'\"", - ] - -# Above, I have given up on running --st-extra-builds because they are alway -# so broken. Just the PT --default-builds are often broken. diff --git a/cmake/ctest/drivers/fissile4/trilinos-tpls-gcc.4.8.3.cmake b/cmake/ctest/drivers/fissile4/trilinos-tpls-gcc.4.8.3.cmake deleted file mode 100644 index 11117ba3b011..000000000000 --- a/cmake/ctest/drivers/fissile4/trilinos-tpls-gcc.4.8.3.cmake +++ /dev/null @@ -1,63 +0,0 @@ -# -# Trilinos TPLs -# - -# Give a default TPL_INSTALL_DIR if not set! -IF (NOT TPL_INSTALL_DIR) - SET(TPL_INSTALL_DIR_DEFAULT_STATIC - "/projects/vera/gcc-4.8.3/tpls/opt_static") - IF ( (NOT BUILD_SHARED_LIBS) AND (EXISTS "${TPL_INSTALL_DIR_DEFAULT_STATIC}") ) - SET(TPL_INSTALL_DIR_DEFAULT "${TPL_INSTALL_DIR_DEFAULT_STATIC}") - ELSE() - SET(TPL_INSTALL_DIR_DEFAULT "/projects/vera/gcc-4.8.3/tpls/opt") - ENDIF() - MESSAGE("-- " "TPL_INSTALL_DIR not set so setting by default to" - " ${TPL_INSTALL_DIR_DEFAULT}!") - SET(TPL_INSTALL_DIR "${TPL_INSTALL_DIR_DEFAULT}" CACHE PATH - "Set by default in vera-tpls-std.cmake") -ENDIF() - -# NOTE: Above we turn on all the TPLs, reguardless of packages are enabled. -# If a VERA repo is not enabled that defines one of these TPLs, the enables -# are no-ops. This ensures that the same XXX_config.h files get generated. -# For exmaple, Teuchos defines an optional dependence on QT. However, if you -# don't enable the SCALE packages, QT (which is required for SCALE) does not -# get enabled and Teuchos_config.h does not define HAVE_TEUCHOS_QT. This -# causes the Teuchos_config.h file to keep changing with different package -# enables. If you don't want to enable one of these TPLs (because you know -# you don't need it) you can just pass in -DTPL_ENABLE_=OFF and it -# will override the above cache enable. - -SET(BLAS_LIBRARY_DIRS "${TPL_INSTALL_DIR}/lapack-3.3.1/lib" CACHE FILEPATH "") -SET(LAPACK_LIBRARY_DIRS "${TPL_INSTALL_DIR}/lapack-3.3.1/lib" CACHE FILEPATH "") - -SET(Boost_DIR "${TPL_INSTALL_DIR}/boost-1.55.0") -SET(Boost_INCLUDE_DIRS "${Boost_DIR}/include" CACHE FILEPATH "") - -SET(BoostLib_LIBRARY_NAMES "boost_system;boost_thread;boost_program_options" CACHE STRING "") -SET(BoostLib_INCLUDE_DIRS ${Boost_INCLUDE_DIRS} CACHE FILEPATH "") -SET(BoostLib_LIBRARY_DIRS "${Boost_DIR}/lib" CACHE FILEPATH "") - -SET(Zlib_INCLUDE_DIRS "${TPL_INSTALL_DIR}/zlib-1.2.7/include" CACHE FILEPATH "" ) -SET(Zlib_LIBRARY_DIRS "${TPL_INSTALL_DIR}/zlib-1.2.7/lib" CACHE FILEPATH "" ) - -SET(HDF5_DIR "${TPL_INSTALL_DIR}/hdf5-1.8.10") -SET(HDF5_LIB_DIR "${HDF5_DIR}/lib") -SET(HDF5_LIBRARY_NAMES "hdf5_hl;hdf5_cpp;hdf5_fortran;hdf5;z" CACHE STRING "") -SET(HDF5_INCLUDE_DIRS - "${HDF5_DIR}/include;${TPL_COMMON_DIR}/zlib-1.2.7/include" - CACHE FILEPATH "" ) -SET(HDF5_LIBRARY_DIRS - "${HDF5_LIB_DIR};${TPL_INSTALL_DIR}/zlib-1.2.7/lib" - CACHE FILEPATH "" ) - -SET(QT_REQUIRED_VERSION 4.7.1 CACHE STRING "" ) -SET(QT_QMAKE_EXECUTABLE ${TPL_INSTALL_DIR}/qt-4.8.2/bin/qmake CACHE FILEPATH "" ) - -# TriKota Hack! -# Must force this varible in the Dakota configure process -SET(BOOST_INCLUDEDIR ${Boost_INCLUDE_DIRS} CACHE PATH "" FORCE) - -# Disable TPLs we don't have on this system by default -SET(TPL_ENABLE_Netcdf OFF CACHE BOOL - "Set in trilinos-tpls-gcc.4.8.3.cmake" ) diff --git a/cmake/ctest/drivers/gabriel/CMakeLists.txt b/cmake/ctest/drivers/gabriel/CMakeLists.txt deleted file mode 100644 index f446ad316705..000000000000 --- a/cmake/ctest/drivers/gabriel/CMakeLists.txt +++ /dev/null @@ -1,28 +0,0 @@ -TRILINOS_DRIVER_SETUP() - -# Set a timeout of 7 hours for an individual build run in parallel with other -# builds -SET(TIMEOUT_MINUTES 420) - -TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_DEBUG_PS - ctest_linux_nightly_mpi_debug_gabriel.cmake - CTEST_INSTALLER_TYPE release - TIMEOUT_MINUTES ${TIMEOUT_MINUTES} - ) - -TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_RELEASE_PS - ctest_linux_nightly_serial_release_gabriel.cmake - CTEST_INSTALLER_TYPE release - TIMEOUT_MINUTES ${TIMEOUT_MINUTES} - ) - -TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG_NOTRACE - ctest_linux_nightly_serial_debug_notracing_gabriel.cmake - CTEST_INSTALLER_TYPE release - TIMEOUT_MINUTES 150 - ) - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/gabriel/TrilinosCTestDriverCore.gabriel.gcc.cmake b/cmake/ctest/drivers/gabriel/TrilinosCTestDriverCore.gabriel.gcc.cmake deleted file mode 100644 index 236a5cadaa6a..000000000000 --- a/cmake/ctest/drivers/gabriel/TrilinosCTestDriverCore.gabriel.gcc.cmake +++ /dev/null @@ -1,128 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for godel using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - #SET( CTEST_BUILD_FLAGS "-j4 -i" ) - #SET( CTEST_PARALLEL_LEVEL 4 ) - SET( CTEST_BUILD_FLAGS "-j6 -i" ) - SET( CTEST_PARALLEL_LEVEL 6 ) - - SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF ) - - # The CheckinTest unit test fails for some reason on gabriel in nighlty - # mode. However, it passes when I run it it locally and it gets run nightly - # on other machines so I will disable this for now. If someone else reports - # a problem then I will look into this further. - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES TriBITS ) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=RELEASE" - "-DCOVERAGE_COMMAND:FILEPATH=/usr/bin/gcov" - "-DMEMORYCHECK_COMMAND:FILEPATH=/usr/bin/valgrind" - "-DZoltan_ENABLE_TESTS:BOOL=OFF" - ) - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_godel_openmpi_1.2.7.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - SET_DEFAULT(COMPILER_VERSION "GCC-3.4.6") - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - #"-DCMAKE_CXX_COMPILER:FILEPATH=/usr/local/gcc-4.2.0/bin/g++" - #"-DCMAKE_C_COMPILER:FILEPATH=/usr/local/gcc-4.2.0/bin/gcc" - #"-DCMAKE_Fortran_COMPILER:FILEPATH=/usr/local/gcc-4.2.0/bin/gfortran" - ) - - SET_DEFAULT(COMPILER_VERSION "GCC-3.4.6") - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/gabriel/bash_profile b/cmake/ctest/drivers/gabriel/bash_profile deleted file mode 100644 index fe49a84080c6..000000000000 --- a/cmake/ctest/drivers/gabriel/bash_profile +++ /dev/null @@ -1,22 +0,0 @@ -# .bash_profile - -# Get the aliases and functions -if [ -f ~/.bashrc ]; then - . ~/.bashrc -fi - -unset USERNAME - -# Setup ssh agent for passwordless access to other machines -export CVS_RSH=ssh -./ssh-passkey-setup.sh - -# Setup for CUBIT -export PATH=/usr/local/cubit-10.2:$PATH - -# Set my editor -export EDITOR="xemacs -nw" - -# User specific environment and startup programs - -export PATH=$HOME/bin:/usr/local/bin:/usr/local/Adobe/Acrobat7.0/bin:$PATH diff --git a/cmake/ctest/drivers/gabriel/cron_driver_gabriel.sh b/cmake/ctest/drivers/gabriel/cron_driver_gabriel.sh deleted file mode 100755 index e45a4769251f..000000000000 --- a/cmake/ctest/drivers/gabriel/cron_driver_gabriel.sh +++ /dev/null @@ -1,24 +0,0 @@ -#!/bin/bash - -# This script must be run from this directory! - -echo -echo "Starting nightly Trilinos testing on gabriel: `date`" -echo - -SCRIPT_DIR=$PWD -cd $HOME -source $SCRIPT_DIR/bash_profile -cd - - -export TDD_PARALLEL_LEVEL=2 -#export TDD_PARALLEL_LEVEL=1 -export TDD_HTTP_PROXY="http://wwwproxy.sandia.gov:80/" -export TDD_CTEST_TEST_TYPE=Nightly -time /usr/local/bin/python ../cron_driver.py - -echo -echo "Ending nightly Trilinos testing on gabriel: `date`" -echo - -/home/rabartl/mailmsg.py "Finished nightly Trilinos CMake tests gabriel: http://trilinos-dev.sandia.gov/cdash/index.php?project=Trilinos" diff --git a/cmake/ctest/drivers/gabriel/ctest_linux_nightly_mpi_debug_gabriel.cmake b/cmake/ctest/drivers/gabriel/ctest_linux_nightly_mpi_debug_gabriel.cmake deleted file mode 100644 index 414c3c6788d3..000000000000 --- a/cmake/ctest/drivers/gabriel/ctest_linux_nightly_mpi_debug_gabriel.cmake +++ /dev/null @@ -1,77 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.gabriel.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_DEBUG_PS) -#SET(CTEST_TEST_TIMEOUT 900) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/gabriel/ctest_linux_nightly_serial_debug_notracing_gabriel.cmake b/cmake/ctest/drivers/gabriel/ctest_linux_nightly_serial_debug_notracing_gabriel.cmake deleted file mode 100644 index eb156985c138..000000000000 --- a/cmake/ctest/drivers/gabriel/ctest_linux_nightly_serial_debug_notracing_gabriel.cmake +++ /dev/null @@ -1,81 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.gabriel.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_NOTRACE) -#SET(CTEST_TEST_TIMEOUT 900) - -# Only test packages that uses RCP up to Thyra -SET(Trilinos_PACKAGES Teuchos RTOp EpetraExt Thyra) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_CHECKED_STL:BOOL=ON" - "-DTeuchos_ENABLE_DEBUG_RCP_NODE_TRACING:BOOL=OFF" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/gabriel/ctest_linux_nightly_serial_release_gabriel.cmake b/cmake/ctest/drivers/gabriel/ctest_linux_nightly_serial_release_gabriel.cmake deleted file mode 100644 index ef686bab8d2e..000000000000 --- a/cmake/ctest/drivers/gabriel/ctest_linux_nightly_serial_release_gabriel.cmake +++ /dev/null @@ -1,80 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.gabriel.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_RELEASE_PS) -#SET(CTEST_TEST_TIMEOUT 900) - -# 2009/08/28: Sundance is not building for this build case. Kevin long said -# to turn it off for now. -SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES TriBITS Sundance ) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/gaia/README b/cmake/ctest/drivers/gaia/README deleted file mode 100644 index ea2babd427b3..000000000000 --- a/cmake/ctest/drivers/gaia/README +++ /dev/null @@ -1,67 +0,0 @@ -(2016/11/22) - -This is the simplest CI server you can possibily imagine. I looked at setting -this up with the TriBITS Dashboard Driver (TDD) system but that is such an -ugly system that I just could not go through with it. Therefore, I have -decided that I am going to abandon that old system and create a new TriBITS -Dashboard Driver Plus system that is the most simple and minimal possible to -use CMake/CTest/CDash to drive and monitor the ctest -S script invocations. -But until I can do that, I went with a simple appraoch described below. - -To get this set up on a new machine, just do: - - mkdir - cd / - git clone git@github.com:trilinos/Trilinos.git - cd Trilinos/ - git checkout --track origin/develop - git branch -d master - -Then create a cronjob (or Jenkins job) that does: - - cd / && ./Trilinos/cmake/ctest/drivers/sems_ci/trilinos_ci_sever.sh \ - &> trilinos_ci_sever.out - -That is it! - -To set up this simple system, I started with a basic ctest -S driver script: - - ctest_linux_mpi_debug_shared_pt_ci.sems.cmake - -using TribitsCTestDriverCore.cmake (just like any other automated Trilinos -build). Then I call that in a simple shell script: - - single_ci_iter.sh - -which just sources the standard SEMS env script and calls the ctest -S driver -script. - -The last part to this simple CI server is the script: - - trilinos_ci_sever.sh - -which uses the simple Python script generic-looping-demon.py to do the CI -loops. - -That is it! - -There are a few major weaknesses to this approach: - -1) If a change is made to the build systems for Trilinos (i.e. in Trilinos or -TriBITS), then the you may get an error since the version of -ctest_linux_mpi_debug_shared_pt_ci.sems.cmake and TribitsCTestDriverCore.cmake -that runs may not be consistent with the updated version of Trilinos and -TriBITS that is pulled by TribitsCTestDriverCore.cmake. If that happens, one -just needs to kill trilinos_ci_server.sh (using kill-pstree.py) and just run -it again with nohup. - -2) If something goes wrong in the early stages of the CTest -S drivers script, -then the CI build is just not uploaded to the Trilinos CDash site and we can't -see if there are any failures. - -3) If things go well, the only way to see what the ctest -S script is doing is -to look at the local trilinos_ci_server.out log file (since it never gets -posted to a CDash site). - -Therefore, this is a temporary solution until we can get something better in -place using a combination of CMake/CTest/CDash and/or Jenkins. diff --git a/cmake/ctest/drivers/gaia/TrilinosCTestDriverCore.sems.cmake b/cmake/ctest/drivers/gaia/TrilinosCTestDriverCore.sems.cmake deleted file mode 100644 index 4113ce274b10..000000000000 --- a/cmake/ctest/drivers/gaia/TrilinosCTestDriverCore.sems.cmake +++ /dev/null @@ -1,84 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for trilinos-test2 using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_BUILD_FLAGS "-j10 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "10" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS ) - # No options to set! When the SEMS env is loaded correctly, the compilers, - # MPI, and the TPLs will be found automatically! - - SET_DEFAULT(COMPILER_VERSION "GCC-4.8.4") - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/gaia/ctest_darwin_mpi_debug_pytrilinos_ci.sems.cmake b/cmake/ctest/drivers/gaia/ctest_darwin_mpi_debug_pytrilinos_ci.sems.cmake deleted file mode 100644 index a0f2da812552..000000000000 --- a/cmake/ctest/drivers/gaia/ctest_darwin_mpi_debug_pytrilinos_ci.sems.cmake +++ /dev/null @@ -1,89 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.sems.cmake") - -# -# Set the options specific to this build case -# - -SET(BUILD_DIR_NAME MPI_RELEASE_DEBUG_SHARED_PT_CI) -#SET(CTEST_TEST_TIMEOUT 900) - -#override the default number of processors to run on. -SET( CTEST_BUILD_FLAGS "-j16 -i" ) -SET( CTEST_PARALLEL_LEVEL "16" ) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - -SET(Trilinos_ENABLE_CONFIGURE_TIMING ON) - -SET(Trilinos_BRANCH develop) - -SET(EXTRA_EXCLUDE_PACKAGES) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_CONFIGURE_OPTIONS_FILE:STRING=cmake/std/MpiReleaseDebugSharedPtSettings.cmake,cmake/std/BasicCiTestingSettings.cmake,cmake/std/sems/SEMSDevEnv.cmake" - "-DTrilinos_TEST_CATEGORIES=BASIC" - "-DTrilinos_ENABLE_CONFIGURE_TIMING=ON" - ) -# NOTE: That above must match *exactly* what is listed is listed in -# project-checkin-test-config.py and produced by the checkin-test-sems.sh -# --default-builds=MPI_RELEASE_DEBUG_SHARED_PT build! - -SET(CTEST_TEST_TYPE Continuous) - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/gaia/single_ci_iter.sh b/cmake/ctest/drivers/gaia/single_ci_iter.sh deleted file mode 100755 index 83508ab1b2a5..000000000000 --- a/cmake/ctest/drivers/gaia/single_ci_iter.sh +++ /dev/null @@ -1,28 +0,0 @@ -#!/bin/bash - -# This is a poor-man's driver script - -DRIVER_SCRIPT_DIR=`echo $0 | sed "s/\(.*\)\/.*\.sh/\1/g"` -echo "DRIVER_SCRIPT_DIR = '$DRIVER_SCRIPT_DIR'" - -#TRILINOS_DIR=`readlink -f ${DRIVER_SCRIPT_DIR}/../../../..` -TRILINOS_DIR=${DRIVER_SCRIPT_DIR}/../../../.. -echo "TRILINOS_DIR='${TRILINOS_DIR}'" - -source /etc/bashrc -TRILINOS_SEMS_DEV_ENV_VERBOSE=1 -source $TRILINOS_DIR/cmake/load_sems_dev_env.sh - -export CTEST_DASHBOARD_ROOT=$PWD - -# See if there are updated files: -cd ${TRILINOS_DIR} -./cmake/tribits/python_utils/gitdist --dist-no-color fetch -NEW_COMMITS=`./cmake/tribits/python_utils/gitdist --dist-no-color log --oneline @{u} ^HEAD | grep -v "\(Git Repo\|^$\)"` -echo "NEW_COMMITS ='$NEW_COMMITS'" -cd .. - -if [ "$NEW_COMMITS" != "" ] || [ "$CI_FIRST_ITERATION" == "1" ] ; then - #echo ctest -V -S $DRIVER_SCRIPT_DIR/ctest_linux_mpi_debug_shared_pt_ci.sems.cmake - ctest -V -S $DRIVER_SCRIPT_DIR/ctest_darwin_mpi_debug_pytrilinos_ci.sems.cmake -fi diff --git a/cmake/ctest/drivers/gaia/trilinos_ci_sever.sh b/cmake/ctest/drivers/gaia/trilinos_ci_sever.sh deleted file mode 100755 index d4b7f1b6941f..000000000000 --- a/cmake/ctest/drivers/gaia/trilinos_ci_sever.sh +++ /dev/null @@ -1,70 +0,0 @@ -#!/bin/bash -# -# This is the main driver script for a poor-man's CI server for the Trilinos -# pre-push CI build. -# - -DRIVER_SCRIPT_DIR=`echo $0 | sed "s/\(.*\)\/.*\.sh/\1/g"` -echo "DRIVER_SCRIPT_DIR = '$DRIVER_SCRIPT_DIR'" - -#TRILINOS_DIR=`readlink -f ${DRIVER_SCRIPT_DIR}/../../../..` -TRILINOS_DIR=${DRIVER_SCRIPT_DIR}/../../../.. -echo "TRILINOS_DIR='${TRILINOS_DIR}'" - -BASE_COMMAND=$DRIVER_SCRIPT_DIR/single_ci_iter.sh -LOOP_INTERVAL=3m -TODAY_RUN_TILL=18:00:00 -PAUSE_FILE=$PWD/pause_ci_server.txt - -# Un-comment to test out locally -#BASE_COMMAND="echo mock_command" -#LOOP_INTERVAL=1s - -echo "BASE_COMMAND = '$BASE_COMMAND'" -echo "LOOP_INTERVAL = '$LOOP_INTERVAL'" -echo "TODAY_RUN_TILL = '$TODAY_RUN_TILL'" -echo "PAUSE_FILE = '$PAUSE_FILE'" - -# -# Execute -# - -# Have to source this or you don't even get the module command! -source /etc/bashrc - -HOSTNAME=`hostname` -MAILMSG=$TRILINOS_DIR/cmake/tribits/python_utils/mailmsg.py - -if [ "$TRILINOS_SKIP_CI_EMAILS" == "" ] ; then - $MAILMSG "Starting Trilinos standrad CI testing server on '$HOSTNAME'" -fi - -# A) Run the first build starting from scratch - -env CI_FIRST_ITERATION=1 \ - CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=TRUE \ - CTEST_ENABLE_MODIFIED_PACKAGES_ONLY=OFF \ - $BASE_COMMAND - -# B) Run a CI loop that will terminate on time - -# B.1) Define the inner loop command - -CI_COMMAND="env CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=OFF CTEST_ENABLE_MODIFIED_PACKAGES_ONLY=ON $BASE_COMMAND" -echo "CI_COMMAND = $CI_COMMAND" - -# B.2) Run the CI loop - -if [ "$TRILINOS_SKIP_CI_ITERATION" == "" ] ; then - $TRILINOS_DIR/cmake/tribits/python_utils/generic-looping-demon.py \ - --command="$CI_COMMAND" \ - --today-run-till=$TODAY_RUN_TILL \ - --loop-interval=$LOOP_INTERVAL \ - --pause-file=$PAUSE_FILE -else - echo "Skipping CI iterations because TRILINOS_SKIP_CI_ITERATION = '$TRILINOS_SKIP_CI_ITERATION' != ''" -fi - -if [ "$TRILINOS_SKIP_CI_EMAILS" == "" ] ; then - $MAILMSG "Ending Trilinos standrad CI testing server on '$HOSTNAME'" -fi diff --git a/cmake/ctest/drivers/godel/CMakeLists.txt b/cmake/ctest/drivers/godel/CMakeLists.txt deleted file mode 100644 index 2833f215d3d3..000000000000 --- a/cmake/ctest/drivers/godel/CMakeLists.txt +++ /dev/null @@ -1,103 +0,0 @@ -# godel driver - -TRILINOS_DRIVER_SETUP() - -set(CTEST_EXE "${CMAKE_CTEST_COMMAND}") -set(workingdir "${TrilinosDriver_BINARY_DIR}") - -# Get the day of the week -execute_process(COMMAND date +%A OUTPUT_VARIABLE DAYOFWEEK) - -if(${DAYOFWEEK} MATCHES "Saturday") - set(RUN_REGULAR_TESTS ON) - set(RUN_COVERAGE_TESTS ON) - set(RUN_MEMCHECK_TESTS OFF) -elseif(${DAYOFWEEK} MATCHES "Sunday") - set(RUN_REGULAR_TESTS ON) - set(RUN_COVERAGE_TESTS OFF) - set(RUN_MEMCHECK_TESTS OFF) -else() - set(RUN_REGULAR_TESTS ON) - set(RUN_COVERAGE_TESTS OFF) - set(RUN_MEMCHECK_TESTS OFF) -endif() - -if(RUN_REGULAR_TESTS) - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_PERFORMANCE - ctest_linux_nightly_serial_performance_godel.cmake - RUN_SERIAL - TIMEOUT_MINUTES 240 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_OPT_ZOLTAN_C - ctest_linux_nightly_mpi_opt_zoltan_c_godel.cmake - RUN_SERIAL - TIMEOUT_MINUTES 240 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_OPT_ZOLTAN_C_64 - ctest_linux_nightly_mpi_opt_zoltan_c64_godel.cmake - RUN_SERIAL - TIMEOUT_MINUTES 240 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG_ICPC - ctest_linux_nightly_serial_debug_icpc_godel.cmake - RUN_SERIAL - TIMEOUT_MINUTES 240 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_RELEASE_ICPC - ctest_linux_nightly_serial_release_icpc_godel.cmake - RUN_SERIAL - TIMEOUT_MINUTES 240 - ) - -endif() - -if(RUN_COVERAGE_TESTS) - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG_COVERAGE - ctest_linux_nightly_serial_debug_coverage_godel.cmake - RUN_SERIAL - TIMEOUT_MINUTES 300 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_DEBUG_COVERAGE - ctest_linux_nightly_mpi_debug_coverage_godel.cmake - RUN_SERIAL - TIMEOUT_MINUTES 300 - ) - -endif() - -if(RUN_MEMCHECK_TESTS) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG_MEMCHECK - ctest_linux_nightly_serial_debug_memcheck_godel.cmake - RUN_SERIAL - TIMEOUT_MINUTES 240 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_DEBUG_MEMCHECK - ctest_linux_nightly_mpi_debug_memcheck_godel.cmake - RUN_SERIAL - TIMEOUT_MINUTES 240 - ) - -#not sure what to do with these maybe just a command? I believe that the new -#testing system is suposed to clean up spawned processes completely. -# -# add_test(kill_memcheck_processes killall -s 9 memcheck) -# set_property(TEST kill_memcheck_processes PROPERTY DEPENDS mpi_debug_memcheck serial_debug_memcheck) -endif() - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/godel/TrilinosCTestDriverCore.godel.gcc.cmake b/cmake/ctest/drivers/godel/TrilinosCTestDriverCore.godel.gcc.cmake deleted file mode 100644 index d06928e205be..000000000000 --- a/cmake/ctest/drivers/godel/TrilinosCTestDriverCore.godel.gcc.cmake +++ /dev/null @@ -1,128 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for godel using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j8 -i" ) - - SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES PyTrilinos TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=RELEASE" - "-DBoost_INCLUDE_DIRS:PATH=/home/trilinos/tpls/boost-1.40.0" - "-DCOVERAGE_COMMAND:FILEPATH=/usr/bin/gcov" - "-DMEMORYCHECK_COMMAND:FILEPATH=/usr/bin/valgrind" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DTPL_ENABLE_BinUtils=ON" - ) - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - SET_DEFAULT(COMPILER_VERSION "GCC-4.1.2") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/usr/local" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_godel_openmpi_1.2.7.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ELSE() - - # 2009/09/02: rabartl: Let CMake pick its own compilers (fixes Intrepid problem) ... - #SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - # ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - # "-DCMAKE_CXX_COMPILER:FILEPATH=/usr/bin/g++" - # "-DCMAKE_C_COMPILER:FILEPATH=/usr/bin/gcc" - # "-DCMAKE_Fortran_COMPILER:FILEPATH=/usr/bin/f77" - # ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_godel_gcc-4.1.2.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/godel/TrilinosCTestDriverCore.godel.icpc.cmake b/cmake/ctest/drivers/godel/TrilinosCTestDriverCore.godel.icpc.cmake deleted file mode 100644 index 61aee0894571..000000000000 --- a/cmake/ctest/drivers/godel/TrilinosCTestDriverCore.godel.icpc.cmake +++ /dev/null @@ -1,107 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for godel using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j8 -i" ) - - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - #SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS ) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES PyTrilinos TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DMEMORYCHECK_COMMAND:FILEPATH=/usr/bin/valgrind" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DTPL_ENABLE_BinUtils=ON" - ) - - SET_DEFAULT(COMPILER_VERSION "ICPC-10.1.0.15") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - MESSAGE(FATAL_ERROR "Error, Intel build does not support MPI yet!") - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_C_COMPILER:FILEPATH=/opt/intel/cc/10.1.015/bin/icc" - "-DCMAKE_CXX_COMPILER:FILEPATH=/opt/intel/cc/10.1.015/bin/icpc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/usr/bin/f77" - "-DCMAKE_CXX_FLAGS:STRING=-diag-disable 597" - "-DCMAKE_LIBRARY_PATH:PATH=/usr/lib64" - ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/godel/cron_driver.sh b/cmake/ctest/drivers/godel/cron_driver.sh deleted file mode 100755 index ed68886289d4..000000000000 --- a/cmake/ctest/drivers/godel/cron_driver.sh +++ /dev/null @@ -1,41 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on godel: `date`" -echo - -# TrilinosDriver settings: -# - -export TDD_GIT_EXE=/home/trilinos/install/bin/eg -export TDD_PARALLEL_LEVEL=4 -export TDD_CTEST_TEST_TYPE=Nightly - -# Trilinos settings: -# - -#export CTEST_TEST_TYPE=Experimental - -#export CTEST_DO_SUBMIT=FALSE - -#export CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=FALSE - -#export Trilinos_PACKAGES=Teuchos - -# Machine specific environment: -# - -#export PYTHONPATH=/Users/jmwille/install/lib/python2.5/site-packages - -# Ensure the tests can find the Intel libraries at runtime. -export LD_LIBRARY_PATH=/opt/intel/cc/10.1.015/lib - -# Machine independent cron_driver: -# - -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on godel: `date`" -echo diff --git a/cmake/ctest/drivers/godel/cron_driver_godel.sh b/cmake/ctest/drivers/godel/cron_driver_godel.sh deleted file mode 100755 index f5674597d708..000000000000 --- a/cmake/ctest/drivers/godel/cron_driver_godel.sh +++ /dev/null @@ -1,207 +0,0 @@ -#!/bin/bash - -CTEST_EXE=/home/trilinos/install/bin/ctest -EG_EXE=/home/trilinos/install/bin/eg -BASEDIR=/home/trilinos/dashboards/development -DRIVER_SCRIPT_DIR=$BASEDIR/Trilinos/cmake/ctest/drivers/godel -TRILINOS_REPOSITORY_LOCATION="software.sandia.gov:/space/git/Trilinos" - - -if [ "$_DAYOFWEEK" == "" ] ; then - _DAYOFWEEK=`date +%A` -fi - -echo "_DAYOFWEEK=$_DAYOFWEEK" - -if [ "$_DAYOFWEEK" == "Saturday" ] ; then - _RUN_REGULAR_TESTS=1 - _RUN_COVERAGE_TESTS=1 - _RUN_MEMCHECK_TESTS=0 -elif [ "$_DAYOFWEEK" == "Sunday" ] ; then - _RUN_REGULAR_TESTS=1 - _RUN_COVERAGE_TESTS=0 - _RUN_MEMCHECK_TESTS=0 -else - _RUN_REGULAR_TESTS=1 - _RUN_COVERAGE_TESTS=0 - _RUN_MEMCHECK_TESTS=0 -fi - -echo "_RUN_REGULAR_TESTS=$_RUN_REGULAR_TESTS" -echo "_RUN_COVERAGE_TESTS=$_RUN_COVERAGE_TESTS" -echo "_RUN_MEMCHECK_TESTS=$_RUN_MEMCHECK_TESTS" - -#exit - - -echo -echo "Starting nightly Trilinos testing on godel: `date`" -echo - - -echo -echo "Checking out just the skeleton cmake/ctest code: `date`" -echo - -cd $BASEDIR -if [ -d Trilinos ]; then - echo Doing an update of existing directory - cd Trilinos - $EG_EXE pull - cd .. -else - echo Cloning the repository because none exists yets - $EG_EXE clone $TRILINOS_REPOSITORY_LOCATION -fi - - -# -# Weekday tests -# - -if [ "$_RUN_REGULAR_TESTS" == "1" ] ; then - -echo -echo "Running weekday tests ..." -echo - -echo -echo "Doing serial performance build: `date`" -echo - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_serial_performance_godel.cmake -VV \ - &> $BASEDIR/ctest_linux_nightly_serial_performance_godel.out - -#echo -#echo "Doing mpi optimized build: `date`" -#echo -# -#time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_mpi_optimized_godel.cmake -VV \ -# &> $BASEDIR/ctest_linux_nightly_mpi_optimized_godel.out -# -#echo -#echo "Doing serial debug build: `date`" -#echo -# -#time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_serial_debug_godel.cmake -VV \ -# &> $BASEDIR/ctest_linux_nightly_serial_debug_godel.out -# -#echo -#echo "Doing mpi optimized shared library build: `date`" -#echo -# -#time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_mpi_optimized_shared_godel.cmake -VV \ -# &> $BASEDIR/ctest_linux_nightly_mpi_optimized_shared_godel.out - -#echo -#echo "Doing serial optimized implicit instantiation build: `date`" -#echo -# -#time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_serial_opt_impl_instant_godel.cmake -VV \ -# &> $BASEDIR/ctest_linux_nightly_serial_opt_impl_instant_godel.out - -#echo -#echo "Doing mpi debug build: `date`" -#echo -# -#time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_mpi_debug_godel.cmake -VV \ -# &> $BASEDIR/ctest_linux_nightly_mpi_debug_godel.out - -echo -echo "Doing mpi optimized zoltan c-only build (32bit and 64bit global IDs): `date`" -echo - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_mpi_opt_zoltan_c_godel.cmake -VV \ - &> $BASEDIR/ctest_linux_nightly_mpi_opt_zoltan_c_godel.out - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_mpi_opt_zoltan_c64_godel.cmake -VV \ - &> $BASEDIR/ctest_linux_nightly_mpi_opt_zoltan_c64_godel.out - -echo -echo "Doing serial debug intel build: `date`" -echo - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_serial_debug_icpc_godel.cmake -VV \ - &> $BASEDIR/ctest_linux_nightly_serial_debug_icpc_godel.out - -echo -echo "Doing serial release intel build: `date`" -echo - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_serial_release_icpc_godel.cmake -VV \ - &> $BASEDIR/ctest_linux_nightly_serial_release_icpc_godel.out - -fi - - -# -# Coverage tests -# - -if [ "$_RUN_COVERAGE_TESTS" == "1" ] ; then - -echo -echo "Running coverage tests ..." -echo - -echo -echo "Doing serial debug coverage build: `date`" -echo - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_serial_debug_coverage_godel.cmake -VV \ - &> $BASEDIR/ctest_linux_nightly_serial_debug_coverage_godel.out - -echo -echo "Doing mpi debug coverage build: `date`" -echo - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_mpi_debug_coverage_godel.cmake -VV \ - &> $BASEDIR/ctest_linux_nightly_mpi_debug_coverage_godel.out - -fi - - -# -# Memcheck tests -# - -#memory testing has been disabled due to hanging -if [ "$_RUN_MEMCHECK_TESTS" == "1" ] ; then - -echo -echo "Running memcheck tests ..." -echo - -echo -echo "Doing serial debug memcheck build: `date`" -echo - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_serial_debug_memcheck_godel.cmake -VV \ - &> $BASEDIR/ctest_linux_nightly_serial_debug_memcheck_godel.out - -echo -echo "Doing mpi debug memcheck build: `date`" -echo - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_linux_nightly_mpi_debug_memcheck_godel.cmake -VV \ - &> $BASEDIR/ctest_linux_nightly_mpi_debug_memcheck_godel.out - -echo -echo "Kill remaining 'memcheck' processes: `date`" -echo - -killall -s 9 memcheck - -fi - -#forcing all files/directories to be group accessible -chgrp -R trilinos-dev * -chmod -R g+w * - - -echo -echo "Ending nightly Trilinos testing on godel: `date`" -echo - - -#/home/rabartl/mailmsg.py "Finished nightly Trilinos tests godel: http://trilinos-dev.sandia.gov/cdash/index.php?project=Trilinos" diff --git a/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_debug_coverage_godel.cmake b/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_debug_coverage_godel.cmake deleted file mode 100644 index 9cea37d4329b..000000000000 --- a/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_debug_coverage_godel.cmake +++ /dev/null @@ -1,81 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.godel.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG_COV) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(CTEST_DO_COVERAGE_TESTING TRUE) - -SET(EXTRA_EXCLUDE_PACKAGES SEACAS) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_debug_godel.cmake b/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_debug_godel.cmake deleted file mode 100644 index 4ad96bbe10a9..000000000000 --- a/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_debug_godel.cmake +++ /dev/null @@ -1,81 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.godel.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG) -#SET(CTEST_TEST_TIMEOUT 900) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_ParMETIS:BOOL=ON" - "-DParMETIS_LIBRARY_DIRS:PATH=/home/kddevin/code/ParMETIS3_1" - "-DTPL_ENABLE_Scotch:BOOL=ON" - "-DScotch_INCLUDE_DIRS:PATH=/home/kddevin/code/scotch_5.1/include" - "-DScotch_LIBRARY_DIRS:PATH=/home/kddevin/code/scotch_5.1/lib" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_debug_memcheck_godel.cmake b/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_debug_memcheck_godel.cmake deleted file mode 100644 index 93bbd205f20f..000000000000 --- a/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_debug_memcheck_godel.cmake +++ /dev/null @@ -1,82 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.godel.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG_MEMCHECK) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(CTEST_DO_MEMORY_TESTING TRUE) - -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" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_opt_zoltan_c64_godel.cmake b/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_opt_zoltan_c64_godel.cmake deleted file mode 100644 index d0c1fd154c6a..000000000000 --- a/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_opt_zoltan_c64_godel.cmake +++ /dev/null @@ -1,97 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.godel.gcc.cmake") - -# -# Test only Zoltan with the C compiler with MPI. Here the only reason -# that we are testing only Zoltan is that is the only package in -# Trilinos that can build with only C. -# Use 64 bit global IDs in Zoltan. -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME ZOLTAN_C_64) -SET(CTEST_TEST_TYPE Nightly) -SET(CTEST_TEST_TIMEOUT 1200) - -#SET(CTEST_DO_COVERAGE_TESTING TRUE) -#SET(CTEST_DO_MEMORY_TESTING TRUE) - -SET(Trilinos_PACKAGES Zoltan) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DMPI_EXEC_MAX_NUMPROCS:STRING=11" - "-DTrilinos_ENABLE_CXX:BOOL=OFF" - "-DTrilinos_ENABLE_ForTrilinos:BOOL=OFF" - "-DTrilinos_ENABLE_Fortran:BOOL=OFF" - "-DZoltan_ENABLE_ULONG_IDS:BOOL=ON" - "-DZoltan_ENABLE_TESTS:BOOL=ON" - "-DTrilinos_TEST_CATEGORIES:STRING=NIGHTLY" - "-DTPL_ENABLE_ParMETIS:BOOL=ON" - "-DParMETIS_LIBRARY_DIRS:PATH=/home/kddevin/code/ParMETIS3_1" - "-DTPL_ENABLE_Scotch:BOOL=ON" - "-DScotch_INCLUDE_DIRS:PATH=/home/kddevin/code/scotch_5.1/include" - "-DScotch_LIBRARY_DIRS:PATH=/home/kddevin/code/scotch_5.1/lib" - "-DTPL_ENABLE_BinUtils=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_opt_zoltan_c_godel.cmake b/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_opt_zoltan_c_godel.cmake deleted file mode 100644 index 7d72b754c32c..000000000000 --- a/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_opt_zoltan_c_godel.cmake +++ /dev/null @@ -1,96 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.godel.gcc.cmake") - -# -# Test only Zoltan with the C compiler with MPI. Here the only reason -# that we are testing only Zoltan is that is the only package in -# Trilinos that can build with only C. -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME ZOLTAN_C) -SET(CTEST_TEST_TYPE Nightly) -SET(CTEST_TEST_TIMEOUT 1200) - -#SET(CTEST_DO_COVERAGE_TESTING TRUE) -#SET(CTEST_DO_MEMORY_TESTING TRUE) - -SET(Trilinos_PACKAGES Zoltan) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DMPI_EXEC_MAX_NUMPROCS:STRING=11" - "-DTrilinos_ENABLE_CXX:BOOL=OFF" - "-DTrilinos_ENABLE_ForTrilinos:BOOL=OFF" - "-DTrilinos_ENABLE_Fortran:BOOL=OFF" - "-DZoltan_ENABLE_UINT_IDS:BOOL=ON" - "-DZoltan_ENABLE_TESTS:BOOL=ON" - "-DTrilinos_TEST_CATEGORIES:STRING=NIGHTLY" - "-DTPL_ENABLE_ParMETIS:BOOL=ON" - "-DParMETIS_LIBRARY_DIRS:PATH=/home/kddevin/code/ParMETIS3_1" - "-DTPL_ENABLE_Scotch:BOOL=ON" - "-DScotch_INCLUDE_DIRS:PATH=/home/kddevin/code/scotch_5.1/include" - "-DScotch_LIBRARY_DIRS:PATH=/home/kddevin/code/scotch_5.1/lib" - "-DTPL_ENABLE_BinUtils=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_optimized_godel.cmake b/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_optimized_godel.cmake deleted file mode 100644 index 6bd4baa562b0..000000000000 --- a/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_optimized_godel.cmake +++ /dev/null @@ -1,84 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.godel.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT) -#SET(CTEST_TEST_TIMEOUT 900) - -#SET(CTEST_DO_COVERAGE_TESTING TRUE) -#SET(CTEST_DO_MEMORY_TESTING TRUE) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_ParMETIS:BOOL=ON" - "-DParMETIS_LIBRARY_DIRS:PATH=/home/kddevin/code/ParMETIS3_1" - "-DTPL_ENABLE_Scotch:BOOL=ON" - "-DScotch_INCLUDE_DIRS:PATH=/home/kddevin/code/scotch_5.1/include" - "-DScotch_LIBRARY_DIRS:PATH=/home/kddevin/code/scotch_5.1/lib" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_optimized_shared_godel.cmake b/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_optimized_shared_godel.cmake deleted file mode 100644 index d61d33ed2601..000000000000 --- a/cmake/ctest/drivers/godel/ctest_linux_nightly_mpi_optimized_shared_godel.cmake +++ /dev/null @@ -1,79 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.godel.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_SHARED) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_EXCLUDE_PACKAGES) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DBUILD_SHARED_LIBS:BOOL=ON" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/godel/ctest_linux_nightly_package_deps_godel.cmake b/cmake/ctest/drivers/godel/ctest_linux_nightly_package_deps_godel.cmake deleted file mode 100644 index a459f86fb629..000000000000 --- a/cmake/ctest/drivers/godel/ctest_linux_nightly_package_deps_godel.cmake +++ /dev/null @@ -1,84 +0,0 @@ -# @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 - - -# -# Set the options specific to this build -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME PACKAGE_DEPS) -#SET(CTEST_TEST_TIMEOUT 900) - - -SET(CTEST_INITIAL_CACHE " - -CMAKE_VERBOSE_MAKEFILE:BOOL=TRUE - -Trilinos_ENABLE_CXX:BOOL=OFF -Trilinos_ENABLE_C:BOOL=OFF -Trilinos_ENABLE_Fortran:BOOL=OFF - -Trilinos_ENABLE_DEPENCENCY_UNIT_TESTS:BOOL=ON - -") - - -# -# Read in the platform-independent and platform-dependent options -# - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestSupport.godel.cmake") diff --git a/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_debug_coverage_godel.cmake b/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_debug_coverage_godel.cmake deleted file mode 100644 index 4dfce17399fc..000000000000 --- a/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_debug_coverage_godel.cmake +++ /dev/null @@ -1,81 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.godel.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_COV) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(CTEST_DO_COVERAGE_TESTING TRUE) - -SET(EXTRA_EXCLUDE_PACKAGES SEACAS) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_debug_godel.cmake b/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_debug_godel.cmake deleted file mode 100644 index 1a0bceeeba44..000000000000 --- a/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_debug_godel.cmake +++ /dev/null @@ -1,79 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.godel.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG) -#SET(CTEST_TEST_TIMEOUT 900) - -#SET(CTEST_DO_COVERAGE_TESTING TRUE) -#SET(CTEST_DO_MEMORY_TESTING TRUE) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_debug_icpc_godel.cmake b/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_debug_icpc_godel.cmake deleted file mode 100644 index ab2a08425027..000000000000 --- a/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_debug_icpc_godel.cmake +++ /dev/null @@ -1,80 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.godel.icpc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_ICPC) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -#SET(Trilinos_PACKAGES Teuchos RTOp Tpetra Thyra Stratimikos Phalanx Rythmos MOOCHO) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_Fortran:BOOL=OFF" - "-DTPL_ENABLE_Boost:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_debug_memcheck_godel.cmake b/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_debug_memcheck_godel.cmake deleted file mode 100644 index b920c1491d61..000000000000 --- a/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_debug_memcheck_godel.cmake +++ /dev/null @@ -1,82 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.godel.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_MEMCHECK) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(CTEST_DO_MEMORY_TESTING TRUE) - -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" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_opt_impl_instant_godel.cmake b/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_opt_impl_instant_godel.cmake deleted file mode 100644 index 07c815e925df..000000000000 --- a/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_opt_impl_instant_godel.cmake +++ /dev/null @@ -1,78 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.godel.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_RELEASE) -#SET(CTEST_TEST_TIMEOUT 900) - -#SET(CTEST_DO_COVERAGE_TESTING TRUE) -#SET(CTEST_DO_MEMORY_TESTING TRUE) - -#SET( EXTRA_CONFIGURE_OPTIONS -# ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_performance_godel.cmake b/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_performance_godel.cmake deleted file mode 100644 index fcd337e16e6f..000000000000 --- a/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_performance_godel.cmake +++ /dev/null @@ -1,95 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.godel.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE NONE) -SET(BUILD_DIR_NAME SERIAL_PERF) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_PACKAGES Teuchos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DCMAKE_CXX_FLAGS:STRING=-O3\ -DBOOST_SP_DISABLE_THREADS" - "-DCMAKE_C_FLAGS:STRING=\"-O3\"" - "-DCMAKE_Fortran_FLAGS:STRING=\"-O5\"" - "-DTrilinos_ENABLE_DEPENCENCY_UNIT_TESTS:BOOL=OFF" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_ENABLE_ALL_OPTIONAL_PACKAGES:BOOL=OFF" - "-DTrilinos_TEST_CATEGORIES:STRING=PERFORMANCE" - "-DTrilinos_REL_CPU_SPEED:STRING=1e+3" - "-DTPL_ENABLE_Boost:BOOL=ON" - ) - -# NOTE: Above, we want to overridde the enabling of all tests and only -# want to do performance tests. - -# NOTE: We are turning off all optional packages because we don't want -# build errors in other packges to affect these packages and we don't -# need them for performance tests. The Sacado performance build -# failed on 2009/04/23 because Zoltan failed to build. - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_release_icpc_godel.cmake b/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_release_icpc_godel.cmake deleted file mode 100644 index 179d14785449..000000000000 --- a/cmake/ctest/drivers/godel/ctest_linux_nightly_serial_release_icpc_godel.cmake +++ /dev/null @@ -1,80 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.godel.icpc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_RELEASE_ICPC) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_PACKAGES Teuchos RTOp Tpetra Thyra Stratimikos Phalanx Rythmos MOOCHO) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_Fortran:BOOL=OFF" - "-DTPL_ENABLE_Boost:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/godel/valgrind_suppressions_godel_gcc-4.1.2.txt b/cmake/ctest/drivers/godel/valgrind_suppressions_godel_gcc-4.1.2.txt deleted file mode 100644 index b28b04f64312..000000000000 --- a/cmake/ctest/drivers/godel/valgrind_suppressions_godel_gcc-4.1.2.txt +++ /dev/null @@ -1,3 +0,0 @@ - - - diff --git a/cmake/ctest/drivers/godel/valgrind_suppressions_godel_openmpi_1.2.7.txt b/cmake/ctest/drivers/godel/valgrind_suppressions_godel_openmpi_1.2.7.txt deleted file mode 100644 index f035ef524389..000000000000 --- a/cmake/ctest/drivers/godel/valgrind_suppressions_godel_openmpi_1.2.7.txt +++ /dev/null @@ -1,133 +0,0 @@ -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send - fun:orte_iof_proxy_svc_publish - fun:orte_iof_proxy_publish - fun:orte_iof_base_setup_parent - fun:orte_odls_default_launch_local_procs - obj:/usr/lib64/openmpi/1.2.7-gcc/bin/orted - fun:orte_gpr_proxy_deliver_notify_msg - fun:orte_gpr_proxy_notify_recv - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 -} - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - fun:_orte_iof_base_frag_ack - fun:orte_iof_base_endpoint_forward - fun:orte_iof_svc_proxy_recv - fun:mca_oob_tcp_msg_recv_complete - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/openmpi/mca_oob_tcp.so - fun:opal_event_base_loop - fun:opal_progress - obj:/usr/lib64/openmpi/1.2.7-gcc/bin/orterun -} - -{ - - Memcheck:Cond - fun:__strcpy_chk - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libmpi.so.0.0.0 - fun:orte_gpr_proxy_deliver_notify_msg - fun:mca_oob_xcast - fun:ompi_mpi_init - fun:PMPI_Init - fun:_ZN7Teuchos16GlobalMPISessionC1EPiPPPcPSo - fun:main -} - -{ - - Memcheck:Cond - fun:__strcpy_chk - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libmpi.so.0.0.0 - fun:orte_gpr_proxy_deliver_notify_msg - fun:mca_oob_xcast - fun:ompi_mpi_init - fun:PMPI_Init - fun:main -} - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - fun:orte_iof_svc_sub_forward - fun:orte_iof_svc_proxy_recv - fun:mca_oob_tcp_msg_recv_complete - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/openmpi/mca_oob_tcp.so - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 - fun:opal_event_base_loop - fun:opal_progress - obj:/usr/lib64/openmpi/1.2.7-gcc/bin/orterun -} - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 - fun:opal_event_base_loop - fun:opal_progress - fun:mca_oob_tcp_msg_wait - fun:mca_oob_tcp_recv - fun:mca_oob_recv_packed - fun:orte_gpr_proxy_exec_compound_cmd - fun:orte_odls_base_report_spawn -} - - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - fun:orte_iof_svc_sub_forward - fun:orte_iof_svc_proxy_recv - fun:mca_oob_tcp_msg_recv_complete - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/openmpi/mca_oob_tcp.so - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 - fun:opal_event_base_loop - fun:opal_progress - obj:/usr/lib64/openmpi/1.2.7-gcc/bin/orterun -} - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 - fun:opal_event_base_loop - fun:opal_progress - fun:mca_oob_tcp_msg_wait - fun:mca_oob_tcp_recv - fun:mca_oob_recv_packed - fun:orte_gpr_proxy_exec_compound_cmd - fun:orte_odls_base_report_spawn -} diff --git a/cmake/ctest/drivers/hansel/CMakeLists.txt b/cmake/ctest/drivers/hansel/CMakeLists.txt deleted file mode 100644 index 0881a92a417e..000000000000 --- a/cmake/ctest/drivers/hansel/CMakeLists.txt +++ /dev/null @@ -1,34 +0,0 @@ -INCLUDE("../../../../Version.cmake") - -TRILINOS_DRIVER_SETUP() - -set(CTEST_EXE "${CMAKE_CTEST_COMMAND}") -set(workingdir "${TrilinosDriver_BINARY_DIR}") - -# Get the day of the week -execute_process(COMMAND date +%A OUTPUT_VARIABLE DAYOFWEEK) - -IF(${Trilinos_REPOSITORY_BRANCH} STREQUAL "develop") - MESSAGE("No testing defined for develop branch yet!") -ELSE() - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_RELEASE - ctest_linux_nightly_mpi_release_hansel.cmake - RUN_SERIAL - TIMEOUT_MINUTES 300 - ) - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_RELEASE_SHARED - ctest_linux_nightly_mpi_release_shared_hansel.cmake - RUN_SERIAL - TIMEOUT_MINUTES 300 - ) - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_RELEASE - ctest_linux_nightly_serial_release_hansel.cmake - RUN_SERIAL - TIMEOUT_MINUTES 300 - ) -ENDIF() - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/hansel/TrilinosCTestDriverCore.hansel.gcc.cmake b/cmake/ctest/drivers/hansel/TrilinosCTestDriverCore.hansel.gcc.cmake deleted file mode 100644 index f6f5097b94d5..000000000000 --- a/cmake/ctest/drivers/hansel/TrilinosCTestDriverCore.hansel.gcc.cmake +++ /dev/null @@ -1,147 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for hansel using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_BUILD_FLAGS "-j20 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "20" ) - - SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DCOVERAGE_COMMAND:FILEPATH=/usr/bin/gcov" - "-DMEMORYCHECK_COMMAND:FILEPATH=/usr/bin/valgrind" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DMesquite_ENABLE_TESTS:BOOL=ON" - "-DSuperLU_INCLUDE_DIRS:PATH=$ENV{SEMS_SUPERLU_INCLUDE_PATH}" - "-DSuperLU_LIBRARY_DIRS:PATH=$ENV{SEMS_SUPERLU_LIBRARY_PATH}" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu" - "-DBoost_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_BOOST_INCLUDE_PATH}" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_BOOST_INCLUDE_PATH}" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_BOOST_LIBRARY_PATH}" - "-DHDF5_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_HDF5_INCLUDE_PATH}" - "-DHDF5_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_HDF5_LIBRARY_PATH}" - "-DNetcdf_INCLUDE_DIRS=$ENV{SEMS_NETCDF_INCLUDE_PATH}" - "-DNetcdf_LIBRARY_DIRS=$ENV{SEMS_NETCDF_LIBRARY_PATH}" - "-DParMETIS_INCLUDE_DIRS=$ENV{SEMS_PARMETIS_INCLUDE_PATH}" - "-DParMETIS_LIBRARY_DIRS=$ENV{SEMS_PARMETIS_LIBRARY_PATH}" - "-DScotch_INCLUDE_DIRS=$ENV{SEMS_SCOTCH_INCLUDE_PATH}" - "-DScotch_LIBRARY_DIRS=$ENV{SEMS_SCOTCH_LIBRARY_PATH}" - "-DTPL_ENABLE_BoostLib=ON" - "-DTPL_ENABLE_Matio=OFF" - "-DTPL_ENABLE_GLM=OFF" - "-DTPL_ENABLE_SuperLU=OFF" - "-DTPL_ENABLE_X11=OFF" - "-DIntrepid2_ENABLE_DEBUG_INF_CHECK:BOOL=OFF" - ) - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - SET_DEFAULT(COMPILER_VERSION "$ENV{SEMS_COMPILER_NAME}-$ENV{SEMS_COMPILER_VERSION}") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_openmpi_1.2.7.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=g++" - "-DCMAKE_C_COMPILER:FILEPATH=gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=gfortran" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_gcc-4.1.2.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/hansel/cron_driver.sh b/cmake/ctest/drivers/hansel/cron_driver.sh deleted file mode 100755 index 7431fe1b6e8d..000000000000 --- a/cmake/ctest/drivers/hansel/cron_driver.sh +++ /dev/null @@ -1,33 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on hansel: `date`" -echo - -# TrilinosDriver settings: -# -export TDD_GIT_EXE=/home/trilinos/git/bin/git -export TDD_PARALLEL_LEVEL=2 -export TDD_HTTP_PROXY="http://wwwproxy.sandia.gov:80/" - -# Trilinos settings: -# -#export TDD_CTEST_TEST_TYPE=Nightly - -# Machine specific environment: -# -#export PATH=/home/trilinos/gcc4.7.2/base/bin:/home/trilinos/cmake/bin:/home/trilinos/git/bin:/home/trilinos/tpl/gcc4.1.2/qt-4.5.2/bin:/usr/kerberos/bin:/usr/local/bin:/bin:/usr/bin - -# BASEDIR is the parent directory of this script's Trilinos source tree... -BASEDIR=`cd "\`dirname \"$0\"\`/../../../../..";pwd` -echo BASEDIR=$BASEDIR - -# Machine independent cron_driver: -# -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on hansel: `date`" -echo - diff --git a/cmake/ctest/drivers/hansel/ctest_linux_nightly_mpi_release_hansel.cmake b/cmake/ctest/drivers/hansel/ctest_linux_nightly_mpi_release_hansel.cmake deleted file mode 100644 index ebd656c6dbd4..000000000000 --- a/cmake/ctest/drivers/hansel/ctest_linux_nightly_mpi_release_hansel.cmake +++ /dev/null @@ -1,92 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.hansel.gcc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "MPI_RELEASE_${Trilinos_VERSION}") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} PyTrilinos Panzer) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DMPI_BASE_DIR:PATH=$ENV{SEMS_OPENMPI_ROOT}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DTPL_ENABLE_ParMETIS:BOOL=OFF" - "-DTPL_ENABLE_Scotch:BOOL=OFF" - "-DSEACASExodus_ENABLE_MPI:BOOL=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/hansel/ctest_linux_nightly_mpi_release_shared_hansel.cmake b/cmake/ctest/drivers/hansel/ctest_linux_nightly_mpi_release_shared_hansel.cmake deleted file mode 100644 index 11c5cf6e0aa0..000000000000 --- a/cmake/ctest/drivers/hansel/ctest_linux_nightly_mpi_release_shared_hansel.cmake +++ /dev/null @@ -1,91 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.hansel.gcc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "MPI_RELEASE_${Trilinos_VERSION}_SHARED") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -#disabling Mesquite because of a build error when shared libs is turned on. -SET(EXTRA_EXCLUDE_PACKAGES STK PyTrilinos Panzer) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DBUILD_SHARED_LIBS:BOOL=ON" - "-DMPI_BASE_DIR:PATH=$ENV{SEMS_OPENMPI_ROOT}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DSEACASExodus_ENABLE_MPI:BOOL=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/hansel/ctest_linux_nightly_serial_release_hansel.cmake b/cmake/ctest/drivers/hansel/ctest_linux_nightly_serial_release_hansel.cmake deleted file mode 100644 index 2b5b77d6ae34..000000000000 --- a/cmake/ctest/drivers/hansel/ctest_linux_nightly_serial_release_hansel.cmake +++ /dev/null @@ -1,88 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.hansel.gcc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "SERIAL_RELEASE_${Trilinos_VERSION}") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(EXTRA_EXCLUDE_PACKAGES Panzer PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/ictinus/CMakeLists.txt b/cmake/ctest/drivers/ictinus/CMakeLists.txt deleted file mode 100644 index b231241122bf..000000000000 --- a/cmake/ctest/drivers/ictinus/CMakeLists.txt +++ /dev/null @@ -1,33 +0,0 @@ -INCLUDE("../../../../Version.cmake") - -TRILINOS_DRIVER_SETUP() - -IF(${Trilinos_REPOSITORY_BRANCH} STREQUAL "master") - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_OPT - ctest_mac_nightly_mpi_opt_ictinus.cmake - TIMEOUT_MINUTES 240 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG - ctest_mac_nightly_serial_debug_ictinus.cmake - TIMEOUT_MINUTES 300 - ) -ELSE() - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_RELEASE - ctest_mac_nightly_mpi_release_ictinus.cmake - TIMEOUT_MINUTES 300 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_RELEASE - ctest_mac_nightly_serial_release_ictinus.cmake - TIMEOUT_MINUTES 300 - ) - -ENDIF() - - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/ictinus/TrilinosCTestDriverCore.ictinus.gcc.cmake b/cmake/ctest/drivers/ictinus/TrilinosCTestDriverCore.ictinus.gcc.cmake deleted file mode 100644 index ddd7b8900c64..000000000000 --- a/cmake/ctest/drivers/ictinus/TrilinosCTestDriverCore.ictinus.gcc.cmake +++ /dev/null @@ -1,117 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for ictinus using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j3 -i" ) - - SET( CTEST_PARALLEL_LEVEL "3" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} PyTrilinos TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENCENCY_UNIT_TESTS:BOOL=OFF" - "-DBoost_INCLUDE_DIRS:FILEPATH=/Users/jmwille/install/boost_1_46_1" - "-DTPL_ENABLE_Netcdf:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS=/Users/jmwille/install/netcdf-4.0/lib" - "-DNetcdf_INCLUDE_DIRS=/Users/jmwille/install/netcdf-4.0/include" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DTPL_ENABLE_Matio=OFF" - "-DIntrepid_ENABLE_DEBUG_INF_CHECK=OFF" - ) - - SET_DEFAULT(COMPILER_VERSION "GCC-4.4.6") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/Users/jmwille/install/gcc-4.4.6/openmpi-1.4.3" - ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/Users/jmwille/install/gcc-4.4.6/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/Users/jmwille/install/gcc-4.4.6/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/Users/jmwille/install/gcc-4.4.6/bin/gfortran" - ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/ictinus/cron_driver.sh b/cmake/ctest/drivers/ictinus/cron_driver.sh deleted file mode 100755 index be54cbdf29ce..000000000000 --- a/cmake/ctest/drivers/ictinus/cron_driver.sh +++ /dev/null @@ -1,39 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on ictinus: `date`" -echo - -# TrilinosDriver settings: -# - -export TDD_GIT_EXE=/Users/jmwille/install/git/bin/git -export TDD_PARALLEL_LEVEL=1 - -# Trilinos settings: -# - -#export CTEST_TEST_TYPE=Experimental - -#export CTEST_DO_SUBMIT=FALSE - -#export CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=FALSE - -#export Trilinos_PACKAGES=Teuchos - -# Machine specific environment: -# - -#export PYTHONPATH=/Users/jmwille/install/lib/python2.5/site-packages - -export PATH=/Users/jmwille/install/git/bin:/Users/jmwille/install/cmake-2.8.4/bin:/Users/jmwille/install/gcc-4.4.6/openmpi-1.4.3/bin:/Users/jmwille/install/gcc-4.4.6/bin:$PATH - -# Machine independent cron_driver: -# - -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on ictinus: `date`" -echo diff --git a/cmake/ctest/drivers/ictinus/ctest_mac_nightly_mpi_debug_ictinus.cmake b/cmake/ctest/drivers/ictinus/ctest_mac_nightly_mpi_debug_ictinus.cmake deleted file mode 100644 index 33e4ff01e2a0..000000000000 --- a/cmake/ctest/drivers/ictinus/ctest_mac_nightly_mpi_debug_ictinus.cmake +++ /dev/null @@ -1,80 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.ictinus.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG_DEV) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(EXTRA_EXCLUDE_PACKAGES Zoltan ) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/ictinus/ctest_mac_nightly_mpi_opt_ictinus.cmake b/cmake/ctest/drivers/ictinus/ctest_mac_nightly_mpi_opt_ictinus.cmake deleted file mode 100644 index f7d0e69964c5..000000000000 --- a/cmake/ctest/drivers/ictinus/ctest_mac_nightly_mpi_opt_ictinus.cmake +++ /dev/null @@ -1,80 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.ictinus.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(EXTRA_EXCLUDE_PACKAGES Zoltan) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/ictinus/ctest_mac_nightly_mpi_release_ictinus.cmake b/cmake/ctest/drivers/ictinus/ctest_mac_nightly_mpi_release_ictinus.cmake deleted file mode 100644 index cdc91e66a900..000000000000 --- a/cmake/ctest/drivers/ictinus/ctest_mac_nightly_mpi_release_ictinus.cmake +++ /dev/null @@ -1,85 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.ictinus.gcc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "MPI_RELEASE_${Trilinos_VERSION}") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) - -SET(EXTRA_EXCLUDE_PACKAGES Zoltan) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/ictinus/ctest_mac_nightly_serial_debug_ictinus.cmake b/cmake/ctest/drivers/ictinus/ctest_mac_nightly_serial_debug_ictinus.cmake deleted file mode 100644 index 0c47064f19e3..000000000000 --- a/cmake/ctest/drivers/ictinus/ctest_mac_nightly_serial_debug_ictinus.cmake +++ /dev/null @@ -1,80 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.ictinus.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_DEV) -#SET(CTEST_TEST_TIMEOUT 900) - -# Exclude Sundance because of strange segfault (see bug 4382) -SET(EXTRA_EXCLUDE_PACKAGES Sundance Zoltan2 Panzer) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/ictinus/ctest_mac_nightly_serial_release_ictinus.cmake b/cmake/ctest/drivers/ictinus/ctest_mac_nightly_serial_release_ictinus.cmake deleted file mode 100644 index e81aebadd939..000000000000 --- a/cmake/ctest/drivers/ictinus/ctest_mac_nightly_serial_release_ictinus.cmake +++ /dev/null @@ -1,85 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.ictinus.gcc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "SERIAL_RELEASE_${Trilinos_VERSION}") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) - -# Exclude Sundance because of strange segfault (see bug 4382) -SET(EXTRA_EXCLUDE_PACKAGES Sundance Panzer) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/kallikrates/CMakeLists.txt b/cmake/ctest/drivers/kallikrates/CMakeLists.txt deleted file mode 100644 index 925b3b23481f..000000000000 --- a/cmake/ctest/drivers/kallikrates/CMakeLists.txt +++ /dev/null @@ -1,38 +0,0 @@ -INCLUDE("../../../../Version.cmake") - -TRILINOS_DRIVER_SETUP() - -IF(${Trilinos_REPOSITORY_BRANCH} STREQUAL "master") - #Nightly tests - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_OPT - ctest_windows_nightly_serial_development.cmake - RUN_SERIAL - TIMEOUT_MINUTES 300 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_OPT_SHARED - ctest_windows_nightly_serial_development_shared.cmake - RUN_SERIAL - TIMEOUT_MINUTES 60 - ) - -ELSE() - #Release tests - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_OPT_RELEASE - ctest_windows_nightly_serial_release.cmake - RUN_SERIAL - TIMEOUT_MINUTES 300 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_OPT_RELEASE_SHARED - ctest_windows_nightly_serial_release_shared.cmake - RUN_SERIAL - TIMEOUT_MINUTES 60 - ) -ENDIF() - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/kallikrates/TrilinosCTestDriverCore.Kallikrates.msvc.cmake b/cmake/ctest/drivers/kallikrates/TrilinosCTestDriverCore.Kallikrates.msvc.cmake deleted file mode 100755 index 794870cf7323..000000000000 --- a/cmake/ctest/drivers/kallikrates/TrilinosCTestDriverCore.Kallikrates.msvc.cmake +++ /dev/null @@ -1,99 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for godel using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - # convert CVS_EXE path to a cmake style path and store - # in CVS_EXECUTABLE. CVS_EXE is an environment variable - # that should be set before running this script. - FILE(TO_CMAKE_PATH "$ENV{CVS_EXE}" CVS_EXECUTABLE) - SET( CTEST_CMAKE_GENERATOR "NMake Makefiles") - SET( CTEST_BUILD_FLAGS " -i" ) - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON ) - SET(COMPILER_VERSION "MSVC9") - - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} ) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCLAPACK_DIR=C:/trilinos_projects/clapack_build" - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DBoost_INCLUDE_DIRS=C:/trilinos_projects/boost_1_40_0" - "-DTPL_ENABLE_Netcdf=OFF" - ) - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/kallikrates/ctest_windows_nightly_mpi_development.cmake b/cmake/ctest/drivers/kallikrates/ctest_windows_nightly_mpi_development.cmake deleted file mode 100755 index 92162472f434..000000000000 --- a/cmake/ctest/drivers/kallikrates/ctest_windows_nightly_mpi_development.cmake +++ /dev/null @@ -1,78 +0,0 @@ -# @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 - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.kallikrates.msvc.cmake") - -# -# Set the options specific to this build case -# -#SET(CTEST_DO_UPDATES FALSE) -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV) -SET(CTEST_TEST_TYPE NIGHTLY) -#SET(CTEST_TEST_TIMEOUT 900) - -SET( EXTRA_EXCLUDE_PACKAGES TriBITS Amesos Ifpack ML Moertel Stokhos Piro Optika Mesquite FEApp) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_KNOWN_EXTERNAL_REPOS_TYPE:STRING=Experimental" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/kallikrates/ctest_windows_nightly_mpi_release.cmake b/cmake/ctest/drivers/kallikrates/ctest_windows_nightly_mpi_release.cmake deleted file mode 100755 index bcce74382c0b..000000000000 --- a/cmake/ctest/drivers/kallikrates/ctest_windows_nightly_mpi_release.cmake +++ /dev/null @@ -1,75 +0,0 @@ -# @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 - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.kallikrates.msvc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# -#SET(CTEST_DO_UPDATES FALSE) -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "${COMM_TYPE}_${BUILD_TYPE}_${Trilinos_VERSION}") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) - -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) -#SET(CTEST_TEST_TIMEOUT 900) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/kallikrates/ctest_windows_nightly_serial_development.cmake b/cmake/ctest/drivers/kallikrates/ctest_windows_nightly_serial_development.cmake deleted file mode 100755 index b8851c75f121..000000000000 --- a/cmake/ctest/drivers/kallikrates/ctest_windows_nightly_serial_development.cmake +++ /dev/null @@ -1,78 +0,0 @@ -# @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 - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.kallikrates.msvc.cmake") - -# -# Set the options specific to this build case -# -#SET(CTEST_DO_UPDATES FALSE) -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_OPT_DEV) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET( EXTRA_EXCLUDE_PACKAGES TriBITS Stokhos Piro FEApp KokkosCore TeuchosKokkosCompat KokkosContainers TpetraKernels KokkosExample TeuchosKokkosComm) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_KNOWN_EXTERNAL_REPOS_TYPE:STRING=Experimental" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/kallikrates/ctest_windows_nightly_serial_development_shared.cmake b/cmake/ctest/drivers/kallikrates/ctest_windows_nightly_serial_development_shared.cmake deleted file mode 100755 index 1925083cc352..000000000000 --- a/cmake/ctest/drivers/kallikrates/ctest_windows_nightly_serial_development_shared.cmake +++ /dev/null @@ -1,81 +0,0 @@ -# @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 - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.kallikrates.msvc.cmake") - -# -# Set the options specific to this build case -# -#SET(CTEST_DO_UPDATES FALSE) -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_OPT_DEV_SHARED) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -#The dll export macros have only been added for a few packages so we can really only test those packages -SET(Trilinos_PACKAGES "Teuchos;Epetra;Anasazi") -SET(CTEST_EXPLICITLY_ENABLE_IMPLICITLY_ENABLED_PACKAGES FALSE) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DBUILD_SHARED_LIBS:BOOL=ON" - "-DTrilinos_ENABLE_ALL_OPTIONAL_PACKAGES:BOOL=OFF" -) - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/kallikrates/ctest_windows_nightly_serial_release.cmake b/cmake/ctest/drivers/kallikrates/ctest_windows_nightly_serial_release.cmake deleted file mode 100755 index 1bd4362493cf..000000000000 --- a/cmake/ctest/drivers/kallikrates/ctest_windows_nightly_serial_release.cmake +++ /dev/null @@ -1,78 +0,0 @@ -# @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 - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.kallikrates.msvc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# -#SET(CTEST_DO_UPDATES FALSE) -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "SERIAL_RELEASE_${Trilinos_VERSION}") -SET(CTEST_TEST_TYPE Experimental) -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) - -SET( EXTRA_EXCLUDE_PACKAGES TriBITS Stokhos Piro FEApp) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/kallikrates/ctest_windows_nightly_serial_release_shared.cmake b/cmake/ctest/drivers/kallikrates/ctest_windows_nightly_serial_release_shared.cmake deleted file mode 100755 index c9b8ea0cf9ab..000000000000 --- a/cmake/ctest/drivers/kallikrates/ctest_windows_nightly_serial_release_shared.cmake +++ /dev/null @@ -1,84 +0,0 @@ -# @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 - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.kallikrates.msvc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# -#SET(CTEST_DO_UPDATES FALSE) -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_OPT_RELEASE_${Trilinos_VERSION}_SHARED) -SET(CTEST_TEST_TYPE Experimental) -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) - -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -#The dll export macros have only been added for a few packages so we can really only test those packages -SET(Trilinos_PACKAGES "Teuchos;Epetra;Anasazi") -SET(CTEST_EXPLICITLY_ENABLE_IMPLICITLY_ENABLED_PACKAGES FALSE) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DBUILD_SHARED_LIBS:BOOL=ON" - "-DTrilinos_ENABLE_ALL_OPTIONAL_PACKAGES:BOOL=OFF" -) - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/kallikrates/task_driver_development_kallikrates.bat b/cmake/ctest/drivers/kallikrates/task_driver_development_kallikrates.bat deleted file mode 100755 index 18c387250395..000000000000 --- a/cmake/ctest/drivers/kallikrates/task_driver_development_kallikrates.bat +++ /dev/null @@ -1,56 +0,0 @@ -rem Driver script for dashboards on kallikrates - -rem Call this script and pass in the base directory for the dashboard -rem save state before changing anything -setlocal - -rem Setting the path to have git on it. -set PATH=%PATH%;C:\Program Files (x86)\Git\cmd;C:\Qt\4.6.3\bin - -rem GIT needs to know how to use ssh -set GIT_SSH=C:\Users\bmpersc\Documents\plink_wrap.bat - -rem Set location of CTEST_EXE, and GIT_EXE -set GIT_EXE=C:\Program Files (x86)\Git\cmd\git -set CTEST_EXE=C:\Program Files (x86)\CMake 2.8\bin\ctest.exe -set TRILINOS_REPOSITORY_LOCATION=software.sandia.gov:/space/git/nightly/Trilinos - -rem Set the base directory which is one above where Trilinos will be -rem checked out. - -set BASEDIR=%~1 - -rem setup the environment for command line cl to run -call "C:\Program Files (x86)\Microsoft Visual Studio 9.0\Common7\Tools\vsvars32.bat" - -rem change into the basedir -cd "%BASEDIR%" - -rem checkout the basics from Trilinos needed to run the dashboard including -rem this script. -if exist Trilinos goto update else goto checkout - -:update - echo "Doing update of an existing directory" - cd Trilinos - call "%GIT_EXE%" pull - cd .. - goto endif - -:checkout - echo "Cloning the repository because none exists yet." - call "%GIT_EXE%" clone %TRILINOS_REPOSITORY_LOCATION% - -:endif - -rem Now run ctest on each of the ctest build scripts for this machine - -call "%CTEST_EXE%" -S "%BASEDIR%\Trilinos\cmake\ctest\drivers\kallikrates\ctest_windows_nightly_serial_development.cmake" -VV >"%BASEDIR%\ctest_msvc_nightly_serial_development_kallikrates.out" 2>&1 - -rem Have to set the path so that the tests can find the dlls during runtime. We need a better solution than this long term. Something like -rpath for gnu. -set PATH=%PATH%;%BASEDIR%\SERIAL_OPT_DEV_SHARED\BUILD\packages\epetra\src;%BASEDIR%\SERIAL_OPT_DEV_SHARED\BUILD\packages\teuchos\src;%BASEDIR%\SERIAL_OPT_DEV_SHARED\BUILD\packages\anasazi\src;%BASEDIR%\SERIAL_OPT_DEV_SHARED\BUILD\packages\epetra\test\src;%BASEDIR%\SERIAL_OPT_DEV_SHARED\BUILD\packages\teuchos\test\FancyOutputting;%BASEDIR%\SERIAL_OPT_DEV_SHARED\BUILD\packages\teuchos\test\ParameterList - -call "%CTEST_EXE%" -S "%BASEDIR%\Trilinos\cmake\ctest\drivers\kallikrates\ctest_windows_nightly_serial_development_shared.cmake" -VV >"%BASEDIR%\ctest_msvc_nightly_serial_development_shared_kallikrates.out" 2>&1 - - -endlocal diff --git a/cmake/ctest/drivers/kallikrates/task_driver_kallikrates.bat b/cmake/ctest/drivers/kallikrates/task_driver_kallikrates.bat deleted file mode 100755 index 13db9a77228c..000000000000 --- a/cmake/ctest/drivers/kallikrates/task_driver_kallikrates.bat +++ /dev/null @@ -1,57 +0,0 @@ -rem Driver script for dashboards on kallikrates - -rem Call this script and pass in the base directory for the dashboard -rem save state before changing anything -setlocal - -rem Setting the path to have git on it. -set PATH=%PATH%;C:\Program Files (x86)\Git\cmd - -rem GIT needs to know how to use ssh -set GIT_SSH=C:\Users\bmpersc\Documents\plink_wrap.bat - -rem Set location of CTEST_EXE, and GIT_EXE -set GIT_EXE=C:\Program Files (x86)\Git\cmd\git -set CTEST_EXE=C:\Program Files (x86)\CMake 2.8\bin\ctest.exe -set BRANCH=trilinos-release-10-0-branch -set TRILINOS_REPOSITORY_LOCATION=software.sandia.gov:/space/git/nightly/Trilinos - -rem Set the base directory which is one above where Trilinos will be -rem checked out. - -set BASEDIR=%~1 - -rem setup the environment for command line cl to run -call "C:\Program Files (x86)\Microsoft Visual Studio 9.0\Common7\Tools\vsvars32.bat" - -rem change into the basedir -cd "%BASEDIR%" - -rem checkout the basics from Trilinos needed to run the dashboard including -rem this script. -if exist Trilinos goto update else goto checkout - -:update - echo "Doing update of an existing directory" - cd Trilinos - call "%GIT_EXE%" checkout %BRANCH% - call "%GIT_EXE%" pull - cd .. - goto endif - -:checkout - echo "Cloning the repository because none exists yet." - call "%GIT_EXE%" clone %TRILINOS_REPOSITORY_LOCATION% - cd Trilinos - call "%GIT_EXE%" checkout --track origin/%BRANCH% - -:endif - -rem Now run ctest on each of the ctest build scripts for this machine - -call "%CTEST_EXE%" -S "%BASEDIR%\Trilinos\cmake\ctest\drivers\kallikrates\ctest_windows_nightly_serial_release.cmake" -VV >"%BASEDIR%\ctest_msvc_nightly_serial_release_kallikrates.out" 2>&1 - -rem disabling temporarily since the mpi build is unstable on windows right now. -rem call "%CTEST_EXE%" -S "%BASEDIR%\Trilinos\cmake\ctest\drivers\kallikrates\ctest_windows_nightly_mpi_release.cmake" -VV >"%BASEDIR%\ctest_msvc_nightly_mpi_release_kallikrates.out" 2>&1 - -endlocal diff --git a/cmake/ctest/drivers/kallikrates/task_driver_kallikrates_jenkins.bat b/cmake/ctest/drivers/kallikrates/task_driver_kallikrates_jenkins.bat deleted file mode 100755 index c19ee5deda84..000000000000 --- a/cmake/ctest/drivers/kallikrates/task_driver_kallikrates_jenkins.bat +++ /dev/null @@ -1,24 +0,0 @@ -rem Driver script for dashboards on kallikrates - -rem Call this script and pass in the base directory for the dashboard -rem save state before changing anything -setlocal - -rem Setting the path to have git on it. -set PATH=%PATH%;C:\Program Files (x86)\Git\cmd - -rem Set location of CTEST_EXE, and GIT_EXE -set GIT_EXE=C:\Program Files (x86)\Git\cmd\git -set CTEST_EXE=C:\Program Files (x86)\CMake 2.8\bin\ctest.exe - -rem Set the base directory which is one above where Trilinos will be -rem checked out. - -rem setup the environment for command line cl to run -call "C:\Program Files (x86)\Microsoft Visual Studio 9.0\Common7\Tools\vsvars32.bat" - -rem Now run ctest on each of the ctest build scripts for this machine - -call "%CTEST_EXE%" -S "Trilinos\cmake\ctest\drivers\kallikrates\ctest_windows_nightly_serial_release.cmake" -VV - -endlocal diff --git a/cmake/ctest/drivers/kallikrates/tdd_task_driver.bat b/cmake/ctest/drivers/kallikrates/tdd_task_driver.bat deleted file mode 100644 index ec39b546b561..000000000000 --- a/cmake/ctest/drivers/kallikrates/tdd_task_driver.bat +++ /dev/null @@ -1,21 +0,0 @@ -rem Driver script for dashboards on kallikrates - -rem Call this script and pass in the base directory for the dashboard -rem save state before changing anything -setlocal - -set TDD_CTEST_TEST_TYPE=Nightly - -set BASEDIR=%~1 - -rem Setting the path to have git on it. -set PATH=%PATH%;C:\Program Files (x86)\Git\cmd - -rem Set location of GIT_EXE -set GIT_EXE=C:\Program Files (x86)\Git\cmd\git - -rem Have to set the path so that the tests can find the dlls during runtime. We need a better solution than this long term. Something like -rpath for gnu. -set PATH=%PATH%;%BASEDIR%\SERIAL_OPT_DEV_SHARED\BUILD\packages\epetra\src;%BASEDIR%\SERIAL_OPT_DEV_SHARED\BUILD\packages\epetra\test\src;%BASEDIR%\SERIAL_OPT_DEV_SHARED\BUILD\packages\anasazi\src;%BASEDIR%\SERIAL_OPT_DEV_SHARED\BUILD\packages\teuchos\core\src;%BASEDIR%\SERIAL_OPT_DEV_SHARED\BUILD\packages\teuchos\parameterlist\src;%BASEDIR%\SERIAL_OPT_DEV_SHARED\BUILD\packages\teuchos\parameterlist\test\FancyOutputting;%BASEDIR%\SERIAL_OPT_DEV_SHARED\BUILD\packages\teuchos\parameterlist\test\ParameterList;%BASEDIR%\SERIAL_OPT_DEV_SHARED\BUILD\packages\teuchos\comm\src;%BASEDIR%\SERIAL_OPT_DEV_SHARED\BUILD\packages\teuchos\comm\test\ParameterList;%BASEDIR%\SERIAL_OPT_DEV_SHARED\BUILD\packages\teuchos\numerics\src;%BASEDIR%\SERIAL_OPT_DEV_SHARED\BUILD\packages\teuchos\remainder\src - - -python %BASEDIR%\Trilinos\cmake\ctest\drivers\cron_driver.py diff --git a/cmake/ctest/drivers/kokkos-dev/CMakeLists.txt b/cmake/ctest/drivers/kokkos-dev/CMakeLists.txt deleted file mode 100644 index 4470110dd354..000000000000 --- a/cmake/ctest/drivers/kokkos-dev/CMakeLists.txt +++ /dev/null @@ -1,13 +0,0 @@ -TRILINOS_DRIVER_SETUP() - - -TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_RELEASE_DEV_KokkosCore_all - ctest_linux_nightly_serial_release_core_all_kokkos-dev.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 180 -) - - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/kokkos-dev/TrilinosCTestDriverCore.kokkos-dev.gcc.cmake b/cmake/ctest/drivers/kokkos-dev/TrilinosCTestDriverCore.kokkos-dev.gcc.cmake deleted file mode 100644 index 83e772264583..000000000000 --- a/cmake/ctest/drivers/kokkos-dev/TrilinosCTestDriverCore.kokkos-dev.gcc.cmake +++ /dev/null @@ -1,110 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for typhon using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j20 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "4" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENDENCY_UNIT_TESTS:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=ON" - "-DTrilinos_ENABLE_Fortran:BOOL=OFF" - "-DTrilinos_ENABLE_TESTS:BOOL=ON" - "-DTrilinos_ENABLE_EXAMPLES:BOOL=ON" - - "-DHWLOC_INCLUDE_DIRS:FILEPATH=/home/projects/hwloc/1.7.1/host/gnu/4.7.3/include" - "-DHWLOC_LIBRARY_DIRS:FILEPATH=/home/projects/hwloc/1.7.1/host/gnu/4.7.3/lib" - ) - - SET_DEFAULT(COMPILER_VERSION "GCC-4.8.3") - - #Ensuring that MPI is on for all parallel builds that might be run. - IF(COMM_TYPE STREQUAL MPI) - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/home/projects/x86-64/openmpi/1.8.3/gcc/4.8.3/cuda/6.5.14" - ) - ELSE() - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER=$ENV{NVCC_WRAPPER}" - "-DCMAKE_C_COMPILER=/home/projects/x86-64/gcc/4.8.3/bin/gcc" - ) - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/kokkos-dev/cron_driver.sh b/cmake/ctest/drivers/kokkos-dev/cron_driver.sh deleted file mode 100755 index 99767d47e2db..000000000000 --- a/cmake/ctest/drivers/kokkos-dev/cron_driver.sh +++ /dev/null @@ -1,39 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on kokkos-dev: `date`" -echo - -# -# TrilinosDriver settings: -# - -export TDD_PARALLEL_LEVEL=2 - -# Trilinos settings: -# - -# Submission mode for the *TrilinosDriver* dashboard -export TDD_CTEST_TEST_TYPE=Nightly - -#export CTEST_DO_SUBMIT=FALSE -export CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=FALSE - -# Machine specific environment -# - -export TDD_HTTP_PROXY="http://sonproxy.sandia.gov:80" -export http_proxy="http://sonproxy.sandia.gov:80" -export TDD_FORCE_CMAKE_INSTALL=1 -export CUDA_LAUNCH_BLOCKING=1 -export OMP_NUM_THREADS=2 -export OMP_PROC_BIND=false -export PATH="$PATH:/opt/intel/composer_xe_2013_sp1.1.106/compiler/lib/intel64" - -# Machine independent cron_driver: -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on kokkos-dev: `date`" -echo diff --git a/cmake/ctest/drivers/kokkos-dev/ctest_linux_nightly_serial_release_core_all_kokkos-dev.cmake b/cmake/ctest/drivers/kokkos-dev/ctest_linux_nightly_serial_release_core_all_kokkos-dev.cmake deleted file mode 100644 index 873ca79008d3..000000000000 --- a/cmake/ctest/drivers/kokkos-dev/ctest_linux_nightly_serial_release_core_all_kokkos-dev.cmake +++ /dev/null @@ -1,106 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.kokkos-dev.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_RELEASE_DEV_KokkosCore_all) -SET(CTEST_PARALLEL_LEVEL 4) -SET(CTEST_TEST_TYPE Experimental) -SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_PACKAGES KokkosCore KokkosLinAlg KokkosContainers KokkosAlgorithms KokkosExample) -SET(EXTRA_EXCLUDE_PACKAGES KokkosTSQR KokkosClassic) - - -SET(EXTRA_CONFIGURE_OPTIONS - "-DTPL_ENABLE_HWLOC:BOOL=ON" - "-DTPL_ENABLE_CUDA:BOOL=ON" - "-DTPL_ENABLE_CUSPARSE:BOOL=ON" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DKokkos_ENABLE_Pthread:BOOL=ON" - "-DTrilinos_ENABLE_OpenMP:BOOL=ON" - "-DKokkos_ENABLE_OpenMP:BOOL=ON" - -#Turning qthreads off until where/how it will be installed can be determined - "TPL_ENABLE_QTHREAD:BOOL=OFF" - "QTHREAD_INCLUDE_DIRS:FILEPATH=path_to_qthread/include" - "QTHREAD_LIBRARY_DIRS:FILEPATH=path_to_qthread/lib" - - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - - "-DTrilinos_ENABLE_KokkosCore=ON" - "-DTrilinos_ENABLE_KokkosContainers=ON" - "-DTrilinos_ENABLE_KokkosLinAlg=ON" - "-DTrilinos_ENABLE_KokkosAlgorithms=ON" - "-DTrilinos_ENABLE_KokkosExample=ON" - "-DTrilinos_ENABLE_KokkosTSQR=OFF" - "-DTrilinos_ENABLE_KokkosClassic=OFF" - - "-DTrilinos_ENABLE_ALL_OPTIONAL_PACKAGES:BOOL=OFF" - -) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/muir/CMakeLists.txt b/cmake/ctest/drivers/muir/CMakeLists.txt deleted file mode 100644 index dff031440f82..000000000000 --- a/cmake/ctest/drivers/muir/CMakeLists.txt +++ /dev/null @@ -1,58 +0,0 @@ -INCLUDE("../../../../Version.cmake") - -TRILINOS_DRIVER_SETUP() - -set(CTEST_EXE "${CMAKE_CTEST_COMMAND}") -set(workingdir "${TrilinosDriver_BINARY_DIR}") - -# Get the day of the week -execute_process(COMMAND date +%A OUTPUT_VARIABLE DAYOFWEEK) - -IF(${Trilinos_REPOSITORY_BRANCH} STREQUAL "develop") - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_DEBUG_Werror_DEV - ctest_linux_nightly_mpi_development_debug_gcc_4.7.2_muir.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 300 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_OPT_DEV - ctest_linux_nightly_serial_development_opt_gcc_4.7.2_muir.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 300 - ) - -# TRILINOS_DRIVER_ADD_DASHBOARD( -# MPI_DEBUG_DEV2 -# ctest_linux_nightly_mpi_development_debug_gcc_5.8.2_muir.cmake -# CTEST_INSTALLER_TYPE release -# RUN_SERIAL -# TIMEOUT_MINUTES 300 -# ) - -# TRILINOS_DRIVER_ADD_DASHBOARD( -# SERIAL_OPT_DEV2 -# ctest_linux_nightly_serial_development_opt_gcc_4.8.2_muir.cmake -# CTEST_INSTALLER_TYPE release -# RUN_SERIAL -# TIMEOUT_MINUTES 300 -# ) - -if(${DAYOFWEEK} MATCHES "Saturday") - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_DEBUG_DEV3 - ctest_linux_nightly_mpi_development_debug_gcc_5.0-trunk_muir.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 300 - ) -endif() - -ELSE() -#release tests would go here -ENDIF() - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/muir/TrilinosCTestDriverCore.trilinos-test.gcc4.7.2.cmake b/cmake/ctest/drivers/muir/TrilinosCTestDriverCore.trilinos-test.gcc4.7.2.cmake deleted file mode 100644 index f6a77f62a3ba..000000000000 --- a/cmake/ctest/drivers/muir/TrilinosCTestDriverCore.trilinos-test.gcc4.7.2.cmake +++ /dev/null @@ -1,137 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for trilinos-test using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_BUILD_FLAGS "-j20 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "20" ) - - SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DCOVERAGE_COMMAND:FILEPATH=/usr/bin/gcov" - "-DMEMORYCHECK_COMMAND:FILEPATH=/usr/bin/valgrind" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DTPL_ENABLE_Matio=OFF" - "-DIntrepidCore_ENABLE_DEBUG_INF_CHECK=OFF" - "-DSuperLU_INCLUDE_DIRS:PATH=/home/trilinos/tpl/gcc4.4.4/SuperLU_4.3/SRC" - "-DSuperLU_LIBRARY_DIRS:PATH=/home/trilinos/tpl/gcc4.4.4/SuperLU_4.3/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu_4.3" - "-DGLM_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.4.4/glm-0.9.4.6" - "-DBoost_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/boostlib_1_55_0/include" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/boostlib_1_55_0/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/boostlib_1_55_0/lib" - "-DTrilinos_ENABLE_CXX11=ON" - ) - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - SET_DEFAULT(COMPILER_VERSION "GCC-4.7.2") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR=/home/trilinos/compilers/gcc/openmpi-1.6.5-gcc-4.7.2" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_openmpi_1.2.7.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/home/trilinos/compilers/gcc/4.7.2/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/home/trilinos/compilers/gcc/4.7.2/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/home/trilinos/compilers/gcc/4.7.2/bin/gfortran" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_gcc-4.1.2.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/muir/TrilinosCTestDriverCore.trilinos-test.gcc4.8.2.cmake b/cmake/ctest/drivers/muir/TrilinosCTestDriverCore.trilinos-test.gcc4.8.2.cmake deleted file mode 100644 index 0c8322596f70..000000000000 --- a/cmake/ctest/drivers/muir/TrilinosCTestDriverCore.trilinos-test.gcc4.8.2.cmake +++ /dev/null @@ -1,137 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for trilinos-test using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_BUILD_FLAGS "-j20 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "20" ) - - SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DCOVERAGE_COMMAND:FILEPATH=/usr/bin/gcov" - "-DMEMORYCHECK_COMMAND:FILEPATH=/usr/bin/valgrind" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DTPL_ENABLE_Matio=OFF" - "-DIntrepidCore_ENABLE_DEBUG_INF_CHECK=OFF" - "-DSuperLU_INCLUDE_DIRS:PATH=/home/trilinos/tpl/gcc4.4.4/SuperLU_4.3/SRC" - "-DSuperLU_LIBRARY_DIRS:PATH=/home/trilinos/tpl/gcc4.4.4/SuperLU_4.3/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu_4.3" - "-DGLM_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.4.4/glm-0.9.4.6" - "-DBoost_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/boostlib_1_55_0/include" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/boostlib_1_55_0/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/boostlib_1_55_0/lib" - "-DTrilinos_ENABLE_CXX11=ON" - ) - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - SET_DEFAULT(COMPILER_VERSION "GCC-4.8.2") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR=/home/trilinos/compilers/gcc/openmpi-1.6.5-gcc-4.8.2" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_openmpi_1.2.7.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/home/trilinos/compilers/gcc/4.8.2/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/home/trilinos/compilers/gcc/4.8.2/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/home/trilinos/compilers/gcc/4.8.2/bin/gfortran" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_gcc-4.1.2.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/muir/TrilinosCTestDriverCore.trilinos-test.gcc5.0.cmake b/cmake/ctest/drivers/muir/TrilinosCTestDriverCore.trilinos-test.gcc5.0.cmake deleted file mode 100644 index d2ccdd62ba61..000000000000 --- a/cmake/ctest/drivers/muir/TrilinosCTestDriverCore.trilinos-test.gcc5.0.cmake +++ /dev/null @@ -1,136 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for trilinos-test using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_BUILD_FLAGS "-j20 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "20" ) - - SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DCOVERAGE_COMMAND:FILEPATH=/usr/bin/gcov" - "-DMEMORYCHECK_COMMAND:FILEPATH=/usr/bin/valgrind" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DTPL_ENABLE_Matio=OFF" - "-DIntrepidCore_ENABLE_DEBUG_INF_CHECK=OFF" - "-DSuperLU_INCLUDE_DIRS:PATH=/home/trilinos/tpl/gcc4.4.4/SuperLU_4.3/SRC" - "-DSuperLU_LIBRARY_DIRS:PATH=/home/trilinos/tpl/gcc4.4.4/SuperLU_4.3/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu_4.3" - "-DBoost_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/boostlib_1_55_0/include" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/boostlib_1_55_0/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/boostlib_1_55_0/lib" - "-DTrilinos_ENABLE_CXX11=ON" - ) - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - SET_DEFAULT(COMPILER_VERSION "GCC-5.0-trunk") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR=/home/trilinos/compilers/gcc/openmpi-1.6.5-gcc-5.0-trunk" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_openmpi_1.2.7.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/home/trilinos/compilers/gcc/5.0-trunk/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/home/trilinos/compilers/gcc/5.0-trunk/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/home/trilinos/compilers/gcc/5.0-trunk/bin/gfortran" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_gcc-4.1.2.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/muir/checkin-test-muir.sh b/cmake/ctest/drivers/muir/checkin-test-muir.sh deleted file mode 100755 index d4f9c728894c..000000000000 --- a/cmake/ctest/drivers/muir/checkin-test-muir.sh +++ /dev/null @@ -1,65 +0,0 @@ - -#!/bin/bash -if [ "$TRILINOS_BASE_DIR" == "" ] ; then - TRILINOS_BASE_DIR=../.. -fi - -TRILINOS_BASE_DIR_ABS=$(readlink -f $TRILINOS_BASE_DIR) - -DRIVERS_BASE_DIR="$TRILINOS_BASE_DIR_ABS/Trilinos/cmake/ctest/drivers/fissile4" - -echo " --DTrilinos_DISABLE_ENABLED_FORWARD_DEP_PACKAGES=ON -" > COMMON.config - -# -# Built-in Primary Tested (PT) --default-builds (DO NOT MODIFY) -# - -echo " -" > MPI_DEBUG.config - -echo " --DCMAKE_C_COMPILER=gcc -" > SERIAL_RELEASE.config - -# -# Standard Secondary Tested (ST) --st-extra-builds (DO NOT MODIFY) -# - -echo " --DTrilinos_ENABLE_DEBUG=ON --DTPL_ENABLE_MPI=ON -" > MPI_DEBUG_ST.config - -echo " --DCMAKE_C_COMPILER=gcc --DCMAKE_BUILD_TYPE=RELEASE --DTrilinos_ENABLE_DEBUG=OFF --DTPL_ENABLE_MPI=OFF -" > SERIAL_RELEASE_ST.config - -# -# Create local defaults file if one does not exist -# - -_LOCAL_CHECKIN_TEST_DEFAULTS=local-checkin-test-defaults.py -if [ -f $_LOCAL_CHECKIN_TEST_DEFAULTS ] ; then - echo "File $_LOCAL_CHECKIN_TEST_DEFAULTS already exists, leaving it!" -else - echo "Creating default file $_LOCAL_CHECKIN_TEST_DEFAULTS!" - echo " -defaults = [ - \"-j12\", - \"--ctest-timeout=180\", - \"--skip-case-no-email\", - ] - " > $_LOCAL_CHECKIN_TEST_DEFAULTS -fi - -# -# Invocation -# - -$TRILINOS_BASE_DIR/Trilinos/checkin-test.py \ -"$@" diff --git a/cmake/ctest/drivers/muir/cron_driver.sh b/cmake/ctest/drivers/muir/cron_driver.sh deleted file mode 100755 index 4335aafaf08e..000000000000 --- a/cmake/ctest/drivers/muir/cron_driver.sh +++ /dev/null @@ -1,44 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on muir: `date`" -echo - -# TrilinosDriver settings: -# -export TDD_GIT_EXE=/home/trilinos/git/bin/git -export TDD_PARALLEL_LEVEL=2 -export TDD_HTTP_PROXY="http://wwwproxy.sandia.gov:80/" - -# Trilinos settings: -# -export TDD_CTEST_TEST_TYPE=Nightly - -# Machine specific environment: -# -export PATH=/usr/local/bin:/bin:/usr/bin/$PATH:/home/trilinos/tpl/gcc4.4.4/qt-4.5.2/bin - -# BASEDIR is the parent directory of this script's Trilinos source tree... -BASEDIR=`cd "\`dirname \"$0\"\`/../../../../..";pwd` -echo BASEDIR=$BASEDIR -BASEDATADIR=$BASEDIR - -export CVS_RSH=ssh - -#export LD_LIBRARY_PATH=/home/trilinos/compilers/gcc/support_libs/mpc-1.0.1/lib:/home/trilinos/compilers/gcc/support_libs/mpfr-3.1.2/lib:/home/trilinos/compilers/gcc/support_libs/gmp-5.1.1/lib:/home/trilinos/compilers/gcc/4.7.2/lib64:$LD_LIBRARY_PATH -export PYTHONPATH="/home/trilinos/tpl/gcc4.4.4/mpi4py-1.3/lib64/python2.6:/home/trilinos/tpl/gcc4.4.4/numpy-1.6.2/lib64/python2.6/site-packages/" -export TRILINOSDATADIRECTORY="$BASEDATADIR/TrilinosData" - -pushd "$BASEDATADIR" -cvs -q -d :ext:software.sandia.gov:/space/CVS co TrilinosData -popd - -# Machine independent cron_driver: -# -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on muir: `date`" -echo - diff --git a/cmake/ctest/drivers/muir/ctest_linux_nightly_mpi_development_debug_gcc_4.7.2_muir.cmake b/cmake/ctest/drivers/muir/ctest_linux_nightly_mpi_development_debug_gcc_4.7.2_muir.cmake deleted file mode 100644 index e5bf776e4eda..000000000000 --- a/cmake/ctest/drivers/muir/ctest_linux_nightly_mpi_development_debug_gcc_4.7.2_muir.cmake +++ /dev/null @@ -1,100 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.gcc4.7.2.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG_Werror_DEV) -SET(ENV{LD_LIBRARY_PATH} "/home/trilinos/compilers/gcc/support_libs/mpc-1.0.1/lib:/home/trilinos/compilers/gcc/support_libs/mpfr-3.1.2/lib:/home/trilinos/compilers/gcc/support_libs/gmp-5.1.1/lib:/home/trilinos/compilers/gcc/4.7.2/lib64:$ENV{LD_LIBRARY_PATH}") -SET(CTEST_TEST_TYPE Nightly) -SET(Trilinos_TRACK Nightly) # CDASH Track -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(EXTRA_EXCLUDE_PACKAGES MOOCHO Optika PyTrilinos Didasko Phalanx Panzer) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/phdf5-1.8.6/lib" - "-DTPL_ENABLE_Netcdf:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.4.4/pnetcdf-4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.4.4/pnetcdf-4.2/include" - "-DZoltan2_ENABLE_Experimental:BOOL=ON" - "-DTPL_ENABLE_SuperLU:BOOL=ON" - "-DTrilinos_SHOW_DEPRECATED_WARNINGS=OFF" - "-DCMAKE_CXX_FLAGS:STRING=-Wall -ansi -pedantic -Werror -Wno-unknown-pragmas -Wno-narrowing -Wno-pragmas -Wno-delete-non-virtual-dtor" - "-DTrilinos_ENABLE_MOOCHO=OFF" - "-DTrilinos_ENABLE_Optika=OFF" - "-DTrilinos_ENABLE_Didasko=OFF" - "-DTrilinos_ENABLE_Phalanx=OFF" - "-DTrilinos_ENABLE_Panzer=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/muir/ctest_linux_nightly_mpi_development_debug_gcc_4.8.2_muir.cmake b/cmake/ctest/drivers/muir/ctest_linux_nightly_mpi_development_debug_gcc_4.8.2_muir.cmake deleted file mode 100644 index 3a2bc4484fa2..000000000000 --- a/cmake/ctest/drivers/muir/ctest_linux_nightly_mpi_development_debug_gcc_4.8.2_muir.cmake +++ /dev/null @@ -1,93 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.gcc4.8.2.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG_DEV2) -SET(ENV{LD_LIBRARY_PATH} "/home/trilinos/compilers/gcc/4.8.2/lib64:$ENV{LD_LIBRARY_PATH}") -SET(CTEST_TEST_TYPE Nightly) -SET(Trilinos_TRACK Specialized) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(EXTRA_EXCLUDE_PACKAGES PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/phdf5-1.8.6/lib" - "-DTPL_ENABLE_Netcdf:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.4.4/pnetcdf-4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.4.4/pnetcdf-4.2/include" - "-DZoltan2_ENABLE_Experimental:BOOL=ON" - "-DTPL_ENABLE_SuperLU:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/muir/ctest_linux_nightly_mpi_development_debug_gcc_5.0-trunk_muir.cmake b/cmake/ctest/drivers/muir/ctest_linux_nightly_mpi_development_debug_gcc_5.0-trunk_muir.cmake deleted file mode 100644 index 7ff4a4f53a84..000000000000 --- a/cmake/ctest/drivers/muir/ctest_linux_nightly_mpi_development_debug_gcc_5.0-trunk_muir.cmake +++ /dev/null @@ -1,93 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.gcc5.0.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG_DEV2) -SET(ENV{LD_LIBRARY_PATH} "/home/trilinos/compilers/gcc/5.0-trunk/lib64:$ENV{LD_LIBRARY_PATH}") -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(EXTRA_EXCLUDE_PACKAGES PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/phdf5-1.8.6/lib" - "-DTPL_ENABLE_Netcdf:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.4.4/pnetcdf-4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.4.4/pnetcdf-4.2/include" - "-DZoltan2_ENABLE_Experimental:BOOL=ON" - "-DTPL_ENABLE_SuperLU:BOOL=ON" - "-DCMAKE_CXX_FLAGS=-fsanitize=alignment" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/muir/ctest_linux_nightly_serial_development_opt_gcc_4.7.2_muir.cmake b/cmake/ctest/drivers/muir/ctest_linux_nightly_serial_development_opt_gcc_4.7.2_muir.cmake deleted file mode 100644 index 8010e64e31bb..000000000000 --- a/cmake/ctest/drivers/muir/ctest_linux_nightly_serial_development_opt_gcc_4.7.2_muir.cmake +++ /dev/null @@ -1,99 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.gcc4.7.2.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_OPT_DEV) -SET(COMPILER_VERSION "GCC-4.7.2") -SET(ENV{LD_LIBRARY_PATH} "/home/trilinos/compilers/gcc/support_libs/mpc-1.0.1/lib:/home/trilinos/compilers/gcc/support_libs/mpfr-3.1.2/lib:/home/trilinos/compilers/gcc/support_libs/gmp-5.1.1/lib:/home/trilinos/compilers/gcc/4.7.2/lib64:$ENV{LD_LIBRARY_PATH}") -SET(CTEST_TEST_TYPE Nightly) -SET(Trilinos_TRACK Clean) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) -#Stokhos is explicitly disabled below to prevent the package from being -#implicitly enabled. Sundance depends on Stokhos. -SET(EXTRA_EXCLUDE_PACKAGES Phalanx Stokhos Sundance Zoltan2 Panzer PyTrilinos STK) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DCMAKE_CXX_COMPILER:FILEPATH=/home/trilinos/compilers/gcc/4.7.2/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/home/trilinos/compilers/gcc/4.7.2/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/home/trilinos/compilers/gcc/4.7.2/bin/gfortran" - "-DTrilinos_ENABLE_Stokhos:BOOL=OFF" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/hdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/hdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.4.4/netcdf-4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.4.4/netcdf-4.2/include" - "-DTPL_ENABLE_SuperLU:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/muir/ctest_linux_nightly_serial_development_opt_gcc_4.8.2_muir.cmake b/cmake/ctest/drivers/muir/ctest_linux_nightly_serial_development_opt_gcc_4.8.2_muir.cmake deleted file mode 100644 index 29b0d9bb3ee2..000000000000 --- a/cmake/ctest/drivers/muir/ctest_linux_nightly_serial_development_opt_gcc_4.8.2_muir.cmake +++ /dev/null @@ -1,99 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.gcc4.8.2.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_OPT_DEV2) -SET(COMPILER_VERSION "GCC-4.8.2") -SET(ENV{LD_LIBRARY_PATH} "/home/trilinos/compilers/gcc/4.8.2/lib64:$ENV{LD_LIBRARY_PATH}") -SET(CTEST_TEST_TYPE Nightly) -SET(Trilinos_TRACK Specialized) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) -#Stokhos is explicitly disabled below to prevent the package from being -#implicitly enabled. Sundance depends on Stokhos. -SET(EXTRA_EXCLUDE_PACKAGES Phalanx Stokhos Sundance Zoltan2 Panzer PyTrilinos STK) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DCMAKE_CXX_COMPILER:FILEPATH=/home/trilinos/compilers/gcc/4.8.2/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/home/trilinos/compilers/gcc/4.8.2/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/home/trilinos/compilers/gcc/4.8.2/bin/gfortran" - "-DTrilinos_ENABLE_Stokhos:BOOL=OFF" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/hdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/hdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.4.4/netcdf-4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.4.4/netcdf-4.2/include" - "-DTPL_ENABLE_SuperLU:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/octopi/CMakeLists.txt b/cmake/ctest/drivers/octopi/CMakeLists.txt deleted file mode 100644 index a1e3b7af8664..000000000000 --- a/cmake/ctest/drivers/octopi/CMakeLists.txt +++ /dev/null @@ -1,27 +0,0 @@ -TRILINOS_DRIVER_SETUP() - -TRILINOS_DRIVER_ADD_DASHBOARD( - ZOLTAN_INT_IDS - ctest_octopi_zoltan_int_ids.cmake - CTEST_INSTALLER_TYPE release -) - -TRILINOS_DRIVER_ADD_DASHBOARD( - ZOLTAN_LONG_IDS - ctest_octopi_zoltan_long_ids.cmake - CTEST_INSTALLER_TYPE release -) - -TRILINOS_DRIVER_ADD_DASHBOARD( - ZOLTAN_LONGLONG_IDS - ctest_octopi_zoltan_longlong_ids.cmake - CTEST_INSTALLER_TYPE release -) - -TRILINOS_DRIVER_ADD_DASHBOARD( - ZOLTAN_PURIFY - ctest_octopi_zoltan_purify.cmake - CTEST_INSTALLER_TYPE release -) - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/octopi/cron_driver_octopi.sh b/cmake/ctest/drivers/octopi/cron_driver_octopi.sh deleted file mode 100755 index 6d9f7149d634..000000000000 --- a/cmake/ctest/drivers/octopi/cron_driver_octopi.sh +++ /dev/null @@ -1,9 +0,0 @@ - -export MAILTO="zoltan-regression@software.sandia.gov" -export TDD_HTTP_PROXY="http://sonproxy.sandia.gov:80/" -export TDD_CTEST_TEST_TYPE=Nightly -export HTTP_PROXY="http://sonproxy.sandia.gov:80/" -export PATH=/opt/lam714-gcc346-pure/bin:/usr/local/bin:$PATH -/opt/lam714-gcc346-pure/bin/lamboot -/usr/bin/local/git pull -env Trilinos_PACKAGES=Zoltan CTEST_TEST_TYPE=Nightly ../cron_driver.py diff --git a/cmake/ctest/drivers/octopi/ctest_octopi_zoltan_int_ids.cmake b/cmake/ctest/drivers/octopi/ctest_octopi_zoltan_int_ids.cmake deleted file mode 100644 index 40f23953fe97..000000000000 --- a/cmake/ctest/drivers/octopi/ctest_octopi_zoltan_int_ids.cmake +++ /dev/null @@ -1,143 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME "ZOLTAN_INT_IDS") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) -SET(CTEST_TEST_TYPE Nightly) -SET(CTEST_TEST_TIMEOUT "2400") - -# -# Set the rest of the system-specific options and run the dashboard build/test -# Platform/compiler specific options for octopi -# - -# Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - -SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - -SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - -SET( CTEST_BUILD_FLAGS "-j8 -i" ) - -SET_DEFAULT( CTEST_PARALLEL_LEVEL "1" ) -SET_DEFAULT(COMPILER_VERSION "GCC-3.4.6") - - -SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -# Only turn on PyTrilinos for shared libraries -SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES TriKota Optika) - -# Purify info -SET(KDD_PURIFY "/usr/local/rational/releases/PurifyPlus.7.0/i386_linux2/bin/purify") -SET(KDD_PURIFY_ARGS "-best-effort -follow-child-processes=yes -cache-dir=/tmp/purify -chain-length=20 -windows=no ") - -# Compilers that work with purify -SET(KDD_GCC "/usr/bin/gcc346") -SET(KDD_GCXX "/usr/bin/g++346") - -# Output of "mpicc --showme:compile" and "mpiCC --showme:compile" -SET(KDD_CFLAGS "-std=c99 -m64 -g -I/opt/lam714-gcc346-pure/include -pthread") -SET(KDD_CXXFLAGS "-m64 -g -I/opt/lam714-gcc346-pure/include -pthread") - -# Output of "mpiCC --showme:link" -SET(KDD_LINKFLAGS "-m64 -L/opt/lam714-gcc346-pure/lib -llammpio -llammpi++ -llamf77mpi -lmpi -llam -laio -laio -lutil -ldl") - -# MPI info; needed for mpirun; also need this in path. -set(KDD_MPI "/opt/lam714-gcc346-pure/bin") -set(TPL_ENABLE_MPI ON) - -set(TDD_HTTP_PROXY "http://sonproxy.sandia.gov:80/") - -SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_USE_COMPILER_WRAPPERS:BOOL=OFF" - "-DMPI_BIN_DIR:STRING=${KDD_MPI}" - "-DCMAKE_C_COMPILER:STRING=${KDD_PURIFY}" - "-DCMAKE_C_FLAGS:STRING=${KDD_PURIFY_ARGS} ${KDD_GCC} ${KDD_CFLAGS}" - "-DCMAKE_CXX_COMPILER:STRING=${KDD_PURIFY}" - "-DCMAKE_CXX_FLAGS:STRING=${KDD_PURIFY_ARGS} ${KDD_GCXX} ${KDD_CXXFLAGS}" - "-DTrilinos_EXTRA_LINK_FLAGS:STRING=${KDD_LINKFLAGS}" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=ON " - "-DMPI_EXEC_MAX_NUMPROCS:STRING=11 " - "-DTrilinos_ENABLE_Fortran:BOOL=OFF " - "-DTrilinos_ENABLE_ALL_PACKAGES:BOOL=OFF " - "-DTrilinos_ENABLE_EXAMPLES:BOOL=ON " - "-DTrilinos_VERBOSE_CONFIGURE:BOOL=ON " - "-DTrilinos_ENABLE_Zoltan:BOOL=ON " - "-DZoltan_ENABLE_EXAMPLES:BOOL=OFF " - "-DZoltan_ENABLE_TESTS:BOOL=ON " - "-DZoltan_ENABLE_UINT_IDS:Bool=ON" - "-DZoltan_ENABLE_ParMETIS:BOOL=ON " - "-DParMETIS_LIBRARY_DIRS:FILEPATH=/Net/local/proj/zoltan/arch/linux64/lib/lam/ParMETIS3" - "-DParMETIS_INCLUDE_DIRS:FILEPATH=/Net/local/proj/zoltan/arch/all/src/ParMETIS3" - "-DZoltan_ENABLE_Scotch:BOOL=OFF" - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENCENCY_UNIT_TESTS:BOOL=OFF" - ) - -TRILINOS_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/octopi/ctest_octopi_zoltan_long_ids.cmake b/cmake/ctest/drivers/octopi/ctest_octopi_zoltan_long_ids.cmake deleted file mode 100644 index 05b936792ad5..000000000000 --- a/cmake/ctest/drivers/octopi/ctest_octopi_zoltan_long_ids.cmake +++ /dev/null @@ -1,143 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME "ZOLTAN_LONG_IDS") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) -SET(CTEST_TEST_TYPE Nightly) -SET(CTEST_TEST_TIMEOUT "2400") - -# -# Set the rest of the system-specific options and run the dashboard build/test -# Platform/compiler specific options for octopi -# - -# Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - -SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - -SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - -SET( CTEST_BUILD_FLAGS "-j8 -i" ) - -SET_DEFAULT( CTEST_PARALLEL_LEVEL "1" ) -SET_DEFAULT(COMPILER_VERSION "GCC-3.4.6") - - -SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -# Only turn on PyTrilinos for shared libraries -SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES TriKota Optika) - -# Purify info -SET(KDD_PURIFY "/usr/local/rational/releases/PurifyPlus.7.0/i386_linux2/bin/purify") -SET(KDD_PURIFY_ARGS "-best-effort -follow-child-processes=yes -cache-dir=/tmp/purify -chain-length=20 -windows=no ") - -# Compilers that work with purify -SET(KDD_GCC "/usr/bin/gcc346") -SET(KDD_GCXX "/usr/bin/g++346") - -# Output of "mpicc --showme:compile" and "mpiCC --showme:compile" -SET(KDD_CFLAGS "-std=c99 -m64 -g -I/opt/lam714-gcc346-pure/include -pthread") -SET(KDD_CXXFLAGS "-m64 -g -I/opt/lam714-gcc346-pure/include -pthread") - -# Output of "mpiCC --showme:link" -SET(KDD_LINKFLAGS "-m64 -L/opt/lam714-gcc346-pure/lib -llammpio -llammpi++ -llamf77mpi -lmpi -llam -laio -laio -lutil -ldl") - -# MPI info; needed for mpirun; also need this in path. -set(KDD_MPI "/opt/lam714-gcc346-pure/bin") -set(TPL_ENABLE_MPI ON) - -set(TDD_HTTP_PROXY "http://sonproxy.sandia.gov:80/") - -SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_USE_COMPILER_WRAPPERS:BOOL=OFF" - "-DMPI_BIN_DIR:STRING=${KDD_MPI}" - "-DCMAKE_C_COMPILER:STRING=${KDD_PURIFY}" - "-DCMAKE_C_FLAGS:STRING=${KDD_PURIFY_ARGS} ${KDD_GCC} ${KDD_CFLAGS}" - "-DCMAKE_CXX_COMPILER:STRING=${KDD_PURIFY}" - "-DCMAKE_CXX_FLAGS:STRING=${KDD_PURIFY_ARGS} ${KDD_GCXX} ${KDD_CXXFLAGS}" - "-DTrilinos_EXTRA_LINK_FLAGS:STRING=${KDD_LINKFLAGS}" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=ON " - "-DMPI_EXEC_MAX_NUMPROCS:STRING=11 " - "-DTrilinos_ENABLE_Fortran:BOOL=OFF " - "-DTrilinos_ENABLE_ALL_PACKAGES:BOOL=OFF " - "-DTrilinos_ENABLE_EXAMPLES:BOOL=ON " - "-DTrilinos_VERBOSE_CONFIGURE:BOOL=ON " - "-DTrilinos_ENABLE_Zoltan:BOOL=ON " - "-DZoltan_ENABLE_EXAMPLES:BOOL=OFF " - "-DZoltan_ENABLE_TESTS:BOOL=ON " - "-DZoltan_ENABLE_ULONG_IDS:Bool=ON" - "-DZoltan_ENABLE_ParMETIS:BOOL=ON " - "-DParMETIS_LIBRARY_DIRS:FILEPATH=/Net/local/proj/zoltan/arch/linux64/lib/lam/ParMETIS3" - "-DParMETIS_INCLUDE_DIRS:FILEPATH=/Net/local/proj/zoltan/arch/all/src/ParMETIS3" - "-DZoltan_ENABLE_Scotch:BOOL=OFF" - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENCENCY_UNIT_TESTS:BOOL=OFF" - ) - -TRILINOS_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/octopi/ctest_octopi_zoltan_longlong_ids.cmake b/cmake/ctest/drivers/octopi/ctest_octopi_zoltan_longlong_ids.cmake deleted file mode 100644 index 1e0dc5529bd4..000000000000 --- a/cmake/ctest/drivers/octopi/ctest_octopi_zoltan_longlong_ids.cmake +++ /dev/null @@ -1,143 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME "ZOLTAN_LONGLONG_IDS") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) -SET(CTEST_TEST_TYPE Nightly) -SET(CTEST_TEST_TIMEOUT "2400") - -# -# Set the rest of the system-specific options and run the dashboard build/test -# Platform/compiler specific options for octopi -# - -# Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - -SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - -SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - -SET( CTEST_BUILD_FLAGS "-j8 -i" ) - -SET_DEFAULT( CTEST_PARALLEL_LEVEL "1" ) -SET_DEFAULT(COMPILER_VERSION "GCC-3.4.6") - - -SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -# Only turn on PyTrilinos for shared libraries -SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES TriKota Optika) - -# Purify info -SET(KDD_PURIFY "/usr/local/rational/releases/PurifyPlus.7.0/i386_linux2/bin/purify") -SET(KDD_PURIFY_ARGS "-best-effort -follow-child-processes=yes -cache-dir=/tmp/purify -chain-length=20 -windows=no ") - -# Compilers that work with purify -SET(KDD_GCC "/usr/bin/gcc346") -SET(KDD_GCXX "/usr/bin/g++346") - -# Output of "mpicc --showme:compile" and "mpiCC --showme:compile" -SET(KDD_CFLAGS "-std=c99 -m64 -g -I/opt/lam714-gcc346-pure/include -pthread") -SET(KDD_CXXFLAGS "-m64 -g -I/opt/lam714-gcc346-pure/include -pthread") - -# Output of "mpiCC --showme:link" -SET(KDD_LINKFLAGS "-m64 -L/opt/lam714-gcc346-pure/lib -llammpio -llammpi++ -llamf77mpi -lmpi -llam -laio -laio -lutil -ldl") - -# MPI info; needed for mpirun; also need this in path. -set(KDD_MPI "/opt/lam714-gcc346-pure/bin") -set(TPL_ENABLE_MPI ON) - -set(TDD_HTTP_PROXY "http://sonproxy.sandia.gov:80/") - -SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_USE_COMPILER_WRAPPERS:BOOL=OFF" - "-DMPI_BIN_DIR:STRING=${KDD_MPI}" - "-DCMAKE_C_COMPILER:STRING=${KDD_PURIFY}" - "-DCMAKE_C_FLAGS:STRING=${KDD_PURIFY_ARGS} ${KDD_GCC} ${KDD_CFLAGS}" - "-DCMAKE_CXX_COMPILER:STRING=${KDD_PURIFY}" - "-DCMAKE_CXX_FLAGS:STRING=${KDD_PURIFY_ARGS} ${KDD_GCXX} ${KDD_CXXFLAGS}" - "-DTrilinos_EXTRA_LINK_FLAGS:STRING=${KDD_LINKFLAGS}" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=ON " - "-DMPI_EXEC_MAX_NUMPROCS:STRING=11 " - "-DTrilinos_ENABLE_Fortran:BOOL=OFF " - "-DTrilinos_ENABLE_ALL_PACKAGES:BOOL=OFF " - "-DTrilinos_ENABLE_EXAMPLES:BOOL=ON " - "-DTrilinos_VERBOSE_CONFIGURE:BOOL=ON " - "-DTrilinos_ENABLE_Zoltan:BOOL=ON " - "-DZoltan_ENABLE_EXAMPLES:BOOL=OFF " - "-DZoltan_ENABLE_TESTS:BOOL=ON " - "-DZoltan_ENABLE_ULLONG_IDS:Bool=ON" - "-DZoltan_ENABLE_ParMETIS:BOOL=ON " - "-DParMETIS_LIBRARY_DIRS:FILEPATH=/Net/local/proj/zoltan/arch/linux64/lib/lam/ParMETIS3" - "-DParMETIS_INCLUDE_DIRS:FILEPATH=/Net/local/proj/zoltan/arch/all/src/ParMETIS3" - "-DZoltan_ENABLE_Scotch:BOOL=OFF" - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENCENCY_UNIT_TESTS:BOOL=OFF" - ) - -TRILINOS_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/octopi/ctest_octopi_zoltan_purify.cmake b/cmake/ctest/drivers/octopi/ctest_octopi_zoltan_purify.cmake deleted file mode 100644 index 111204a65f9b..000000000000 --- a/cmake/ctest/drivers/octopi/ctest_octopi_zoltan_purify.cmake +++ /dev/null @@ -1,144 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME "ZOLTAN_PURIFY") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) -SET(CTEST_TEST_TYPE Nightly) -SET(CTEST_TEST_TIMEOUT "2400") - -# -# Set the rest of the system-specific options and run the dashboard build/test -# Platform/compiler specific options for octopi -# - -# Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - -SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - -SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - -SET( CTEST_BUILD_FLAGS "-j8 -i" ) - -SET_DEFAULT( CTEST_PARALLEL_LEVEL "1" ) -SET_DEFAULT(COMPILER_VERSION "GCC-3.4.6") - - -SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -# Only turn on PyTrilinos for shared libraries -SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES TriKota Optika) - -# Purify info -SET(KDD_PURIFY "/usr/local/rational/releases/PurifyPlus.7.0/i386_linux2/bin/purify") -SET(KDD_PURIFY_ARGS "-best-effort -follow-child-processes=yes -cache-dir=/tmp/purify -chain-length=20 -windows=no ") - -# Compilers that work with purify -SET(KDD_GCC "/usr/bin/gcc346") -SET(KDD_GCXX "/usr/bin/g++346") - -# Output of "mpicc --showme:compile" and "mpiCC --showme:compile" -SET(KDD_CFLAGS "-std=c99 -m64 -g -I/opt/lam714-gcc346-pure/include -pthread") -SET(KDD_CXXFLAGS "-m64 -g -I/opt/lam714-gcc346-pure/include -pthread") - -# Output of "mpiCC --showme:link" -SET(KDD_LINKFLAGS "-m64 -L/opt/lam714-gcc346-pure/lib -llammpio -llammpi++ -llamf77mpi -lmpi -llam -laio -laio -lutil -ldl") - -# MPI info; needed for mpirun; also need this in path. -set(KDD_MPI "/opt/lam714-gcc346-pure/bin") -set(TPL_ENABLE_MPI ON) - -set(TDD_HTTP_PROXY "http://sonproxy.sandia.gov:80/") - -SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_USE_COMPILER_WRAPPERS:BOOL=OFF" - "-DMPI_BIN_DIR:STRING=${KDD_MPI}" - "-DCMAKE_C_COMPILER:STRING=${KDD_PURIFY}" - "-DCMAKE_C_FLAGS:STRING=${KDD_PURIFY_ARGS} ${KDD_GCC} ${KDD_CFLAGS}" - "-DCMAKE_CXX_COMPILER:STRING=${KDD_PURIFY}" - "-DCMAKE_CXX_FLAGS:STRING=${KDD_PURIFY_ARGS} ${KDD_GCXX} ${KDD_CXXFLAGS}" - "-DTrilinos_EXTRA_LINK_FLAGS:STRING=${KDD_LINKFLAGS}" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=ON " - "-DMPI_EXEC_MAX_NUMPROCS:STRING=11 " - "-DTrilinos_ENABLE_Fortran:BOOL=OFF " - "-DTrilinos_ENABLE_ALL_PACKAGES:BOOL=OFF " - "-DTrilinos_ENABLE_EXAMPLES:BOOL=ON " - "-DTrilinos_VERBOSE_CONFIGURE:BOOL=ON " - "-DTrilinos_ENABLE_Zoltan:BOOL=ON " - "-DZoltan_ENABLE_EXAMPLES:BOOL=OFF " - "-DZoltan_ENABLE_TESTS:BOOL=ON " - "-DZoltan_ENABLE_ParMETIS:BOOL=ON " - "-DParMETIS_LIBRARY_DIRS:FILEPATH=/Net/local/proj/zoltan/arch/linux64/lib/lam/ParMETIS3" - "-DParMETIS_INCLUDE_DIRS:FILEPATH=/Net/local/proj/zoltan/arch/all/src/ParMETIS3" - "-DZoltan_ENABLE_Scotch:BOOL=ON" - "-DScotch_LIBRARY_DIRS:FILEPATH=/Net/local/proj/zoltan/arch/linux64/lib/lam/Scotch5" - "-DScotch_INCLUDE_DIRS:FILEPATH=/Net/local/proj/zoltan/arch/all/src/Scotch5" - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENCENCY_UNIT_TESTS:BOOL=OFF" - ) - -TRILINOS_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/p90n03/CMakeLists.txt b/cmake/ctest/drivers/p90n03/CMakeLists.txt deleted file mode 100644 index c1e9606f227c..000000000000 --- a/cmake/ctest/drivers/p90n03/CMakeLists.txt +++ /dev/null @@ -1,13 +0,0 @@ -# p90n03 driver - -set(CTEST_EXE "${CMAKE_CTEST_COMMAND}") -set(workingdir "${TrilinosDriver_BINARY_DIR}") - -add_test(serial_debug - "${CTEST_EXE}" - -S - "${CMAKE_CURRENT_SOURCE_DIR}/ctest_aix_nightly_serial_debug.cmake" - -VV - --output-log - "${workingdir}/ctest_aix_nightly_serial_debug_p90n03.out" -) diff --git a/cmake/ctest/drivers/p90n03/TrilinosCTestDriverCore.p90n03.xl.cmake b/cmake/ctest/drivers/p90n03/TrilinosCTestDriverCore.p90n03.xl.cmake deleted file mode 100644 index 7d7bdcd31462..000000000000 --- a/cmake/ctest/drivers/p90n03/TrilinosCTestDriverCore.p90n03.xl.cmake +++ /dev/null @@ -1,95 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for IBM AIX machine p90n03 -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET(ENV{OBJECT_MODE} 64) - SET(COMPILER_VERSION XL-11.01) - SET(CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - SET(CTEST_BUILD_FLAGS "-j8 -i" ) - SET(Trilinos_REPOSITORY_LOCATION $ENV{HOME}/bench/gitroot/Trilinos.git) - SET(Trilinos_ENABLE_KNOWN_EXTERNAL_REPOS_TYPE " ") - SET(Trilinos_WARNINGS_AS_ERRORS_FLAGS " ") - #SET(Trilinos_TRACK "Experimental") - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES PyTrilinos TriKota Optika) - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - ENDIF() - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DCMAKE_C_COMPILER:FILEPATH=/usr/vacpp/bin/xlc_r" - "-DCMAKE_CXX_COMPILER:FILEPATH=/usr/vacpp/bin/xlC_r" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/usr/bin/xlf_r" - "-DCMAKE_CXX_FLAGS:STRING=-qrtti=all -qstaticinline" - "-DCMAKE_Fortran_FLAGS:STRING=-qarch=pwr7 -qtune=pwr7" - "-DBUILD_SHARED_LIBS=ON" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DTPL_BLAS_LIBRARIES=$ENV{LAPACK_DIR}/libblas.so" - "-DTPL_LAPACK_LIBRARIES=$ENV{LAPACK_DIR}/liblapack.so" - "-DTPL_Pthread_LIBRARIES=-lpthread" - ) - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/p90n03/cron_driver.bash b/cmake/ctest/drivers/p90n03/cron_driver.bash deleted file mode 100755 index 0f0b0725dd90..000000000000 --- a/cmake/ctest/drivers/p90n03/cron_driver.bash +++ /dev/null @@ -1,16 +0,0 @@ -#!/usr/bin/env bash - -echo -echo "Starting nightly Trilinos development testing on p90n03: $(date)" -echo - -selfdir=$(cd "$(dirname "$0")";pwd) - -export TDD_CTEST_TEST_TYPE=Experimental -export CTEST_TEST_TIMEOUT=28800 - -ctest -V -S $selfdir/../TribitsDriverDashboard.cmake - -echo -echo "Ending nightly Trilinos development testing on p90n03: $(date)" -echo diff --git a/cmake/ctest/drivers/p90n03/ctest_aix_nightly_serial_debug.cmake b/cmake/ctest/drivers/p90n03/ctest_aix_nightly_serial_debug.cmake deleted file mode 100644 index 4d3f21c55ae7..000000000000 --- a/cmake/ctest/drivers/p90n03/ctest_aix_nightly_serial_debug.cmake +++ /dev/null @@ -1,71 +0,0 @@ -# @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 - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.p90n03.xl.cmake") - -# -# Set the options specific to this build case -# -#SET(CTEST_DO_UPDATES FALSE) -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG) -#SET(CTEST_TEST_TIMEOUT 900) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/parameterized/TrilinosCTestDriverCore.generic.cmake b/cmake/ctest/drivers/parameterized/TrilinosCTestDriverCore.generic.cmake deleted file mode 100644 index cbea1a8544d4..000000000000 --- a/cmake/ctest/drivers/parameterized/TrilinosCTestDriverCore.generic.cmake +++ /dev/null @@ -1,135 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for typhon using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "16" ) - SET( CTEST_BUILD_FLAGS "-j${CTEST_PARALLEL_LEVEL} -i" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_STABLE_CODE ON) - - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} PyTrilinos TriKota Optika) - - SET_DEFAULT(Trilinos_ENABLE_KNOWN_EXTERNAL_REPOS_TYPE "None") - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DTrilinos_PRE_REPOSITORIES=''" - "-DTrilinos_EXTRA_REPOSITORIES=''" - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENDENCY_UNIT_TESTS:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=ON" - "-DBUILD_SHARED_LIBS:BOOL=ON" - - "-DTrilinos_ENABLE_CXX11=ON" - "-DTrilinos_CXX11_FLAGS:STRING=--std=c++11" - - "-DTPL_ENABLE_BLAS:BOOL=ON" - "-DTPL_ENABLE_LAPACK:BOOL=ON" - - "-DSuperLU_INCLUDE_DIRS:PATH=$ENV{SEMS_SUPERLU_ROOT}/include" - "-DSuperLU_LIBRARY_DIRS:PATH=$ENV{SEMS_SUPERLU_ROOT}/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu" - - "-DBoost_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_BOOST_ROOT}/include" - "-DBoost_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_BOOST_ROOT}/lib" - - "-DBoostLib_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_BOOST_ROOT}/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_BOOST_ROOT}/lib" - - "-DHDF5_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_HDF5_ROOT}/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_HDF5_ROOT}/lib" - - "-DNetcdf_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_NETCDF_ROOT}/include" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_NETCDF_ROOT}/lib" - - "-DZlib_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_ZLIB_ROOT}/include" - "-DZlib_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_ZLIB_ROOT}/lib" - - ) - - SET_DEFAULT(COMPILER_VERSION "$ENV{SEMS_COMPILER_NAME}-$ENV{SEMS_COMPILER_VERSION}") - - #Ensuring that MPI is on for all parallel builds that might be run. - IF(COMM_TYPE STREQUAL MPI) - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR=$ENV{SEMS_OPENMPI_ROOT}" - ) - ELSE() - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=$ENV{CXX}" - "-DCMAKE_C_COMPILER:FILEPATH=$ENV{CC}" - "-DCMAKE_Fortran_COMPILER:FILEPATH=$ENV{FC}" - ) - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/parameterized/UMFPACK_Settings.cmake b/cmake/ctest/drivers/parameterized/UMFPACK_Settings.cmake deleted file mode 100644 index 73b772ee6a37..000000000000 --- a/cmake/ctest/drivers/parameterized/UMFPACK_Settings.cmake +++ /dev/null @@ -1,22 +0,0 @@ - -SET(TPL_ENABLE_AMD "ON" CACHE BOOL ) -SET(AMD_LIBRARY_NAMES "amd" CACHE STRING ) - -SET(AMD_INCLUDE_DIRS CACHE PATH - "$ENV{WORKSPACE}/SuiteSparse/AMD/Include" - "$ENV{WORKSPACE}/SuiteSparse/UFconfig" ) -SET(AMD_LIBRARY_DIRS - "$ENV{WORKSPACE}/SuiteSparse/AMD/Lib" ) - -SET(TPL_ENABLE_UMFPACK "ON" CACHE BOOL ) -SET(UMFPACK_LIBRARY_NAMES - "umfpack" "amd" - CACHE STRING) - -SET(UMFPACK_INCLUDE_DIRS - "$ENV{WORKSPACE}/SuiteSparse/UMFPACK/Include" - "$ENV{WORKSPACE}/SuiteSparse/AMD/Include" - "$ENV{WORKSPACE}/SuiteSparse/UFconfig" ) -SET(UMFPACK_LIBRARY_DIRS - "$ENV{WORKSPACE}/SuiteSparse/UMFPACK/Lib" - "$ENV{WORKSPACE}/SuiteSparse/AMD/Lib" ) diff --git a/cmake/ctest/drivers/parameterized/ctest_linux_nightly_generic.cmake b/cmake/ctest/drivers/parameterized/ctest_linux_nightly_generic.cmake deleted file mode 100644 index 7bd78e5a4a8c..000000000000 --- a/cmake/ctest/drivers/parameterized/ctest_linux_nightly_generic.cmake +++ /dev/null @@ -1,165 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.generic.cmake") - -# -# Set the options specific to this build case -# -SET(COMM_TYPE $ENV{JENKINS_COMM_TYPE}) -SET(BUILD_TYPE $ENV{JENKINS_BUILD_TYPE}) - - -STRING(REPLACE "sems-" "" COMPILER_DIR $ENV{COMPILER_MODULE}) -STRING(REPLACE "/" "_" COMPILER_DIR ${COMPILER_DIR}) - - -SET(COMM_DIR "") -IF(COMM_TYPE STREQUAL MPI) - STRING(REPLACE "sems-" "" COMM_DIR $ENV{MPI_MODULE}) - STRING(REPLACE "/" "_" COMM_DIR ${COMM_DIR}) -ENDIF() - - -# If JENKINS_BUILD_TAG is nonempty, prepend an underscore to it, otherwise leave -# it blank. If JENKINS_BUILD_TAG doesn't exist, it shoud be set to empty. -SET(BUILD_TAG "$ENV{JENKINS_BUILD_TAG}") -IF(BUILD_TAG) - # You'd think we could just use "^_*" as the pattern and "_" as the replace - # but CMake isn't happy with that. - STRING(REGEX REPLACE "^_+" "" BUILD_TAG ${BUILD_TAG}) - SET(BUILD_TAG "_${BUILD_TAG}") -ENDIF() - - -# Get the Jenkins Environment variable, if it exists, containing extra parameters -# for EXTRA_CONFIGURE_OPTIONS -# The string should come in like looking like this: -# '"-DTrilinos_ENABLE_FOO:BOOL=ON" "-DTrilinos_ENABLE_BAR:BOOL=ON"' -# -SET(JENKINS_EXTRA_CONFIGURE_OPTIONS "$ENV{JENKINS_Trilinos_EXTRA_CONFIGURE_OPTIONS}") -IF(JENKINS_EXTRA_CONFIGURE_OPTIONS) - MESSAGE(STATUS "JENKINS_Trilinos_EXTRA_CONFIGURE_OPTIONS: ${JENKINS_EXTRA_CONFIGURE_OPTIONS}") - - # Strip leading and trailing whitespace - STRING(STRIP "${JENKINS_EXTRA_CONFIGURE_OPTIONS}" JENKINS_EXTRA_CONFIGURE_OPTIONS) - - # There should just be one leading and trailing '"' character, - # But when JENKINS_EXTRA_CONFIGURE_OPTIONS is added to EXTRA_CONFIGURE_OPTIONS - # CMake is adding in an extra quotation by the time this gets to the command line. - # So let's strip off the leading and trailing quotation from the string itself. - STRING(REGEX REPLACE "^\"+" "" JENKINS_EXTRA_CONFIGURE_OPTIONS ${JENKINS_EXTRA_CONFIGURE_OPTIONS}) - STRING(REGEX REPLACE "\"+$" "" JENKINS_EXTRA_CONFIGURE_OPTIONS ${JENKINS_EXTRA_CONFIGURE_OPTIONS}) -ENDIF() - -# Debugging Messages -# MESSAGE("") -# MESSAGE("---") -# MESSAGE("--- ENV:JENKINS_EXTRA_CONFIGURE_OPTIONS: '$ENV{JENKINS_Trilinos_EXTRA_CONFIGURE_OPTIONS}'") -# MESSAGE("--- JENKINS_EXTRA_CONFIGURE_OPTIONS....: '${JENKINS_EXTRA_CONFIGURE_OPTIONS}'") -# MESSAGE("--- BUILD_TAG..........................: '${BUILD_TAG}'") -# MESSAGE("---") - -# Set the build name of the job (this is reported to CDash as the job name) -SET(BUILD_DIR_NAME ${COMM_TYPE}_${BUILD_TYPE}_${COMPILER_DIR}_${COMM_DIR}${BUILD_TAG}_DEV) - -SET(CTEST_PARALLEL_LEVEL 16) - - -# Note: CTEST_TEST_TYPE drives some side-effects in Tribits that should be -# taken into account. If CTEST_TEST_TYPE is Experimental, Tribits will -# override Trilinos_TRACK and *always* assign results to the Experimental -# track on CDash. Also, Tribits does different things based on CTEST_TEST_TYPE -# being one of the 3 blessed types (Nightly, Continuous, Experimental), so it's -# best to keep CTEST_TEST_TYPE one of these values. -SET(CTEST_TEST_TYPE Nightly) -SET(Trilinos_TRACK $ENV{JENKINS_JOB_TYPE}) - - -SET(CTEST_TEST_TIMEOUT 900) - - -SET(EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_SuperLU:BOOL=ON" - "-DTPL_ENABLE_Netcdf:BOOL=ON" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DTPL_ENABLE_BoostLib:BOOL=ON" - "-DTPL_ENABLE_Zlib:BOOL=ON" - - "-DMueLu_INST_DOUBLE_INT_LONGINT:BOOL=ON" - "-DTPL_ENABLE_Matio:BOOL=OFF" - - # wcmclen: 2017-07-10: Disabling tests Anasazi_Epetra_OrthoManagerGenTester_1_MPI_4 and - # Anasazi_Epetra_ModalSolversTester_MPI_4 due to unstable behaviour - # in testing. Heidi has been looking into it but it appears that - # it's not an easy fix. - # Reference: Trilinos issue #1393 (https://github.com/trilinos/Trilinos/issues/1393) - "-DAnasazi_Epetra_ModalSolversTester_MPI_4_DISABLE:BOOL=ON" - "-DAnasazi_Epetra_OrthoManagerGenTester_0_MPI_4_DISABLE:BOOL=ON" - "-DAnasazi_Epetra_OrthoManagerGenTester_1_MPI_4_DISABLE:BOOL=ON" - - # Append extra options from the Jenkins parameter JENKINS_EXTRA_CONFIGURE_OPTIONS - ${JENKINS_EXTRA_CONFIGURE_OPTIONS} -) - -#"-DMPI_EXEC_POST_NUMPROCS_FLAGS:STRING=-bind-to;socket;--map-by;socket" -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/parameterized/ctest_linux_nightly_generic_kokkos.cmake b/cmake/ctest/drivers/parameterized/ctest_linux_nightly_generic_kokkos.cmake deleted file mode 100644 index 713c5367caea..000000000000 --- a/cmake/ctest/drivers/parameterized/ctest_linux_nightly_generic_kokkos.cmake +++ /dev/null @@ -1,98 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.generic.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE $ENV{JENKINS_COMM_TYPE}) -SET(BUILD_TYPE $ENV{JENKINS_BUILD_TYPE}) -SET(BUILD_DIR_NAME ${COMM_TYPE}_${BUILD_TYPE}_DEV_ETI_SERIAL-$ENV{JENKINS_DO_SERIAL}_OPENMP-$ENV{JENKINS_DO_OPENMP}_PTHREAD-$ENV{JENKINS_DO_PTHREAD}_CUDA-$ENV{JENKINS_DO_CUDA}_COMPLEX-$ENV{JENKINS_DO_COMPLEX}) -SET(CTEST_PARALLEL_LEVEL 1) -SET(CTEST_TEST_TYPE $ENV{JENKINS_JOB_TYPE}) -SET(CTEST_TEST_TIMEOUT 900) - -#SET(Trilinos_PACKAGES Kokkos Tpetra Belos Ifpack2 MueLu Amesos Amesos2 Ifpack Epetra EpetraExt Zoltan Zoltan2 Xpetra Panzer Intrepid STK Seacas Anasazi Phalanx Sacado Stokhos Shylu Stratimikos Thyra) - -SET(EXTRA_CONFIGURE_OPTIONS - "-DTPL_ENABLE_SuperLU=OFF" - - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTeuchos_ENABLE_COMPLEX:BOOL=$ENV{JENKINS_DO_COMPLEX}" - "-DTrilinos_ENABLE_OpenMP:BOOL=$ENV{JENKINS_DO_OPENMP}" - "-DTPL_ENABLE_HWLOC:STRING=OFF" - "-DTPL_ENABLE_CUDA:STRING=$ENV{JENKINS_DO_CUDA}" - - "-DKokkos_ENABLE_Pthreadi:BOOL=$ENV{JENKINS_DO_PTHREAD}" - "-DKokkos_ENABLE_Cuda_UVM:BOOL=$ENV{JENKINS_DO_CUDA}" - - "-DTpetra_INST_SERIAL:BOOL=$ENV{JENKINS_DO_SERIAL}" - "-DTpetra_INST_OPENMP:BOOL=$ENV{JENKINS_DO_OPENMP}" - "-DTpetra_INST_PTHREAD:BOOL=$ENV{JENKINS_DO_PTHREAD}" - "-DTpetra_INST_CUDA:BOOL=$ENV{JENKINS_DO_CUDA}" - "-DTpetra_INST_COMPLEX_DOUBLE:BOOL=$ENV{JENKINS_DO_COMPLEX}" - "-DMueLu_INST_DOUBLE_INT_LONGINT:BOOL=ON" - -) - -#"-DMPI_EXEC_POST_NUMPROCS_FLAGS:STRING=-bind-to;socket;--map-by;socket" -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/parameterized/ctest_linux_nightly_generic_sierra.cmake b/cmake/ctest/drivers/parameterized/ctest_linux_nightly_generic_sierra.cmake deleted file mode 100644 index 0ac83981f6b4..000000000000 --- a/cmake/ctest/drivers/parameterized/ctest_linux_nightly_generic_sierra.cmake +++ /dev/null @@ -1,165 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.generic.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE $ENV{JENKINS_COMM_TYPE}) -SET(BUILD_TYPE $ENV{JENKINS_BUILD_TYPE}) -SET(BUILD_DIR_NAME Sierra_${COMM_TYPE}_${BUILD_TYPE}_DEV_ETI_SERIAL-$ENV{JENKINS_DO_SERIAL}_OPENMP-$ENV{JENKINS_DO_OPENMP}_PTHREAD-$ENV{JENKINS_DO_PTHREAD}_CUDA-$ENV{JENKINS_DO_CUDA}_COMPLEX-$ENV{JENKINS_DO_COMPLEX}) -SET(CTEST_PARALLEL_LEVEL 16) - -# Note: CTEST_TEST_TYPE drives some side-effects in Tribits that should be -# taken into account. If CTEST_TEST_TYPE is Experimental, Tribits will -# override Trilinos_TRACK and *always* assign results to the Experimental -# track on CDash. Also, Tribits does different things based on CTEST_TEST_TYPE -# being one of the 3 blessed types (Nightly, Continuous, Experimental), so it's -# best to keep CTEST_TEST_TYPE one of these values. -SET(CTEST_TEST_TYPE Nightly) -SET(Trilinos_TRACK $ENV{JENKINS_JOB_TYPE}) - -SET(CTEST_TEST_TIMEOUT 900) -# SET(CTEST_DO_SUBMIT FALSE) - -SET(Trilinos_PACKAGES Amesos Amesos2 Anasazi AztecOO Belos Epetra EpetraExt FEI Ifpack Ifpack2 Intrepid Kokkos ML MueLu NOX Pamgen RTOp Sacado Shards Teuchos Thyra Tpetra TrilinosSS Triutils Xpetra Zoltan Zoltan2) - -SET(EXTRA_EXCLUDE_PACKAGES Galeri Intrepid2 Isorropia Stratimikos Teko SEACAS STK) - -SET(EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_ALL_OPTIONAL_PACKAGES:BOOL=OFF" - "-DTPL_ENABLE_SuperLU=OFF" - - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTeuchos_ENABLE_COMPLEX:BOOL=$ENV{JENKINS_DO_COMPLEX}" - "-DTrilinos_ENABLE_OpenMP:BOOL=$ENV{JENKINS_DO_OPENMP}" - "-DTPL_ENABLE_HWLOC:STRING=OFF" - "-DTPL_ENABLE_CUDA:STRING=$ENV{JENKINS_DO_CUDA}" - - "-DFEI_AZTECOO:BOOL=ON" - "-DTrilinos_ENABLE_AztecOO:BOOL=ON" - - "-DTrilinos_ENABLE_EpetraExt:BOOL=ON" - - "-DKokkos_ENABLE_Pthread:BOOL=$ENV{JENKINS_DO_PTHREAD}" - "-DKokkos_ENABLE_Cuda_UVM:BOOL=$ENV{JENKINS_DO_CUDA}" - "-DKokkos_ENABLE_OpenMP:BOOL=$ENV{JENKINS_DO_OPENMP}" - - "-DMETIS_INCLUDE_DIRS=$ENV{SEMS_PARMETIS_INCLUDE_PATH}" - "-DMETIS_LIBRARY_DIRS=$ENV{SEMS_PARMETIS_LIBRARY_PATH}" - - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_THYRA:BOOL=OFF" - "-DNOX_ENABLE_EPETRA:BOOL=ON" - - "-DTpetra_INST_SERIAL:BOOL=$ENV{JENKINS_DO_SERIAL}" - "-DTpetra_INST_OPENMP:BOOL=$ENV{JENKINS_DO_OPENMP}" - "-DTpetra_INST_PTHREAD:BOOL=$ENV{JENKINS_DO_PTHREAD}" - "-DTpetra_INST_CUDA:BOOL=$ENV{JENKINS_DO_CUDA}" - "-DTrilinos_ENABLE_COMPLEX_DOUBLE:BOOL=$ENV{JENKINS_DO_COMPLEX}" - "-DTpetra_INST_COMPLEX_FLOAT:BOOL=OFF" - "-DTpetra_INST_INT_INT:BOOL=ON" - "-DTpetra_INST_INT_LONG:BOOL=ON" - "-DTpetra_INST_INT_LONG_LONG:BOOL=OFF" - "-DTpetra_INST_FLOAT:BOOL=OFF" - "-DTpetra_INST_DOUBLE:BOOL=ON" - "-DTpetraCore_ENABLE_TSQR:BOOL=ON" - "-DTpetra_HIDE_DEPRECATED_CODE:BOOL=ON" - "-DTrilinos_ENABLE_TpetraTSQR:BOOL=ON" - "-DTrilinos_ENABLE_Tpetra:BOOL=ON" - -"DKokkos_ENABLE_Cuda_Lambda:BOOL=$ENV{JENKINS_DO_COMPLEX}" - - "-DMueLu_ENABLE_Epetra=OFF" - "-DMueLu_ENABLE_Tpetra=ON" - - "-DAmesos2_ENABLE_Epetra=OFF" - "-DAmesos2_CONFIGURE_OPTIONS_FILE:FILEPATH=cmake/ctest/drivers/parameterized/UMFPACK_Settings.cmake" - - "-DCMAKE_CXX_FLAGS:STRING=$ENV{JENKINS_CXX_FLAGS}" - "-DCMAKE_C_FLAGS:STRING=$ENV{JENKINS_C_FLAGS}" - "-DCMAKE_Fortran_FLAGS=$ENV{JENKINS_Fortran_FLAGS}" - - "-DTrilinos_C_Standard=gnu11" - -) - -IF (DEFINED ENV{JENKINS_BLAS_LIBRARY_DIRS}) - SET(EXTRA_CONFIGURE_OPTIONS ${EXTRA_CONFIGURE_OPTIONS} - "-DBLAS_LIBRARY_DIRS=$ENV{JENKINS_BLAS_LIBRARY_DIRS}") -ENDIF() - -IF (DEFINED ENV{JENKINS_LAPACK_LIBRARY_DIRS}) - SET(EXTRA_CONFIGURE_OPTIONS ${EXTRA_CONFIGURE_OPTIONS} - "-DLAPACK_LIBRARY_DIRS=$ENV{JENKINS_LAPACK_LIBRARY_DIRS}") -ENDIF() - -IF (DEFINED ENV{JENKINS_CMAKE_EXE_LINKER_FLAGS}) - SET(EXTRA_CONFIGURE_OPTIONS ${EXTRA_CONFIGURE_OPTIONS} - "-DTrilinos_EXTRA_LINK_FLAGS=$ENV{JENKINS_CMAKE_EXE_LINKER_FLAGS}") -ENDIF() - -IF (DEFINED ENV{JENKINS_CMAKE_DISABLE_MPI_WRAPPER}) - SET(EXTRA_CONFIGURE_OPTIONS ${EXTRA_CONFIGURE_OPTIONS} - "-DMPI_USE_COMPILER_WRAPPERS=OFF") -ENDIF() - -#"-DMPI_EXEC_POST_NUMPROCS_FLAGS:STRING=-bind-to;socket;--map-by;socket" -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/perseus/CMakeLists.txt b/cmake/ctest/drivers/perseus/CMakeLists.txt deleted file mode 100644 index 22986c246b2b..000000000000 --- a/cmake/ctest/drivers/perseus/CMakeLists.txt +++ /dev/null @@ -1,11 +0,0 @@ -TRILINOS_DRIVER_SETUP() - -TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_Downstream_ETI_SERIAL-${Tpetra_INST_SERIAL}_OPENMP-${Tpetra_INST_OPENMP}_PTHREAD-${Tpetra_INST_PTHREAD}_CUDA-${Tpetra_INST_CUDA}_COMPLEX-${Teuchos_ENABLE_COMPLEX} - ctest_linux_nightly_mpi_release_downstream_ETI_generic_perseus.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 420 -) - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/perseus/TrilinosCTestDriverCore.perseus.generic.cmake b/cmake/ctest/drivers/perseus/TrilinosCTestDriverCore.perseus.generic.cmake deleted file mode 100644 index 29ea0042a302..000000000000 --- a/cmake/ctest/drivers/perseus/TrilinosCTestDriverCore.perseus.generic.cmake +++ /dev/null @@ -1,129 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for typhon using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j16 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "1" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENDENCY_UNIT_TESTS:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=ON" - - "-D Trilinos_ENABLE_CXX11=ON" - "-D Trilinos_CXX11_FLAGS:STRING=--std=c++11" - - "-DTPL_ENABLE_BLAS:BOOL=ON" - "-DTPL_ENABLE_LAPACK:BOOL=ON" - "-DSuperLU_INCLUDE_DIRS:PATH=$ENV{SEMS_SUPERLU_INCLUDE_PATH}" - "-DSuperLU_LIBRARY_DIRS:PATH=$ENV{SEMS_SUPERLU_LIBRARY_PATH}" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu" - "-DBoost_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_BOOST_INCLUDE_PATH}" - "-DBoost_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_BOOST_LIBRARY_PATH}" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_BOOST_INCLUDE_PATH}" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_BOOST_LIBRARY_PATH}" - "-DHDF5_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_HDF5_INCLUDE_PATH}" - "-DHDF5_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_HDF5_LIBRARY_PATH}" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_NETCDF_INCLUDE_PATH}" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_NETCDF_LIBRARY_PATH}" - "-DZlib_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_ZLIB_INCLUDE_PATH}" - "-DZlib_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_ZLIB_LIBRARY_PATH}" - "-DTPL_ENABLE_X11:BOOL=OFF" - - ) - - SET_DEFAULT(COMPILER_VERSION "$ENV{SEMS_COMPILER_NAME}-$ENV{SEMS_COMPILER_VERSION}") - - #Ensuring that MPI is on for all parallel builds that might be run. - IF(COMM_TYPE STREQUAL MPI) - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR=$ENV{SEMS_OPENMPI_ROOT}" - "-D MPI_CXX_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicxx" - "-D MPI_C_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicc" - "-D MPI_FORTRAN_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpifort" - "-D CMAKE_CXX_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicxx" - "-D CMAKE_C_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicc" - "-D CMAKE_FORTRAN_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpifort" - "-D MPI_EXEC:FILEPATH=${MPI_BASE_DIR}/bin/mpirun" - "-DMPI_EXEC_POST_NUMPROCS_FLAGS:STRING=--bind-to-socket" - - ) - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/perseus/TrilinosCTestDriverCore.perseus.jenkins.cmake b/cmake/ctest/drivers/perseus/TrilinosCTestDriverCore.perseus.jenkins.cmake deleted file mode 100644 index 015cf0c001d1..000000000000 --- a/cmake/ctest/drivers/perseus/TrilinosCTestDriverCore.perseus.jenkins.cmake +++ /dev/null @@ -1,123 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for typhon using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET(Trilinos_REPOSITORY_LOCATION "$ENV{WORKSPACE}/Trilinos") - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j8 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "1" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENDENCY_UNIT_TESTS:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=ON" - - "-DMPI_BASE_DIR=$ENV{SEMS_OPENMPI_ROOT}" - "-D MPI_CXX_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicxx" - "-D MPI_C_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicc" - "-D MPI_FORTRAN_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpifort" - "-D CMAKE_CXX_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicxx" - "-D CMAKE_C_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpicc" - "-D CMAKE_FORTRAN_COMPILER:FILEPATH=${MPI_BASE_DIR}/bin/mpifort" - "-D MPI_EXEC:FILEPATH=${MPI_PATH}/bin/mpirun" - "-D MPI_EXEC_POST_NUMPROCS_FLAGS:STRING=-bind-to-socket" - - "-DTPL_ENABLE_BLAS:BOOL=ON" - "-DTPL_ENABLE_LAPACK:BOOL=ON" - "-DTPL_SuperLU_LIBRARIES=${SEMS_SUPERLU_LIBRARY_PATH}/libsuperlu.a" - "-DTPL_SuperLU_INCLUDE_DIRS=$SEMS_SUPERLU_INCLUDE_PATH" - "-DTPL_ENABLE_X11:BOOL=OFF" - - - "-DCUDA_TOOLKIT_ROOT_DIR=$ENV{CUDA_ROOT}" - ) - - IF ($ENV{SEMS_COMPILER_NAME} STREQUAL gcc) - SET_DEFAULT(COMPILER_VERSION "GCC-$ENV{SEMS_COMPILER_VERSION}") - ELSE () - SET_DEFAULT(COMPILER_VERSION "Intel-$ENV{SEMS_COMPILER_VERSION}") - ENDIF() - - #Ensuring that MPI is on for all parallel builds that might be run. - IF(COMM_TYPE STREQUAL MPI) - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - ) - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/perseus/cron_driver.sh b/cmake/ctest/drivers/perseus/cron_driver.sh deleted file mode 100755 index 224aaa119eda..000000000000 --- a/cmake/ctest/drivers/perseus/cron_driver.sh +++ /dev/null @@ -1,67 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on typhon: `date`" -echo - -# -# TrilinosDriver settings: -# - -export TDD_PARALLEL_LEVEL=1 - -# Trilinos settings: -# - -# Submission mode for the *TrilinosDriver* dashboard -export TDD_CTEST_TEST_TYPE=${JENKINS_JOB_TYPE} - -#export CTEST_DO_SUBMIT=FALSE -#export CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=FALSE - -# Machine specific environment -# -source /projects/sems/modulefiles/utils/sems-modules-init.sh -module purge -module load sems-env -module load kokkos-env - -module load sems-python/2.7.9 -module load sems-cmake/3.10.3 -module load sems-git/2.1.3 -module load sems-${COMPILER_SUFFIX} - -export TRIBITS_TDD_USE_SYSTEM_CTEST=1 -export TDD_HTTP_PROXY="http://sonproxy.sandia.gov:80" -export http_proxy="http://sonproxy.sandia.gov:80" -export CUDA_LAUNCH_BLOCKING=1 -export CUDA_MANAGED_FORCE_DEVICE_ALLOC=1 -export OMP_NUM_THREADS=2 -export OMP_PROC_BIND=false - -# Machine independent cron_driver: -# -#openmpi-1.7-cuda6 - -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` - -if [ "${JENKINS_DO_CUDA}" == 'ON' ]; then - module load kokkos-${CUDA_SUFFIX} - module load kokkos-${MPI_SUFFIX}/cuda - export OMPI_CXX=$WORKSPACE/Trilinos/packages/kokkos/config/nvcc_wrapper -else - module load sems-${MPI_SUFFIX} -fi - -module load sems-${BOOST_SUFFIX}/base -module load sems-${HDF5_SUFFIX}/parallel -module load sems-${NETCDF_SUFFIX}/parallel -module load sems-${ZLIB_SUFFIX}/base - -module list - -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on typhon: `date`" -echo diff --git a/cmake/ctest/drivers/perseus/ctest_linux_nightly_mpi_debug_muelu_extratypes_ei_negima_jenkins.cmake b/cmake/ctest/drivers/perseus/ctest_linux_nightly_mpi_debug_muelu_extratypes_ei_negima_jenkins.cmake deleted file mode 100644 index 8d253a322d58..000000000000 --- a/cmake/ctest/drivers/perseus/ctest_linux_nightly_mpi_debug_muelu_extratypes_ei_negima_jenkins.cmake +++ /dev/null @@ -1,84 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.perseus.jenkins.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME OPENMPI_1.8.7_DEBUG_DEV_MueLu_ExtraTypes_EI_WITH_KOKKOS_$ENV{KOKKOS_BRANCH}) -SET(CTEST_PARALLEL_LEVEL 8) -SET(CTEST_TEST_TYPE Nightly) -SET(CTEST_TEST_TIMEOUT 1800) - -SET(Trilinos_PACKAGES MueLu Xpetra Amesos2) - -SET(EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTpetra_ENABLE_INT_LONG_LONG:BOOL=ON" - - "-DZoltan2_ENABLE_Experimental:BOOL=ON" - "-DTPL_ENABLE_SuperLU:BOOL=ON" -) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/perseus/ctest_linux_nightly_mpi_release_downstream_ETI_generic_perseus.cmake b/cmake/ctest/drivers/perseus/ctest_linux_nightly_mpi_release_downstream_ETI_generic_perseus.cmake deleted file mode 100644 index 707050405085..000000000000 --- a/cmake/ctest/drivers/perseus/ctest_linux_nightly_mpi_release_downstream_ETI_generic_perseus.cmake +++ /dev/null @@ -1,98 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.perseus.generic.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_RELEASE_DEV_DownStream_ETI_SERIAL-$ENV{JENKINS_DO_SERIAL}_OPENMP-$ENV{JENKINS_DO_OPENMP}_PTHREAD-$ENV{JENKINS_DO_PTHREAD}_CUDA-$ENV{JENKINS_DO_CUDA}_COMPLEX-$ENV{JENKINS_DO_COMPLEX}) -SET(CTEST_PARALLEL_LEVEL 1) -SET(CTEST_TEST_TYPE $ENV{JENKINS_JOB_TYPE}) -SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_PACKAGES Kokkos Tpetra Belos Ifpack2 MueLu Amesos Amesos2 Ifpack Epetra EpetraExt Zoltan Zoltan2 Xpetra Panzer Intrepid STK Seacas Anasazi Phalanx Sacado Stokhos Shylu Stratimikos Thyra) - -SET(EXTRA_CONFIGURE_OPTIONS - "-DTPL_ENABLE_SuperLU=OFF" - - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTeuchos_ENABLE_COMPLEX:BOOL=$ENV{JENKINS_DO_COMPLEX}" - "-DTrilinos_ENABLE_OpenMP:BOOL=$ENV{JENKINS_DO_OPENMP}" - "-DTPL_ENABLE_HWLOC:STRING=OFF" - "-DTPL_ENABLE_CUDA:STRING=$ENV{JENKINS_DO_CUDA}" - - "-DKokkos_ENABLE_Pthread:BOOL=$ENV{JENKINS_DO_PTHREAD}" - "-DKokkos_ENABLE_Cuda_UVM:BOOL=$ENV{JENKINS_DO_CUDA}" - - "-DTpetra_INST_SERIAL:BOOL=$ENV{JENKINS_DO_SERIAL}" - "-DTpetra_INST_OPENMP:BOOL=$ENV{JENKINS_DO_OPENMP}" - "-DTpetra_INST_PTHREAD:BOOL=$ENV{JENKINS_DO_PTHREAD}" - "-DTpetra_INST_CUDA:BOOL=$ENV{JENKINS_DO_CUDA}" - "-D Tpetra_INST_COMPLEX_DOUBLE:BOOL=$ENV{JENKINS_DO_COMPLEX}" - "-D MueLu_INST_DOUBLE_INT_LONGINT:BOOL=ON" - -) - -#"-DMPI_EXEC_POST_NUMPROCS_FLAGS:STRING=-bind-to;socket;--map-by;socket" -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/perseus/jenkins_driver.sh b/cmake/ctest/drivers/perseus/jenkins_driver.sh deleted file mode 100755 index 51cdc1aaab1b..000000000000 --- a/cmake/ctest/drivers/perseus/jenkins_driver.sh +++ /dev/null @@ -1,81 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on typhon: `date`" -echo - -# snapshot_kokkos_into_trilinos -snapshot_kokkos_into_trilinos() { - cd $WORKSPACE/Trilinos && git reset --hard HEAD && cd - - cd $WORKSPACE/kokkos && git reset --hard origin/$1 && cd - - $WORKSPACE/kokkos/config/snapshot.py -n $WORKSPACE/kokkos $WORKSPACE/Trilinos/packages || { echo "SNAPSHOT FAILED!" && exit 1; } - export KOKKOS_BRANCH=$1 -} - -# -# TrilinosDriver settings: -# - -export TDD_PARALLEL_LEVEL=2 - -# Trilinos settings: -# - -# Submission mode for the *TrilinosDriver* dashboard -export TDD_CTEST_TEST_TYPE=Nightly -export TRIBITS_TDD_USE_SYSTEM_CTEST=1 - -#export CTEST_DO_SUBMIT=FALSE -#export CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=FALSE - -# Machine specific environment -# - -source /projects/modulefiles/utils/sems-modules-init.sh -source /projects/modulefiles/utils/kokkos-modules-init.sh - -module load python/2.7.9 -module load cuda/6.5.14 -module load cmake/2.8.11 -module load git - -export FROM_JENKINS=1 -export TDD_HTTP_PROXY="http://sonproxy.sandia.gov:80" -export http_proxy="http://sonproxy.sandia.gov:80" -export CUDA_LAUNCH_BLOCKING=1 -export OMP_NUM_THREADS=2 - -# Machine independent cron_driver: -# -#openmpi-1.7-cuda6 - -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` - -module load intel/15.0.2/openmpi/1.8.7/cuda/6.5.14 -module load superlu/4.3/intel/15.0.2/base - -export KOKKOS_BRANCH=master -$SCRIPT_DIR/../cron_driver.py - -snapshot_kokkos_into_trilinos develop -$SCRIPT_DIR/../cron_driver.py - -# module unload intel/15.0.2/openmpi/1.8.7/cuda/6.5.14 -# module unload superlu/4.3/intel/15.0.2/base - -# module load gcc/4.8.4/openmpi/1.8.7/cuda/6.5.14 -# module load superlu/4.3/gcc/4.8.4/base - -# cd $WORKSPACE/Trilinos && git reset --hard HEAD && cd - -# $SCRIPT_DIR/../cron_driver.py - -# snapshot_kokkos_into_trilinos develop -# $SCRIPT_DIR/../cron_driver.py - -git status - -cd $WORKSPACE/Trilinos && git reset --hard HEAD && cd - - -echo -echo "Ending nightly Trilinos development testing on typhon: `date`" -echo diff --git a/cmake/ctest/drivers/pu241/CMakeLists.txt b/cmake/ctest/drivers/pu241/CMakeLists.txt deleted file mode 100644 index 06863e48e799..000000000000 --- a/cmake/ctest/drivers/pu241/CMakeLists.txt +++ /dev/null @@ -1,44 +0,0 @@ -# pu241 driver - -TRILINOS_DRIVER_SETUP() - -# ToDo: I think we can remove these two variables -set(CTEST_EXE "${CMAKE_CTEST_COMMAND}") -set(workingdir "${TrilinosDriver_BINARY_DIR}") - -# Get the day of the week -execute_process(COMMAND date +%A OUTPUT_VARIABLE DAYOFWEEK) - -if(${DAYOFWEEK} MATCHES "Saturday") - set(RUN_REGULAR_TESTS ON) -elseif(${DAYOFWEEK} MATCHES "Sunday") - set(RUN_REGULAR_TESTS ON) -else() - set(RUN_REGULAR_TESTS ON) -endif() - -SET(TIMEOUT_MINUTES 360) # 6 hours - -IF (RUN_REGULAR_TESTS) - - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_DEBUG_GCC - ctest_linux_nightly_mpi_debug_gcc_4.6.1_trilinos.cmake - TIMEOUT_MINUTES ${TIMEOUT_MINUTES} - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_RELEASE_GCC - ctest_linux_nightly_mpi_release_gcc_4.6.1_trilinos.cmake - TIMEOUT_MINUTES ${TIMEOUT_MINUTES} - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_RELEASE_GCC - ctest_linux_nightly_serial_release_gcc_4.6.1_trilinos.cmake - TIMEOUT_MINUTES ${TIMEOUT_MINUTES} - ) - -ENDIF (RUN_REGULAR_TESTS) - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/pu241/ExtraRepositoriesList.cmake b/cmake/ctest/drivers/pu241/ExtraRepositoriesList.cmake deleted file mode 100644 index 8972b5b66180..000000000000 --- a/cmake/ctest/drivers/pu241/ExtraRepositoriesList.cmake +++ /dev/null @@ -1,9 +0,0 @@ -# -# List of extra external repositories for Trilinos related to CASL VERA -# - -SET( Trilinos_EXTRAREPOS_DIR_REPOTYPE_REPOURL_PACKSTAT_CATEGORY - TeuchosWrappersExt "" GIT casl-dev.ornl.gov:/git-root/TeuchosWrappersExt "" Continuous - Dakota packages/TriKota/Dakota GIT - casl-dev.ornl.gov:/git-root/Dakota NOPACKAGES Continuous - ) diff --git a/cmake/ctest/drivers/pu241/SubmitToTrilinos.cmake b/cmake/ctest/drivers/pu241/SubmitToTrilinos.cmake deleted file mode 100644 index b2c9140b6b27..000000000000 --- a/cmake/ctest/drivers/pu241/SubmitToTrilinos.cmake +++ /dev/null @@ -1,9 +0,0 @@ -# Sumbit to Trilinos CDash server on casl-dev until can -# address VRI Kanban story #2404 -#SET_DEFAULT(CTEST_DROP_SITE "casl-dev.ornl.gov") -SET_DEFAULT(CTEST_DROP_SITE "testing.sandia.gov") -SET_DEFAULT(CTEST_DROP_LOCATION "/cdash/submit.php?project=Trilinos") - -# Must overridde the Trilinos defaults to send to /extended/cdash -SET_DEFAULT(CTEST_DROP_SITE_COVERAGE ${CTEST_DROP_SITE}) -SET_DEFAULT(CTEST_DROP_LOCATION_COVERAGE ${CTEST_DROP_LOCATION}) diff --git a/cmake/ctest/drivers/pu241/TrilinosCTestDriverCore.pu241.gcc.4.5.1.cmake b/cmake/ctest/drivers/pu241/TrilinosCTestDriverCore.pu241.gcc.4.5.1.cmake deleted file mode 100644 index b3c4b3295ac0..000000000000 --- a/cmake/ctest/drivers/pu241/TrilinosCTestDriverCore.pu241.gcc.4.5.1.cmake +++ /dev/null @@ -1,56 +0,0 @@ -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/casl-exclude-trilinos-packages.cmake") - -# -# Platform/compiler specific options for godel using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j6 -i" ) - SET( CTEST_PARALLEL_LEVEL 6 ) - - #SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - #SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS ) - - SET_DEFAULT(Trilinos_ENABLE_KNOWN_EXTERNAL_REPOS_TYPE Nightly) - - IF (BUILD_TYPE STREQUAL DEBUG) - SET(BUILD_TYPE_OPTIONS_FILE gcc-4.5.1-debug-options.cmake) - ELSEIF (BUILD_TYPE STREQUAL RELEASE) - SET(BUILD_TYPE_OPTIONS_FILE gcc-4.5.1-release-options.cmake) - ELSE() - SET(BUILD_TYPE_OPTIONS_FILE) - ENDIF() - PRINT_VAR(BUILD_TYPE_OPTIONS_FILE) - - SET_DEFAULT(COMPILER_VERSION "GCC-4.5.1-IFORT-11.1.064") - - IF (COMM_TYPE STREQUAL MPI) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DTrilinos_CONFIGURE_OPTIONS_FILE:FILEPATH=${CTEST_SCRIPT_DIRECTORY}/gcc-4.5.1-mpi-ss-options.cmake,${CTEST_SCRIPT_DIRECTORY}/${BUILD_TYPE_OPTIONS_FILE}" - "-DTPL_ENABLE_MPI:BOOL=ON" - ${EXTRA_CONFIGURE_OPTIONS} - ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DTrilinos_CONFIGURE_OPTIONS_FILE:FILEPATH=${CTEST_SCRIPT_DIRECTORY}/gcc-4.5.1-serial-ss-options.cmake,${CTEST_SCRIPT_DIRECTORY}/${BUILD_TYPE_OPTIONS_FILE}" - "-DTPL_ENABLE_MPI:BOOL=OFF" - ${EXTRA_CONFIGURE_OPTIONS} - ) - - ENDIF() - - PRINT_VAR(EXTRA_SYSTEM_CONFIGURE_OPTIONS) - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/pu241/TrilinosCTestDriverCore.pu241.gcc.4.6.1.cmake b/cmake/ctest/drivers/pu241/TrilinosCTestDriverCore.pu241.gcc.4.6.1.cmake deleted file mode 100644 index 5aed5a3be073..000000000000 --- a/cmake/ctest/drivers/pu241/TrilinosCTestDriverCore.pu241.gcc.4.6.1.cmake +++ /dev/null @@ -1,61 +0,0 @@ -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/casl-exclude-trilinos-packages.cmake") - -# -# Platform/compiler specific options for godel using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j6 -i" ) - SET( CTEST_PARALLEL_LEVEL 6 ) - - SET( CTEST_MEMORYCHECK_COMMAND - /usr/bin/valgrind ) - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all" ) - - SET_DEFAULT(Trilinos_ENABLE_KNOWN_EXTERNAL_REPOS_TYPE Nightly) - - IF (BUILD_TYPE STREQUAL DEBUG) - SET(BUILD_TYPE_OPTIONS_FILE "${CTEST_SCRIPT_DIRECTORY}/gcc-4.6.1-debug-options.cmake") - ELSEIF (BUILD_TYPE STREQUAL RELEASE) - SET(BUILD_TYPE_OPTIONS_FILE "${CTEST_SCRIPT_DIRECTORY}/gcc-4.6.1-release-options.cmake") - ELSE() - SET(BUILD_TYPE_OPTIONS_FILE) - ENDIF() - PRINT_VAR(BUILD_TYPE_OPTIONS_FILE) - - SET(TPLS_FILE "${CTEST_SCRIPT_DIRECTORY}/trilinos-tpls-gcc.4.6.1.cmake") - - SET_DEFAULT(COMPILER_VERSION "GCC-4.6.1") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DTrilinos_CONFIGURE_OPTIONS_FILE:FILEPATH=${CTEST_SCRIPT_DIRECTORY}/gcc-4.6.1-mpi-ss-options.cmake,${BUILD_TYPE_OPTIONS_FILE},${TPLS_FILE}" - "-DTPL_ENABLE_MPI:BOOL=ON" - ${EXTRA_CONFIGURE_OPTIONS} - ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DTrilinos_CONFIGURE_OPTIONS_FILE:FILEPATH=${CTEST_SCRIPT_DIRECTORY}/gcc-4.6.1-serial-ss-options.cmake,${BUILD_TYPE_OPTIONS_FILE},${TPLS_FILE}" - "-DTPL_ENABLE_MPI:BOOL=OFF" - ${EXTRA_CONFIGURE_OPTIONS} - ) - - ENDIF() - - PRINT_VAR(EXTRA_SYSTEM_CONFIGURE_OPTIONS) - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/pu241/TrilinosCTestDriverCore.pu241.icpc.12.0.4.cmake b/cmake/ctest/drivers/pu241/TrilinosCTestDriverCore.pu241.icpc.12.0.4.cmake deleted file mode 100644 index a1eb8fdf7689..000000000000 --- a/cmake/ctest/drivers/pu241/TrilinosCTestDriverCore.pu241.icpc.12.0.4.cmake +++ /dev/null @@ -1,51 +0,0 @@ - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/casl-exclude-trilinos-packages.cmake") - -# -# Platform/compiler specific options for godel using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j6 -i" ) - SET( CTEST_PARALLEL_LEVEL 6 ) - - #SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - #SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS ) - - SET_DEFAULT(COMPILER_VERSION "ICPC-12.0.4") - - SET_DEFAULT(Trilinos_ENABLE_KNOWN_EXTERNAL_REPOS_TYPE Nightly) - - IF (BUILD_TYPE STREQUAL DEBUG) - SET(BUILD_TYPE_OPTIONS_FILE intel-12.0.4-serial-debug-ss-options.cmake) - ELSEIF (BUILD_TYPE STREQUAL RELEASE) - SET(BUILD_TYPE_OPTIONS_FILE intel-12.0.4-serial-release-ss-options.cmake) - ELSE() - SET(BUILD_TYPE_OPTIONS_FILE) - ENDIF() - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - MESSAGE(FATAL_ERROR "Error, Intel build does not support MPI yet!") - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DTrilinos_CONFIGURE_OPTIONS_FILE:FILEPATH=${CTEST_SCRIPT_DIRECTORY}/${BUILD_TYPE_OPTIONS_FILE}" - "-DTPL_ENABLE_MPI:BOOL=OFF" - ${EXTRA_CONFIGURE_OPTIONS} - ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/pu241/boost-1.46.1-options.cmake b/cmake/ctest/drivers/pu241/boost-1.46.1-options.cmake deleted file mode 100644 index dddeec165d04..000000000000 --- a/cmake/ctest/drivers/pu241/boost-1.46.1-options.cmake +++ /dev/null @@ -1,12 +0,0 @@ -# -# Set up TPL pointers for boost 1.46.1 -# - -SET(TPL_ENABLE_Boost ON CACHE BOOL "") -SET(Boost_INCLUDE_DIRS /opt/gcc-4.5.1/tpls/boost-1.46.1/include CACHE FILEPATH "") -SET(BoostLib_LIBRARY_NAMES "boost_thread;boost_program_options" CACHE STRING "") -SET(BoostLib_INCLUDE_DIRS ${Boost_INCLUDE_DIRS} CACHE FILEPATH "") -SET(BoostLib_LIBRARY_DIRS /opt/gcc-4.5.1/tpls/boost-1.46.1/lib CACHE FILEPATH "") - -# Must force this variable in the Dakota configure process -SET(BOOST_INCLUDEDIR ${Boost_INCLUDE_DIRS} CACHE PATH "" FORCE) diff --git a/cmake/ctest/drivers/pu241/boost-1.47.0-options.cmake b/cmake/ctest/drivers/pu241/boost-1.47.0-options.cmake deleted file mode 100644 index 216891fc9993..000000000000 --- a/cmake/ctest/drivers/pu241/boost-1.47.0-options.cmake +++ /dev/null @@ -1,14 +0,0 @@ -# -# Set up TPL pointers for boost 1.47.0 -# - -SET(BOOST_ROOT /opt/intel-11.1.064/tpls/boost-1.47.0) - -SET(TPL_ENABLE_Boost ON CACHE BOOL "") -SET(Boost_INCLUDE_DIRS ${BOOST_ROOT}/include CACHE FILEPATH "") -SET(BoostLib_LIBRARY_NAMES "boost_thread;boost_program_options" CACHE STRING "") -SET(BoostLib_INCLUDE_DIRS ${Boost_INCLUDE_DIRS} CACHE FILEPATH "") -SET(BoostLib_LIBRARY_DIRS ${BOOST_ROOT}/lib CACHE FILEPATH "") - -# Must force this variable in the Dakota configure process -SET(BOOST_INCLUDEDIR ${Boost_INCLUDE_DIRS} CACHE PATH "" FORCE) diff --git a/cmake/ctest/drivers/pu241/boost-1.49.0-options.cmake b/cmake/ctest/drivers/pu241/boost-1.49.0-options.cmake deleted file mode 100644 index 373fa6f68229..000000000000 --- a/cmake/ctest/drivers/pu241/boost-1.49.0-options.cmake +++ /dev/null @@ -1,13 +0,0 @@ -# -# Set up TPL pointers for boost 1.49.0 -# - -SET(BOOST_ROOT /opt/intel-12.0.8/tpls/boost-1.49.0) -SET(TPL_ENABLE_Boost ON CACHE BOOL "") -SET(Boost_INCLUDE_DIRS ${BOOST_ROOT}/include CACHE FILEPATH "") -SET(BoostLib_LIBRARY_NAMES "boost_thread;boost_program_options" CACHE STRING "") -SET(BoostLib_INCLUDE_DIRS ${Boost_INCLUDE_DIRS} CACHE FILEPATH "") -SET(BoostLib_LIBRARY_DIRS ${BOOST_ROOT}/lib CACHE FILEPATH "") - -# Must force this variable in the Dakota configure process -SET(BOOST_INCLUDEDIR ${Boost_INCLUDE_DIRS} CACHE PATH "" FORCE) diff --git a/cmake/ctest/drivers/pu241/casl-core-enables-disables.cmake b/cmake/ctest/drivers/pu241/casl-core-enables-disables.cmake deleted file mode 100644 index 7523f6252270..000000000000 --- a/cmake/ctest/drivers/pu241/casl-core-enables-disables.cmake +++ /dev/null @@ -1,64 +0,0 @@ -# -# This file is meant to be included in the configuration of Trilinos to -# disable packages and other critical varaibles internally. These excludes -# can be overwritten on the command line in the CMake cache. -# -# These options are set for *all* compilers for all builds so they have to be -# 100% general! -# - -# Must include first so that it defines ${PROJECT_NAME}_EXCLUDE_PACKAGES -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/casl-exclude-trilinos-packages.cmake) - -# Put in hard disables for excluded packages -FOREACH(EXCLUDED_PACKAGE ${${PROJECT_NAME}_EXCLUDE_PACKAGES}) - SET(${PROJECT_NAME}_ENABLE_${EXCLUDED_PACKAGE} OFF CACHE BOOL - "Disabled in casl-core-enables-disables.cmake") -ENDFOREACH() - -# We don't want or need HDF5 support in EpetraExt -SET(EpetraExt_ENABLE_HDF5 OFF CACHE BOOL - "Disabled in casl-core-enables-disables.cmake") - -# Turn off STK tests since they are constantly failing. NOTE: Since CASL is -# not developing on STK, only using it, this should not represent a big risk -# for STK or CASL. -SET(STK_ENABLE_TESTS OFF CACHE BOOL "Disabled in casl-core-enables-disables.cmake") -SET(STK_ENABLE_EXAMPLES OFF CACHE BOOL "Disabled in casl-core-enables-disables.cmake") - -# Turn off MPI support in SEACAS because it that triggers usage of paralllel -# NETCSF which we don't need for CASL (VRI Kanban #2823) -SET(SEACASExodus_ENABLE_MPI OFF CACHE BOOL "") - -# We don't have the Matio TPL for SEACAS -SET(TPL_ENABLE_Matio OFF CACHE BOOL "") - -# Use CMake when building Dakota, not autotools -SET(TriKota_ENABLE_DakotaCMake ON CACHE BOOL "") - -# Turn off this failing Rythmos test (see Trilinos bug 5485) -SET(Rythmos_ImplicitRK_ConvergenceTest_MPI_1_DISABLE TRUE) - -# Turn off failing ML tests (see Trilinos bug 5537) -SET(ML_Blackboard_MPI_4_DISABLE TRUE) -SET(ML_AdaptiveSA_MPI_4_DISABLE TRUE) - -# Turn off some failing Belos and Anasazi tests (see Trilinos bugs 5382 and 5383) -SET(Belos_Tpetra_MVOPTester_complex_test_MPI_4_DISABLE TRUE) -SET(Belos_Tpetra_MVOPTester_complex_test_DISABLE TRUE) -SET(Anasazi_Tpetra_MVOPTester_MPI_4_DISABLE TRUE) -SET(Anasazi_Tpetra_MVOPTester_DISABLE TRUE) - -# We don't want PETSC or HYPRE support in Trilinos in case of incompatible version -SET(EpetraExt_ENABLE_HYPRE OFF CACHE BOOL "") -SET(EpetraExt_ENABLE_PETSC OFF CACHE BOOL "") -SET(Ifpack_ENABLE_HYPRE OFF CACHE BOOL "") -SET(ML_ENABLE_PETSC OFF CACHE BOOL "") -SET(NOX_ENABLE_PETSC OFF CACHE BOOL "") - -# Don't allow Optika GUI tests since they just seem to work and are not tested -# (see discussion in commit message). -SET(Optika_DO_GUI_UNIT_TESTS OFF CACHE BOOL "") - -# Turn on configure timing -SET(${PROJECT_NAME}_ENABLE_CONFIGURE_TIMING ON CACHE BOOL "") diff --git a/cmake/ctest/drivers/pu241/casl-exclude-trilinos-packages.cmake b/cmake/ctest/drivers/pu241/casl-exclude-trilinos-packages.cmake deleted file mode 100644 index 5a30171bb020..000000000000 --- a/cmake/ctest/drivers/pu241/casl-exclude-trilinos-packages.cmake +++ /dev/null @@ -1,32 +0,0 @@ -# These are all packages that are not needed by CASL development. This list -# is the only list that need to be maintained to exclude and disable Trilinos -# packages. This list is read in and used in a variety of places. - -IF (NOT ${PROJECT_NAME}_EXCLUDE_PACKAGES) - SET(${PROJECT_NAME}_EXCLUDE_PACKAGES - Sacado - Pliris - Galeri - Amesos2 - Pamgen - Komplex - RBGen - STK - Phdmesh - Moertel - TrilinosCouplings - MOOCHO - Stokhos - Xpetra - MueLu - Sundance - CTrilinos - ForTrilinos - PyTrilinos - Didasko - Optika - FEApp - Zoltan2 - ShyLU - ) -ENDIF() diff --git a/cmake/ctest/drivers/pu241/checkin-test-fissile4.sh b/cmake/ctest/drivers/pu241/checkin-test-fissile4.sh deleted file mode 100755 index 440f14f07d47..000000000000 --- a/cmake/ctest/drivers/pu241/checkin-test-fissile4.sh +++ /dev/null @@ -1,102 +0,0 @@ -#!/bin/bash - -# Used to test Trilinos on any of the ORNL CASL Fissile 4 machines -# -# This script requires that the VERA dev env be loaded by sourcing the script: -# -# . /projects/vera/load_dev_env.[sh,csh] -# -# You can source this script either in your shell startup script -# (e.g. .bash_profile) or you can source it manually whenever you need to set -# up to build VERA software. -# -# NOTE: This script should not be directly modifed by typical CASL -# developers except, perhaps to add new extra builds. - -EXTRA_ARGS=$@ - -# The default location for this directory tree is: -# -# Trilinos.base -# Trilinos (your Trilinos soruce tree) -# BUILDS -# CHECKIN (where you run this script from) -# -if [ "$TRILINOS_BASE_DIR" == "" ] ; then - TRILINOS_BASE_DIR=../.. -fi - -TRILINOS_BASE_DIR_ABS=$(readlink -f $TRILINOS_BASE_DIR) - -DRIVERS_BASE_DIR="$TRILINOS_BASE_DIR_ABS/Trilinos/cmake/ctest/drivers/pu241" - -# Packages in Trilinos to disable (mostly for auotmated CI server) -DISABLE_PACKAGES=CTrilinos,ForTrilinos,PyTrilinos,Didasko,Pliris,Amesos2,STK,FEApp,TriKota,Optika - -# Check to make sure that the env has been loaded correctly -if [ "$LOADED_VERA_DEV_ENV" != "gcc461" ] ; then - echo "Error, must source /projects/vera/gcc-4.6.1/load_dev_env.[sh,csh] before running checkin-test-vera.sh!" - exit 1 -fi - -echo " --DTrilinos_ENABLE_CXX11=OFF --DTrilinos_EXCLUDE_PACKAGES=CTrilinos --DTrilinos_DISABLE_ENABLED_FORWARD_DEP_PACKAGES=ON -" > COMMON.config - -# -# Built-in Primary Stable (PS) builds (DO NOT MODIFY) -# - -echo " --DTrilinos_CONFIGURE_OPTIONS_FILE:FILEPATH='$DRIVERS_BASE_DIR/gcc-4.6.1-mpi-debug-ps-options.cmake' -" > MPI_DEBUG.config - -echo " --DTrilinos_CONFIGURE_OPTIONS_FILE:FILEPATH='$DRIVERS_BASE_DIR/gcc-4.6.1-serial-release-ps-options.cmake' -" > SERIAL_RELEASE.config - -# -# Standard Secondary Stable (SS) builds (DO NOT MODIFY) -# - -echo " --DTrilinos_CONFIGURE_OPTIONS_FILE:FILEPATH='$DRIVERS_BASE_DIR/gcc-4.6.1-mpi-debug-ss-options.cmake,$DRIVERS_BASE_DIR/trilinos-tpls-gcc.4.6.1.cmake' -" > MPI_DEBUG_ST.config - -echo " --DTrilinos_CONFIGURE_OPTIONS_FILE:FILEPATH='$DRIVERS_BASE_DIR/gcc-4.6.1-serial-release-ss-options.cmake,$DRIVERS_BASE_DIR/trilinos-tpls-gcc.4.6.1.cmake' -" > SERIAL_RELEASE_ST.config - -# -# Extra builds -# - -echo " --DTrilinos_CONFIGURE_OPTIONS_FILE:FILEPATH='$DRIVERS_BASE_DIR/gcc-4.6.1-mpi-debug-ps-options.cmake' --DCMAKE_BUILD_TYPE:STRING=RELEASE --DTrilinos_ENABLE_DEBUG:BOOL=OFF -" > MPI_RELEASE.config - -# -# Invocation -# - -$TRILINOS_BASE_DIR/Trilinos/checkin-test.py \ --j16 \ ---ctest-timeout=180 \ ---st-extra-builds=MPI_DEBUG_ST,SERIAL_RELEASE_ST \ ---disable-packages=$DISABLE_PACKAGES \ ---skip-case-no-email \ ---ctest-options="-E '(Piro_AnalysisDriver|Stokhos_Linear2D_Diffusion_GMRES_KLR|Panzer_STK_ResponseLibraryTest|MueLu_|Amesos2_|Rythmos_ImplicitRK_UnitTest_MPI_1|SEACASExodus_exodus_unit_tests|Intrepid_test_Discretization_Basis_HGRAD_TRI_Cn_FEM_Test_02_MPI_1|Intrepid_test_Discretization_Basis_HDIV_TET_In_FEM_Test_02_MPI_1|Intrepid_test_Discretization_Basis_HGRAD_TET_Cn_FEM_Test_02_MPI_1|Sundance_BesselTest2D_MPI_1|ThyraTpetraAdapters_TpetraThyraWrappersUnitTests_serial|Ifpack2_RILUKSingleProcessUnitTests)'" \ -$EXTRA_ARGS - -# NOTE: By default we use 16 processes which is 1/2 of the 32 processes on a -# fissile 4 machine. This way two people can build and test without taxing -# the machine too much. - -# Here is the template for excluding tests that can be aded to -# checkin-test.py call above -# -# --ctest-options="-E '(Test1|Test2)'" \ diff --git a/cmake/ctest/drivers/pu241/cron_driver_pu241.sh b/cmake/ctest/drivers/pu241/cron_driver_pu241.sh deleted file mode 100755 index a4437d7b4388..000000000000 --- a/cmake/ctest/drivers/pu241/cron_driver_pu241.sh +++ /dev/null @@ -1,29 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos testing on pu241: `date`" -echo - -BASEDIR=/home/casl-vri-admin/TrilinosNightlyDashboards -DRIVER_SCRIPT_DIR=$BASEDIR/Trilinos/cmake/ctest/drivers/pu241 -TRILINOS_REPOSITORY_LOCATION="software.sandia.gov:/space/git/Trilinos" - -. /projects/vera/gcc-4.6.1/load_dev_env.sh - -umask u=rwx,g=rwx,o= - -export TDD_PARALLEL_LEVEL=6 -export TDD_CTEST_TEST_TYPE=Nightly - -# Submit the outer TDD tests to casl-dev always since these are CASL machines -export TDD_CTEST_DROP_SITE=casl-dev.ornl.gov -export TDD_CTEST_DROP_LOCATION="/cdash/submit.php?project=TrilinosDriver" - -#export CTEST_TEST_TYPE=Experimental - -time env python ../cron_driver.py - -echo -echo "Ending nightly Trilinos testing on pu241: `date`" -echo - diff --git a/cmake/ctest/drivers/pu241/cron_driver_pu241_intel12.sh b/cmake/ctest/drivers/pu241/cron_driver_pu241_intel12.sh deleted file mode 100755 index 343c2ffe308f..000000000000 --- a/cmake/ctest/drivers/pu241/cron_driver_pu241_intel12.sh +++ /dev/null @@ -1,40 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos testing on pu241: `date`" -echo - -BASEDIR=/home/casl-vri-admin/TrilinosNightlyDashboardsIntel12 -DRIVER_SCRIPT_DIR=$BASEDIR/Trilinos/cmake/ctest/drivers/pu241 -TRILINOS_REPOSITORY_LOCATION="software.sandia.gov:/space/git/Trilinos" - - -# Allow override of dev env -if [ "$CASL_VRI_DEV_ENV_BASE" == "" ] ; then - CASL_VRI_DEV_ENV_BASE=/opt/casl_vri_dev_env -fi -echo "CASL_VRI_DEV_ENV_BASE = '$CASL_VRI_DEV_ENV_BASE'" - -# load intel 12 dev env -. $CASL_VRI_DEV_ENV_BASE/fissile_four/build_scripts/load_official_dev_env.sh 12 -# mark environment so that dashboard will build the intel 12 configs only -export INTEL12_BUILD=1 - -umask u=rwx,g=rwx,o= - -export TDD_PARALLEL_LEVEL=4 -export TDD_CTEST_TEST_TYPE=Nightly - -# Submit the outer TDD tests to casl-dev always since these are CASL machines -export TDD_CTEST_DROP_SITE=casl-dev.ornl.gov -export TDD_CTEST_DROP_LOCATION="/cdash/submit.php?project=TrilinosDriver" - -export TDD_BUILD_NAME="Linux-TDD-Intel12-pu241" -#export CTEST_TEST_TYPE=Experimental - -time env python ../cron_driver.py - -echo -echo "Ending nightly Trilinos testing on pu241 (Intel 12): `date`" -echo - diff --git a/cmake/ctest/drivers/pu241/ctest_linux_nightly_mpi_debug_gcc_4.5.1_trilinos.cmake b/cmake/ctest/drivers/pu241/ctest_linux_nightly_mpi_debug_gcc_4.5.1_trilinos.cmake deleted file mode 100644 index 3e0f311da4c7..000000000000 --- a/cmake/ctest/drivers/pu241/ctest_linux_nightly_mpi_debug_gcc_4.5.1_trilinos.cmake +++ /dev/null @@ -1,18 +0,0 @@ -# -# Build all Secondary Stable Trilinos packages in core Trilinos with GCC 4.5.1 compiler -# - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.pu241.gcc.4.5.1.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/SubmitToTrilinos.cmake") - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG_GCC_TRILINOS) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) -SET(EXTRA_CONFIGURE_OPTIONS - ${EXTRA_CONFIGURE_OPTIONS} - -DSTK_ENABLE_BoostLib:BOOL=OFF - ) - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/pu241/ctest_linux_nightly_mpi_debug_gcc_4.6.1_trilinos.cmake b/cmake/ctest/drivers/pu241/ctest_linux_nightly_mpi_debug_gcc_4.6.1_trilinos.cmake deleted file mode 100644 index ee11b3a83ade..000000000000 --- a/cmake/ctest/drivers/pu241/ctest_linux_nightly_mpi_debug_gcc_4.6.1_trilinos.cmake +++ /dev/null @@ -1,14 +0,0 @@ -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.pu241.gcc.4.6.1.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/SubmitToTrilinos.cmake") - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG_GCC) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) -SET(EXTRA_CONFIGURE_OPTIONS - ${EXTRA_CONFIGURE_OPTIONS} - -DSTK_ENABLE_BoostLib:BOOL=OFF - ) - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/pu241/ctest_linux_nightly_mpi_release_gcc_4.5.1_trilinos.cmake b/cmake/ctest/drivers/pu241/ctest_linux_nightly_mpi_release_gcc_4.5.1_trilinos.cmake deleted file mode 100644 index 0e331fb5ae5f..000000000000 --- a/cmake/ctest/drivers/pu241/ctest_linux_nightly_mpi_release_gcc_4.5.1_trilinos.cmake +++ /dev/null @@ -1,18 +0,0 @@ -# -# Build all Secondary Stable Trilinos packages in core Trilinos with GCC 4.5.1 compiler -# - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.pu241.gcc.4.5.1.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/SubmitToTrilinos.cmake") - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_RELEASE_GCC_TRILINOS) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) -SET(EXTRA_CONFIGURE_OPTIONS - ${EXTRA_CONFIGURE_OPTIONS} - -DSTK_ENABLE_BoostLib:BOOL=OFF - ) - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/pu241/ctest_linux_nightly_mpi_release_gcc_4.6.1_trilinos.cmake b/cmake/ctest/drivers/pu241/ctest_linux_nightly_mpi_release_gcc_4.6.1_trilinos.cmake deleted file mode 100644 index dea736acf0c4..000000000000 --- a/cmake/ctest/drivers/pu241/ctest_linux_nightly_mpi_release_gcc_4.6.1_trilinos.cmake +++ /dev/null @@ -1,14 +0,0 @@ -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.pu241.gcc.4.6.1.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/SubmitToTrilinos.cmake") - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_RELEASE_GCC) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) -SET(EXTRA_CONFIGURE_OPTIONS - ${EXTRA_CONFIGURE_OPTIONS} - -DSTK_ENABLE_BoostLib:BOOL=OFF - ) - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/pu241/ctest_linux_nightly_serial_debug_icpc_12.0.4_trilinos.cmake b/cmake/ctest/drivers/pu241/ctest_linux_nightly_serial_debug_icpc_12.0.4_trilinos.cmake deleted file mode 100644 index c1a20eb091cd..000000000000 --- a/cmake/ctest/drivers/pu241/ctest_linux_nightly_serial_debug_icpc_12.0.4_trilinos.cmake +++ /dev/null @@ -1,20 +0,0 @@ -# -# Build all Secondary Stable Trilinos packages in core Trilinos with Intel 12.0.4 compiler -# - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.pu241.icpc.12.0.4.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/SubmitToTrilinos.cmake") - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_ICPC_TRILINOS) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) -SET(EXTRA_CONFIGURE_OPTIONS - ${EXTRA_CONFIGURE_OPTIONS} - -DTeuchos_ENABLE_STACKTRACE:BOOL=ON - -DTrilinos_ENABLE_DEBUG:BOOL=ON - -DSTK_ENABLE_BoostLib:BOOL=OFF - ) - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/pu241/ctest_linux_nightly_serial_release_gcc_4.5.1_trilinos.cmake b/cmake/ctest/drivers/pu241/ctest_linux_nightly_serial_release_gcc_4.5.1_trilinos.cmake deleted file mode 100644 index 9556086115c3..000000000000 --- a/cmake/ctest/drivers/pu241/ctest_linux_nightly_serial_release_gcc_4.5.1_trilinos.cmake +++ /dev/null @@ -1,17 +0,0 @@ -# -# Build all Secondary Stable Trilinos packages in core Trilinos with GCC 4.5.1 compiler -# - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.pu241.gcc.4.5.1.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/SubmitToTrilinos.cmake") - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_RELEASE_GCC_TRILINOS) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) -SET(EXTRA_CONFIGURE_OPTIONS - ${EXTRA_CONFIGURE_OPTIONS} - ) - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/pu241/ctest_linux_nightly_serial_release_gcc_4.6.1_trilinos.cmake b/cmake/ctest/drivers/pu241/ctest_linux_nightly_serial_release_gcc_4.6.1_trilinos.cmake deleted file mode 100644 index 068e4a7099bd..000000000000 --- a/cmake/ctest/drivers/pu241/ctest_linux_nightly_serial_release_gcc_4.6.1_trilinos.cmake +++ /dev/null @@ -1,15 +0,0 @@ -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.pu241.gcc.4.6.1.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/SubmitToTrilinos.cmake") - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_RELEASE_GCC) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) -SET(Trilinos_ENABLE_Panzer OFF) -SET(EXTRA_CONFIGURE_OPTIONS - ${EXTRA_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_Panzer=OFF" - ) - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/pu241/ctest_linux_nightly_serial_release_icpc_12.0.4_trilinos.cmake b/cmake/ctest/drivers/pu241/ctest_linux_nightly_serial_release_icpc_12.0.4_trilinos.cmake deleted file mode 100644 index e6360930ee57..000000000000 --- a/cmake/ctest/drivers/pu241/ctest_linux_nightly_serial_release_icpc_12.0.4_trilinos.cmake +++ /dev/null @@ -1,18 +0,0 @@ -# -# Build all Secondary Stable Trilinos packages in core Trilinos with Intel 12.0.4 compiler -# - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.pu241.icpc.12.0.4.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/SubmitToTrilinos.cmake") - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_RELEASE_ICPC_TRILINOS) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) -SET(EXTRA_CONFIGURE_OPTIONS - ${EXTRA_CONFIGURE_OPTIONS} - -DTeuchos_ENABLE_STACKTRACE:BOOL=ON - ) - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/pu241/gcc-4.5.1-base-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.5.1-base-options.cmake deleted file mode 100644 index c8e0d4083306..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.5.1-base-options.cmake +++ /dev/null @@ -1,22 +0,0 @@ -# -# Base options for all hybrid GCC 4.5.1 C/C++ and Intel 11.1.064 Fortran builds -# - -# Define the core compilers -SET(TRILINOS_TOOLSET_BASE /opt/gcc-4.5.1/trilinos-toolset) -# Add rpath for compiler libraries -SET(${PROJECT_NAME}_EXTRA_LINK_FLAGS "-Wl,-rpath,${TRILINOS_TOOLSET_BASE}/lib64" CACHE STRING "") -# This dicates downstream the intel fortran compiler to be used -# Include MKL and TBB; these should match version of Intel compilers being used -MESSAGE(STATUS "Selecting ifort 11.1.064 compiler and libraries") -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/tbb-11.1.064-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/mkl-11.1.064-options.cmake) -SET(IFORT_VERSION "11.1.064") -SET(BLAS_INCLUDE_DIRS ${MKL_IFORT_MODULE_PATH} CACHE PATH "Path to MKL BLAS Fortran modules compatible with Intel fortran") -SET(LAPACK_INCLUDE_DIRS ${MKL_IFORT_MODULE_PATH} CACHE PATH "Path to MKL LAPACK Fortran modules compatible with Intel fortran") - -# To avoid problem with EpetraExt_inout_test failure in optimized code for hybrid build -SET(Epetra_ENABLE_Fortran OFF CACHE BOOL "") - -# Include last so that above override these cache variables -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/casl-core-enables-disables.cmake) diff --git a/cmake/ctest/drivers/pu241/gcc-4.5.1-debug-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.5.1-debug-options.cmake deleted file mode 100644 index e09a34452b07..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.5.1-debug-options.cmake +++ /dev/null @@ -1,3 +0,0 @@ -SET(CMAKE_BUILD_TYPE RELEASE CACHE STRING "") -SET(${PROJECT_NAME}_ENABLE_DEBUG ON CACHE BOOL "") -SET(CMAKE_Fortran_FLAGS_DEBUG_OVERRIDE "-O3" CACHE STRING "") diff --git a/cmake/ctest/drivers/pu241/gcc-4.5.1-mpi-debug-ps-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.5.1-mpi-debug-ps-options.cmake deleted file mode 100644 index 7f55daad379d..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.5.1-mpi-debug-ps-options.cmake +++ /dev/null @@ -1,6 +0,0 @@ -# -# checkin-test-fissile4.sh PS MPI_DEBUG build -# - -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.5.1-mpi-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.5.1-debug-options.cmake) diff --git a/cmake/ctest/drivers/pu241/gcc-4.5.1-mpi-debug-ss-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.5.1-mpi-debug-ss-options.cmake deleted file mode 100644 index b0362aff1c53..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.5.1-mpi-debug-ss-options.cmake +++ /dev/null @@ -1,15 +0,0 @@ -# -# checkin-test-fissile4.sh MPI_DEBUG_SS build -# - -SET(TPL_ENABLE_MPI ON CACHE BOOL "") -# SET(${PROJECT_NAME}_ENABLE_CHECKED_STL ON CACHE BOOL "") -SET(${PROJECT_NAME}_ENABLE_DEBUG_SYMBOLS ON CACHE BOOL "") -SET(Teuchos_ENABLE_DEFAULT_STACKTRACE OFF CACHE BOOL "") - -# Disable boost libs since not build with checked-stl turned on -SET(STK_ENABLE_BoostLib OFF CACHE BOOL "") - -# Include last so that above override these cache variables -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.5.1-mpi-ss-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.5.1-debug-options.cmake) diff --git a/cmake/ctest/drivers/pu241/gcc-4.5.1-mpi-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.5.1-mpi-options.cmake deleted file mode 100644 index beb25b1daf6b..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.5.1-mpi-options.cmake +++ /dev/null @@ -1,19 +0,0 @@ -# -# Primary Stable options for MPI builds with hybrid GCC 4.5.1 C/C++ and Intel 12.0.4 -# Fortran -# - -# Included first ot define TRILINOS_TOOLSET_BASE and MKLROOT -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.5.1-base-options.cmake) - -# Point to OpenMPI build with GCC 4.5.1 C/C++ and Intel 12.0.4 Fortran -SET(MPI_BASE_DIR "${TRILINOS_TOOLSET_BASE}/openmpi-ifort-12.0.4" CACHE PATH "") -SET(${PROJECT_NAME}_EXTRA_LINK_FLAGS "-Wl,-rpath,${TRILINOS_TOOLSET_BASE}/openmpi-ifort-12.0.4/lib ${${PROJECT_NAME}_EXTRA_LINK_FLAGS}" CACHE STRING "") - -# Used only when TriKota/Dakota are enabled with CMake -SET(TriKota_ENABLE_DakotaCMake ON CACHE BOOL "") -SET(ENABLE_DAKOTA_TESTS OFF CACHE BOOL "") -SET(HAVE_ACRO OFF CACHE BOOL "") -SET(HAVE_AMPL OFF CACHE BOOL "") -SET(HAVE_X_GRAPHICS OFF CACHE BOOL "") -SET(HAVE_HOPSPACK OFF CACHE BOOL "") diff --git a/cmake/ctest/drivers/pu241/gcc-4.5.1-mpi-ss-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.5.1-mpi-ss-options.cmake deleted file mode 100644 index 9834e2db03ed..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.5.1-mpi-ss-options.cmake +++ /dev/null @@ -1,9 +0,0 @@ - -# Secondary Stable MPI build with GCC 4.5.1 - -# Must turn off this option so that Panzer/Drekar can work with Intrepid -SET(Intrepid_ENABLE_DEBUG_INF_CHECK OFF CACHE BOOL "") - -# Include last so that above override these cache variables -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.5.1-mpi-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/boost-1.46.1-options.cmake) diff --git a/cmake/ctest/drivers/pu241/gcc-4.5.1-release-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.5.1-release-options.cmake deleted file mode 100644 index df8057cc3f00..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.5.1-release-options.cmake +++ /dev/null @@ -1,2 +0,0 @@ -SET(CMAKE_BUILD_TYPE RELEASE CACHE STRING "") -SET(CMAKE_Fortran_FLAGS_RELEASE_OVERRIDE "-O3" CACHE STRING "") diff --git a/cmake/ctest/drivers/pu241/gcc-4.5.1-serial-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.5.1-serial-options.cmake deleted file mode 100644 index f5c7c20f4be0..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.5.1-serial-options.cmake +++ /dev/null @@ -1,12 +0,0 @@ -# -# Primary Stable options for serial builds with hybrid GCC 4.5.1 C/C++ and Intel 12.0.4 -# Fortran -# - -# Must be including first in order to define TRILINOS_TOOLSET_BASE -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.5.1-base-options.cmake) - -# Set up the hybrid compilers -SET(CMAKE_CXX_COMPILER "${TRILINOS_TOOLSET_BASE}/bin/g++" CACHE FILEPATH "") -SET(CMAKE_C_COMPILER "${TRILINOS_TOOLSET_BASE}/bin/gcc" CACHE FILEPATH "") -SET(CMAKE_Fortran_COMPILER "/opt/intel/Compiler/11.1/064/bin/intel64/ifort" CACHE FILEPATH "") diff --git a/cmake/ctest/drivers/pu241/gcc-4.5.1-serial-release-ps-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.5.1-serial-release-ps-options.cmake deleted file mode 100644 index e353e15bb479..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.5.1-serial-release-ps-options.cmake +++ /dev/null @@ -1,6 +0,0 @@ -# -# checkin-test-fissile4.sh PS SERIAL_RELEASE build -# - -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.5.1-serial-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.5.1-release-options.cmake) diff --git a/cmake/ctest/drivers/pu241/gcc-4.5.1-serial-release-ss-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.5.1-serial-release-ss-options.cmake deleted file mode 100644 index b7d70f790ba8..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.5.1-serial-release-ss-options.cmake +++ /dev/null @@ -1,9 +0,0 @@ -# -# checkin-test-fissile4.sh SERIAL_RELEASE_SS build -# - -SET(TPL_ENABLE_MPI OFF CACHE BOOL "") - -# Include last so that above override these cache variables -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.5.1-serial-ss-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.5.1-release-options.cmake) diff --git a/cmake/ctest/drivers/pu241/gcc-4.5.1-serial-ss-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.5.1-serial-ss-options.cmake deleted file mode 100644 index 16803e33d3b9..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.5.1-serial-ss-options.cmake +++ /dev/null @@ -1,7 +0,0 @@ -# -# Secondary Stable Serial build with GCC 4.5.1 -# - -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.5.1-serial-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/boost-1.46.1-options.cmake) - diff --git a/cmake/ctest/drivers/pu241/gcc-4.6.1-base-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.6.1-base-options.cmake deleted file mode 100644 index 6d50b0f1cdcd..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.6.1-base-options.cmake +++ /dev/null @@ -1,42 +0,0 @@ -# -# Base options for all GCC 4.6.1 builds -# - -# Define the core compilers -IF (NOT TRILINOS_TOOLSET_BASE) - SET(TRILINOS_TOOLSET_BASE /projects/vera/gcc-4.6.1/toolset) -ENDIF() -SET(GCC_BASE_DIR ${TRILINOS_TOOLSET_BASE}/gcc-4.6.1) -# Add rpath for compiler libraries and gomp for parts built with OpenMP -SET(${PROJECT_NAME}_EXTRA_LINK_FLAGS - "-lgomp -Wl,-rpath,${GCC_BASE_DIR}/lib64" - CACHE STRING "") -# This dicates downstream the intel fortran compiler to be used -# Include MKL and TBB; these should match version of Intel compilers being used -MESSAGE(STATUS "Selecting gfortran 4.6.1 compiler and Intel 12.0.4 TBB/MKL") -SET(IFORT_VERSION "") -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/tbb-12.0.4-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/mkl-12.0.4-options.cmake) -SET(BLAS_INCLUDE_DIRS ${MKL_GCC451_MODULE_PATH} CACHE PATH "Path to MKL BLAS Fortran modules compatible with gfortran") -SET(LAPACK_INCLUDE_DIRS ${MKL_GCC451_MODULE_PATH} CACHE PATH "Path to MKL LAPACK Fortran modules compatible with gfortran") - -# Build shared libs by default to save massive amounts of disk space -SET(BUILD_SHARED_LIBS ON CACHE BOOL - "Set by default in gcc-4.6.1-base-options.cmake") - -# To avoid problem with EpetraExt_inout_test failure in optimized code for hybrid builds -SET(Epetra_ENABLE_Fortran OFF CACHE BOOL - "Set by default in gcc-4.6.1-base-options.cmake") - -# Turn off HDF5 in EpetraExt to avoid hdf5 conflicts -SET(EpetraExt_ENABLE_HDF5 OFF CACHE BOOL - "Set by default in gcc-4.6.1-base-options.cmake") - -# Set up valgrind options -SET( MEMORYCHECK_COMMAND - /projects/vera/common_tools/valgrind-3.9.0/bin/valgrind) -SET( MEMORYCHECK_COMMAND_OPTIONS - "-q --trace-children=yes --tool=memcheck --leak-check=yes --leak-check=full --workaround-gcc296-bugs=yes --num-callers=50") - -# Include last so that above override these cache variables -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/casl-core-enables-disables.cmake) diff --git a/cmake/ctest/drivers/pu241/gcc-4.6.1-ci-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.6.1-ci-options.cmake deleted file mode 100644 index 73b5d0616b39..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.6.1-ci-options.cmake +++ /dev/null @@ -1,3 +0,0 @@ -# Do a shared library build (BinUtils needs -fPIC to work with this) -SET(TPL_ENABLE_BinUtils OFF CACHE BOOL "") -SET(BUILD_SHARED_LIBS ON CACHE BOOL "") diff --git a/cmake/ctest/drivers/pu241/gcc-4.6.1-debug-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.6.1-debug-options.cmake deleted file mode 100644 index e09a34452b07..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.6.1-debug-options.cmake +++ /dev/null @@ -1,3 +0,0 @@ -SET(CMAKE_BUILD_TYPE RELEASE CACHE STRING "") -SET(${PROJECT_NAME}_ENABLE_DEBUG ON CACHE BOOL "") -SET(CMAKE_Fortran_FLAGS_DEBUG_OVERRIDE "-O3" CACHE STRING "") diff --git a/cmake/ctest/drivers/pu241/gcc-4.6.1-mpi-debug-ps-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.6.1-mpi-debug-ps-options.cmake deleted file mode 100644 index 0dbb4d0dcbeb..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.6.1-mpi-debug-ps-options.cmake +++ /dev/null @@ -1,7 +0,0 @@ -# -# checkin-test-fissile4.sh PS MPI_DEBUG build -# - -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.6.1-mpi-options.cmake) -# these options are the same for 4.6.1 and 4.5.1 -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.5.1-debug-options.cmake) diff --git a/cmake/ctest/drivers/pu241/gcc-4.6.1-mpi-debug-ss-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.6.1-mpi-debug-ss-options.cmake deleted file mode 100644 index ae79b8f90661..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.6.1-mpi-debug-ss-options.cmake +++ /dev/null @@ -1,16 +0,0 @@ -# -# checkin-test-fissile4.sh MPI_DEBUG_SS build -# - -SET(TPL_ENABLE_MPI ON CACHE BOOL "") -# SET(${PROJECT_NAME}_ENABLE_CHECKED_STL ON CACHE BOOL "") -SET(${PROJECT_NAME}_ENABLE_DEBUG_SYMBOLS ON CACHE BOOL "") -SET(Teuchos_ENABLE_DEFAULT_STACKTRACE OFF CACHE BOOL "") - -# Disable boost libs since not build with checked-stl turned on -SET(STK_ENABLE_BoostLib OFF CACHE BOOL "") - -# Include last so that above override these cache variables -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.6.1-mpi-ss-options.cmake) -# these options are the same for 4.6.1 and 4.5.1 -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.5.1-debug-options.cmake) diff --git a/cmake/ctest/drivers/pu241/gcc-4.6.1-mpi-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.6.1-mpi-options.cmake deleted file mode 100644 index 868b9d38dad2..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.6.1-mpi-options.cmake +++ /dev/null @@ -1,10 +0,0 @@ -# -# Primary Stable options for MPI builds with hybrid GCC 4.6.1 C/C++ -# Fortran -# - -# Included first ot define TRILINOS_TOOLSET_BASE and MKLROOT -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.6.1-base-options.cmake) - -# Point to OpenMPI build with GCC 4.6.1 C/C++ -SET(MPI_BASE_DIR "${TRILINOS_TOOLSET_BASE}/openmpi-1.4.3" CACHE PATH "") diff --git a/cmake/ctest/drivers/pu241/gcc-4.6.1-mpi-ss-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.6.1-mpi-ss-options.cmake deleted file mode 100644 index 21d28becfe11..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.6.1-mpi-ss-options.cmake +++ /dev/null @@ -1,11 +0,0 @@ - -# Secondary Stable MPI build with GCC 4.6.1 - -SET(${PROJECT_NAME}_ENABLE_EXPLICIT_INSTANTIATION ON CACHE BOOL "") - -# Must turn off this option so that Panzer/Drekar can work with Intrepid -SET(Intrepid_ENABLE_DEBUG_INF_CHECK OFF CACHE BOOL "") - -# Include last so that above override these cache variables -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.6.1-mpi-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/boost-1.46.1-options.cmake) diff --git a/cmake/ctest/drivers/pu241/gcc-4.6.1-release-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.6.1-release-options.cmake deleted file mode 100644 index df8057cc3f00..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.6.1-release-options.cmake +++ /dev/null @@ -1,2 +0,0 @@ -SET(CMAKE_BUILD_TYPE RELEASE CACHE STRING "") -SET(CMAKE_Fortran_FLAGS_RELEASE_OVERRIDE "-O3" CACHE STRING "") diff --git a/cmake/ctest/drivers/pu241/gcc-4.6.1-serial-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.6.1-serial-options.cmake deleted file mode 100644 index 393c15f438b1..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.6.1-serial-options.cmake +++ /dev/null @@ -1,12 +0,0 @@ -# -# Primary Stable options for serial builds with hybrid GCC 4.6.1 C/C++ -# Fortran -# - -# Must be including first in order to define TRILINOS_TOOLSET_BASE -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.6.1-base-options.cmake) - -# Set up the hybrid compilers -SET(CMAKE_CXX_COMPILER "${GCC_BASE_DIR}/bin/g++" CACHE FILEPATH "") -SET(CMAKE_C_COMPILER "${GCC_BASE_DIR}/bin/gcc" CACHE FILEPATH "") -SET(CMAKE_Fortran_COMPILER "${GCC_BASE_DIR}/bin/gfortran" CACHE FILEPATH "") diff --git a/cmake/ctest/drivers/pu241/gcc-4.6.1-serial-release-ps-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.6.1-serial-release-ps-options.cmake deleted file mode 100644 index 435470ef567f..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.6.1-serial-release-ps-options.cmake +++ /dev/null @@ -1,7 +0,0 @@ -# -# checkin-test-fissile4.sh PS SERIAL_RELEASE build -# - -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.6.1-serial-options.cmake) -# these options are the same for 4.6.1 and 4.5.1 -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.5.1-release-options.cmake) diff --git a/cmake/ctest/drivers/pu241/gcc-4.6.1-serial-release-ss-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.6.1-serial-release-ss-options.cmake deleted file mode 100644 index 29c3dd86ca42..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.6.1-serial-release-ss-options.cmake +++ /dev/null @@ -1,11 +0,0 @@ -# -# checkin-test-fissile4.sh SERIAL_RELEASE_SS build -# - -SET(TPL_ENABLE_MPI OFF CACHE BOOL "") -SET(${PROJECT_NAME}_EXCLUDE_PACKAGES ${${PROJECT_NAME}_EXCLUDE_PACKAGES} Panzer) - -# Include last so that above override these cache variables -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.6.1-serial-ss-options.cmake) -# these options are the same for 4.6.1 and 4.5.1 -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.5.1-release-options.cmake) diff --git a/cmake/ctest/drivers/pu241/gcc-4.6.1-serial-ss-options.cmake b/cmake/ctest/drivers/pu241/gcc-4.6.1-serial-ss-options.cmake deleted file mode 100644 index 87fbd5635f08..000000000000 --- a/cmake/ctest/drivers/pu241/gcc-4.6.1-serial-ss-options.cmake +++ /dev/null @@ -1,9 +0,0 @@ -# -# Secondary Stable Serial build with GCC 4.6.1 -# - -SET(${PROJECT_NAME}_ENABLE_EXPLICIT_INSTANTIATION ON CACHE BOOL "") - -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/gcc-4.6.1-serial-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/boost-1.46.1-options.cmake) - diff --git a/cmake/ctest/drivers/pu241/intel-11.1.064-options.cmake b/cmake/ctest/drivers/pu241/intel-11.1.064-options.cmake deleted file mode 100644 index 2d43b6831edf..000000000000 --- a/cmake/ctest/drivers/pu241/intel-11.1.064-options.cmake +++ /dev/null @@ -1,33 +0,0 @@ -# -# Core options for Intel 11.1.064 builds -# - -# Define the core compilers -SET(IFORT_VERSION "11.1.064") -SET(INTEL_LIB /opt/intel/Compiler/11.1/064/lib/intel64) -SET(INTEL_BIN /opt/intel/Compiler/11.1/064/bin/intel64) -# Add rpath for compiler libraries -# SET(${PROJECT_NAME}_EXTRA_LINK_FLAGS "-Wl,-rpath,${INTEL_LIB}" CACHE STRING "") -SET(CMAKE_SKIP_RPATH ON BOOL "") -# Intel 11 not compatible with GCC 4.5.1; in case it is loaded, lock it out -SET(CMAKE_C_FLAGS "-gcc-name=/usr/bin/gcc" CACHE STRING "") -SET(CMAKE_CXX_FLAGS "-gxx-name=/usr/bin/g++" CACHE STRING "") - -# this compiler supports BinUtils -SET(TPL_ENABLE_BinUtils ON CACHE BOOL "") - -# Include MKL and TBB; these should match version of Intel compilers being used -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/tbb-11.1.064-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/mkl-11.1.064-options.cmake) -SET(BLAS_INCLUDE_DIRS ${MKL_IFORT_MODULE_PATH} CACHE PATH "Path to MKL BLAS Fortran modules compatible with Intel fortran") -SET(LAPACK_INCLUDE_DIRS ${MKL_IFORT_MODULE_PATH} CACHE PATH "Path to MKL LAPACK Fortran modules compatible with Intel fortran") - -# Point to basic CASL-related TPLs compatible with the Intel C/C++ compiler -SET(PVMLibraries_LIBRARY_DIRS /opt/intel-11.1.064/tpls/pvm3/lib/LINUX64 CACHE FILEPATH "") -SET(PVMHeaders_INCLUDE_DIRS /opt/intel-11.1.064/tpls/pvm3/include CACHE FILEPATH "") -SET(HDF5_LIBRARY_NAMES "hdf5_hl;hdf5;hdf5_cpp" CACHE STRING "") -SET(HDF5_LIBRARY_DIRS /opt/intel-11.1.064/tpls/hdf5-1.8.5-patch1/lib CACHE FILEPATH "") -SET(HDF5_INCLUDE_DIRS /opt/intel-11.1.064/tpls/hdf5-1.8.5-patch1/include CACHE FILEPATH "") - -# Including these last to allow override above -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/casl-core-enables-disables.cmake) diff --git a/cmake/ctest/drivers/pu241/intel-11.1.064-serial-debug-ss-options.cmake b/cmake/ctest/drivers/pu241/intel-11.1.064-serial-debug-ss-options.cmake deleted file mode 100644 index 3fa27963c413..000000000000 --- a/cmake/ctest/drivers/pu241/intel-11.1.064-serial-debug-ss-options.cmake +++ /dev/null @@ -1,8 +0,0 @@ -# -# checkin-test-fissile4.sh INTEL11_SERIAL_DEBUG build -# - -# Include last so that above override these cache variables -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-11.1.064-serial-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-debug-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/boost-1.46.1-options.cmake) diff --git a/cmake/ctest/drivers/pu241/intel-11.1.064-serial-options.cmake b/cmake/ctest/drivers/pu241/intel-11.1.064-serial-options.cmake deleted file mode 100644 index 99debb21970c..000000000000 --- a/cmake/ctest/drivers/pu241/intel-11.1.064-serial-options.cmake +++ /dev/null @@ -1,12 +0,0 @@ -# -# Primary Stable options for serial builds with Intel 11.1.064 compiler -# - -# Must be including first in order to define TRILINOS_TOOLSET_BASE -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-11.1.064-options.cmake) - -SET(TPL_ENABLE_MPI OFF CACHE BOOL "") - -SET(CMAKE_CXX_COMPILER "${INTEL_BIN}/icpc" CACHE FILEPATH "") -SET(CMAKE_C_COMPILER "${INTEL_BIN}/icc" CACHE FILEPATH "") -SET(CMAKE_Fortran_COMPILER "${INTEL_BIN}/ifort" CACHE FILEPATH "") diff --git a/cmake/ctest/drivers/pu241/intel-11.1.064-serial-release-ss-options.cmake b/cmake/ctest/drivers/pu241/intel-11.1.064-serial-release-ss-options.cmake deleted file mode 100644 index 3b6bbeca0689..000000000000 --- a/cmake/ctest/drivers/pu241/intel-11.1.064-serial-release-ss-options.cmake +++ /dev/null @@ -1,8 +0,0 @@ -# -# checkin-test-fissile4.sh INTEL11_SERIAL_RELEASE build -# - -# Include last so that above override these cache variables -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-11.1.064-serial-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-release-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/boost-1.46.1-options.cmake) diff --git a/cmake/ctest/drivers/pu241/intel-12.0.4-options.cmake b/cmake/ctest/drivers/pu241/intel-12.0.4-options.cmake deleted file mode 100644 index 0bcb952f6a45..000000000000 --- a/cmake/ctest/drivers/pu241/intel-12.0.4-options.cmake +++ /dev/null @@ -1,30 +0,0 @@ -# -# Core options for Intel 12.0.4 builds -# - -# Define the core compilers -SET(IFORT_VERSION "12.0.4") -SET(INTEL_LIB /opt/intel/Compiler/composerxe-2011.4.191/compiler/lib/intel64) -SET(INTEL_BIN /opt/intel/Compiler/composerxe-2011.4.191/bin/intel64) -# Add rpath for compiler libraries -# SET(${PROJECT_NAME}_EXTRA_LINK_FLAGS "-Wl,-rpath,${INTEL_LIB}" CACHE STRING "") -SET(CMAKE_SKIP_RPATH ON BOOL "") - -# this compiler supports BinUtils -SET(TPL_ENABLE_BinUtils ON CACHE BOOL "") - -# Include MKL and TBB; these should match version of Intel compilers being used -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/tbb-12.0.4-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/mkl-12.0.4-options.cmake) -SET(BLAS_INCLUDE_DIRS ${MKL_IFORT_MODULE_PATH} CACHE PATH "Path to MKL BLAS Fortran modules compatible with Intel fortran") -SET(LAPACK_INCLUDE_DIRS ${MKL_IFORT_MODULE_PATH} CACHE PATH "Path to MKL LAPACK Fortran modules compatible with Intel fortran") - -# Point to basic CASL-related TPLs compatible with the Intel C/C++ compiler -SET(PVMLibraries_LIBRARY_DIRS /opt/intel-11.1.064/tpls/pvm3/lib/LINUX64 CACHE FILEPATH "") -SET(PVMHeaders_INCLUDE_DIRS /opt/intel-11.1.064/tpls/pvm3/include CACHE FILEPATH "") -SET(HDF5_LIBRARY_NAMES "hdf5_hl;hdf5;hdf5_cpp" CACHE STRING "") -SET(HDF5_LIBRARY_DIRS /opt/intel-11.1.064/tpls/hdf5-1.8.5-patch1/lib CACHE FILEPATH "") -SET(HDF5_INCLUDE_DIRS /opt/intel-11.1.064/tpls/hdf5-1.8.5-patch1/include CACHE FILEPATH "") - -# Including these last to allow override above -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/casl-core-enables-disables.cmake) diff --git a/cmake/ctest/drivers/pu241/intel-12.0.4-serial-debug-ss-options.cmake b/cmake/ctest/drivers/pu241/intel-12.0.4-serial-debug-ss-options.cmake deleted file mode 100644 index c67f38171803..000000000000 --- a/cmake/ctest/drivers/pu241/intel-12.0.4-serial-debug-ss-options.cmake +++ /dev/null @@ -1,8 +0,0 @@ -# -# checkin-test-fissile4.sh INTEL12_SERIAL_RELEASE build -# - -# Include last so that above override these cache variables -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-12.0.4-serial-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-debug-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/boost-1.46.1-options.cmake) diff --git a/cmake/ctest/drivers/pu241/intel-12.0.4-serial-options.cmake b/cmake/ctest/drivers/pu241/intel-12.0.4-serial-options.cmake deleted file mode 100644 index a87e62feca3c..000000000000 --- a/cmake/ctest/drivers/pu241/intel-12.0.4-serial-options.cmake +++ /dev/null @@ -1,12 +0,0 @@ -# -# Primary Stable options for serial builds with Intel 12.0.4 compiler -# - -# Must be including first in order to define TRILINOS_TOOLSET_BASE -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-12.0.4-options.cmake) - -SET(TPL_ENABLE_MPI OFF CACHE BOOL "") - -SET(CMAKE_CXX_COMPILER "${INTEL_BIN}/icpc" CACHE FILEPATH "") -SET(CMAKE_C_COMPILER "${INTEL_BIN}/icc" CACHE FILEPATH "") -SET(CMAKE_Fortran_COMPILER "${INTEL_BIN}/ifort" CACHE FILEPATH "") diff --git a/cmake/ctest/drivers/pu241/intel-12.0.4-serial-release-ss-options.cmake b/cmake/ctest/drivers/pu241/intel-12.0.4-serial-release-ss-options.cmake deleted file mode 100644 index 28ea986d36b8..000000000000 --- a/cmake/ctest/drivers/pu241/intel-12.0.4-serial-release-ss-options.cmake +++ /dev/null @@ -1,8 +0,0 @@ -# -# checkin-test-fissile4.sh INTEL12_SERIAL_DEBUG build -# - -# Include last so that above override these cache variables -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-12.0.4-serial-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-release-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/boost-1.46.1-options.cmake) diff --git a/cmake/ctest/drivers/pu241/intel-12.0.4-ss-options.cmake b/cmake/ctest/drivers/pu241/intel-12.0.4-ss-options.cmake deleted file mode 100644 index 84aab5fdb493..000000000000 --- a/cmake/ctest/drivers/pu241/intel-12.0.4-ss-options.cmake +++ /dev/null @@ -1,8 +0,0 @@ -# -# Secondary Stable Serial build with Intel 12.0.4 -# - -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-12.0.4-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/boost-1.46.1-options.cmake) - - diff --git a/cmake/ctest/drivers/pu241/intel-12.0.8-mpi-debug-ss-options.cmake b/cmake/ctest/drivers/pu241/intel-12.0.8-mpi-debug-ss-options.cmake deleted file mode 100644 index 483e1cb0bd24..000000000000 --- a/cmake/ctest/drivers/pu241/intel-12.0.8-mpi-debug-ss-options.cmake +++ /dev/null @@ -1,8 +0,0 @@ -# -# checkin-test-fissile4.sh INTEL12_SERIAL_RELEASE build -# - -# Include last so that above override these cache variables -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-12.0.8-mpi-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-debug-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/boost-1.49.0-options.cmake) diff --git a/cmake/ctest/drivers/pu241/intel-12.0.8-mpi-options.cmake b/cmake/ctest/drivers/pu241/intel-12.0.8-mpi-options.cmake deleted file mode 100644 index af9634cb38b1..000000000000 --- a/cmake/ctest/drivers/pu241/intel-12.0.8-mpi-options.cmake +++ /dev/null @@ -1,21 +0,0 @@ -# -# Primary Stable options for MPI builds with hybrid GCC 4.5.1 C/C++ and Intel 12.0.4 -# Fortran -# - -# Included first ot define TRILINOS_TOOLSET_BASE and MKLROOT -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-12.0.8-options.cmake) - -SET(INTEL_BASE /opt/intel-12.0.8) - -# Point to OpenMPI build with Intel 12.0.8 -SET(MPI_BASE_DIR "${INTEL_BASE}/openmpi" CACHE PATH "") -SET(${PROJECT_NAME}_EXTRA_LINK_FLAGS "-Wl,-rpath,${INTEL_BASE}/openmpi/lib ${${PROJECT_NAME}_EXTRA_LINK_FLAGS}" CACHE STRING "") - -# Used only when TriKota/Dakota are enabled with CMake -SET(TriKota_ENABLE_DakotaCMake ON CACHE BOOL "") -SET(ENABLE_DAKOTA_TESTS OFF CACHE BOOL "") -SET(HAVE_ACRO OFF CACHE BOOL "") -SET(HAVE_AMPL OFF CACHE BOOL "") -SET(HAVE_X_GRAPHICS OFF CACHE BOOL "") -SET(HAVE_HOPSPACK OFF CACHE BOOL "") diff --git a/cmake/ctest/drivers/pu241/intel-12.0.8-mpi-release-ss-options.cmake b/cmake/ctest/drivers/pu241/intel-12.0.8-mpi-release-ss-options.cmake deleted file mode 100644 index 0d502bd56bb9..000000000000 --- a/cmake/ctest/drivers/pu241/intel-12.0.8-mpi-release-ss-options.cmake +++ /dev/null @@ -1,8 +0,0 @@ -# -# checkin-test-fissile4.sh INTEL12_SERIAL_DEBUG build -# - -# Include last so that above override these cache variables -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-12.0.8-mpi-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-release-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/boost-1.49.0-options.cmake) diff --git a/cmake/ctest/drivers/pu241/intel-12.0.8-mpi-ss-options.cmake b/cmake/ctest/drivers/pu241/intel-12.0.8-mpi-ss-options.cmake deleted file mode 100644 index 4673e73f4a01..000000000000 --- a/cmake/ctest/drivers/pu241/intel-12.0.8-mpi-ss-options.cmake +++ /dev/null @@ -1,7 +0,0 @@ -# -# checkin-test-fissile4.sh INTEL12_SERIAL_DEBUG build -# - -# Include last so that above override these cache variables -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-12.0.8-mpi-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/boost-1.49.0-options.cmake) diff --git a/cmake/ctest/drivers/pu241/intel-12.0.8-options.cmake b/cmake/ctest/drivers/pu241/intel-12.0.8-options.cmake deleted file mode 100644 index c6615feba8b6..000000000000 --- a/cmake/ctest/drivers/pu241/intel-12.0.8-options.cmake +++ /dev/null @@ -1,30 +0,0 @@ -# -# Core options for Intel 12.0.8 builds -# - -# Define the core compilers -SET(IFORT_VERSION "12.0.8") -SET(INTEL_LIB /opt/intel-12.0.8/lib/intel64) -SET(INTEL_BIN /opt/intel-12.0.8/bin) -# Add rpath for compiler libraries -# SET(${PROJECT_NAME}_EXTRA_LINK_FLAGS "-Wl,-rpath,${INTEL_LIB}" CACHE STRING "") -SET(CMAKE_SKIP_RPATH ON BOOL "") - -# this compiler supports BinUtils -SET(TPL_ENABLE_BinUtils ON CACHE BOOL "") - -# Include MKL and TBB; these should match version of Intel compilers being used -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/tbb-12.0.8-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/mkl-12.0.8-options.cmake) -SET(BLAS_INCLUDE_DIRS ${MKL_IFORT_MODULE_PATH} CACHE PATH "Path to MKL BLAS Fortran modules compatible with Intel fortran") -SET(LAPACK_INCLUDE_DIRS ${MKL_IFORT_MODULE_PATH} CACHE PATH "Path to MKL LAPACK Fortran modules compatible with Intel fortran") - -# Point to basic CASL-related TPLs compatible with the Intel C/C++ compiler -SET(PVMLibraries_LIBRARY_DIRS /opt/intel-12.0.8/tpls/pvm3/lib CACHE FILEPATH "") -SET(PVMHeaders_INCLUDE_DIRS /opt/intel-12.0.8/tpls/pvm3/include CACHE FILEPATH "") -SET(HDF5_LIBRARY_NAMES "hdf5_hl;hdf5;hdf5_cpp" CACHE STRING "") -SET(HDF5_LIBRARY_DIRS /opt/intel-12.0.8/tpls/hdf5-1.8.5-patch1/lib CACHE FILEPATH "") -SET(HDF5_INCLUDE_DIRS /opt/intel-12.0.8/tpls/hdf5-1.8.5-patch1/include CACHE FILEPATH "") - -# Including these last to allow override above -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/casl-core-enables-disables.cmake) diff --git a/cmake/ctest/drivers/pu241/intel-12.0.8-serial-debug-ss-options.cmake b/cmake/ctest/drivers/pu241/intel-12.0.8-serial-debug-ss-options.cmake deleted file mode 100644 index b6c20da6eefa..000000000000 --- a/cmake/ctest/drivers/pu241/intel-12.0.8-serial-debug-ss-options.cmake +++ /dev/null @@ -1,8 +0,0 @@ -# -# checkin-test-fissile4.sh INTEL12_SERIAL_RELEASE build -# - -# Include last so that above override these cache variables -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-12.0.8-serial-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-debug-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/boost-1.49.0-options.cmake) diff --git a/cmake/ctest/drivers/pu241/intel-12.0.8-serial-options.cmake b/cmake/ctest/drivers/pu241/intel-12.0.8-serial-options.cmake deleted file mode 100644 index 077065b5cbb7..000000000000 --- a/cmake/ctest/drivers/pu241/intel-12.0.8-serial-options.cmake +++ /dev/null @@ -1,12 +0,0 @@ -# -# Primary Stable options for serial builds with Intel 12.0.4 compiler -# - -# Must be including first in order to define TRILINOS_TOOLSET_BASE -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-12.0.8-options.cmake) - -SET(TPL_ENABLE_MPI OFF CACHE BOOL "") - -SET(CMAKE_CXX_COMPILER "${INTEL_BIN}/icpc" CACHE FILEPATH "") -SET(CMAKE_C_COMPILER "${INTEL_BIN}/icc" CACHE FILEPATH "") -SET(CMAKE_Fortran_COMPILER "${INTEL_BIN}/ifort" CACHE FILEPATH "") diff --git a/cmake/ctest/drivers/pu241/intel-12.0.8-serial-release-ss-options.cmake b/cmake/ctest/drivers/pu241/intel-12.0.8-serial-release-ss-options.cmake deleted file mode 100644 index 564579a1bc05..000000000000 --- a/cmake/ctest/drivers/pu241/intel-12.0.8-serial-release-ss-options.cmake +++ /dev/null @@ -1,8 +0,0 @@ -# -# checkin-test-fissile4.sh INTEL12_SERIAL_DEBUG build -# - -# Include last so that above override these cache variables -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-12.0.8-serial-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-release-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/boost-1.49.0-options.cmake) diff --git a/cmake/ctest/drivers/pu241/intel-12.0.8-serial-ss-options.cmake b/cmake/ctest/drivers/pu241/intel-12.0.8-serial-ss-options.cmake deleted file mode 100644 index 1835632cca82..000000000000 --- a/cmake/ctest/drivers/pu241/intel-12.0.8-serial-ss-options.cmake +++ /dev/null @@ -1,7 +0,0 @@ -# -# checkin-test-fissile4.sh INTEL12_SERIAL_DEBUG build -# - -# Include last so that above override these cache variables -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-12.0.8-serial-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/boost-1.49.0-options.cmake) diff --git a/cmake/ctest/drivers/pu241/intel-12.0.8-ss-options.cmake b/cmake/ctest/drivers/pu241/intel-12.0.8-ss-options.cmake deleted file mode 100644 index bc7edf0bb9df..000000000000 --- a/cmake/ctest/drivers/pu241/intel-12.0.8-ss-options.cmake +++ /dev/null @@ -1,6 +0,0 @@ -# -# Secondary Stable Serial build with Intel 12.0.12.0.8 -# - -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/intel-12.0.8-options.cmake) -INCLUDE(${CMAKE_CURRENT_LIST_DIR}/boost-1.49.0-options.cmake) diff --git a/cmake/ctest/drivers/pu241/intel-debug-options.cmake b/cmake/ctest/drivers/pu241/intel-debug-options.cmake deleted file mode 100644 index 0db417f8307c..000000000000 --- a/cmake/ctest/drivers/pu241/intel-debug-options.cmake +++ /dev/null @@ -1,2 +0,0 @@ -SET(CMAKE_BUILD_TYPE DEBUG CACHE STRING "") -SET(CMAKE_Fortran_FLAGS_DEBUG_OVERRIDE "-O3" CACHE STRING "") diff --git a/cmake/ctest/drivers/pu241/intel-release-options.cmake b/cmake/ctest/drivers/pu241/intel-release-options.cmake deleted file mode 100644 index df8057cc3f00..000000000000 --- a/cmake/ctest/drivers/pu241/intel-release-options.cmake +++ /dev/null @@ -1,2 +0,0 @@ -SET(CMAKE_BUILD_TYPE RELEASE CACHE STRING "") -SET(CMAKE_Fortran_FLAGS_RELEASE_OVERRIDE "-O3" CACHE STRING "") diff --git a/cmake/ctest/drivers/pu241/mkl-11.1.064-options.cmake b/cmake/ctest/drivers/pu241/mkl-11.1.064-options.cmake deleted file mode 100644 index eb2f1482db75..000000000000 --- a/cmake/ctest/drivers/pu241/mkl-11.1.064-options.cmake +++ /dev/null @@ -1,12 +0,0 @@ - -SET(INTEL_11_1_064_ROOT /opt/intel/Compiler/11.1/064) -SET(MKLROOT ${INTEL_11_1_064_ROOT}/mkl) -SET(MKL_IFORT_MODULE_PATH ${MKLROOT}/include/em64t/lp64) -SET(MKLLIB "${MKLROOT}/lib/em64t") - -SET(BLAS_LIBRARY_NAMES "mkl_intel_lp64;mkl_blas95_lp64;mkl_core;mkl_sequential" - CACHE STRING "Sequential 64-bit BLAS with 32-bit integers") -SET(BLAS_LIBRARY_DIRS "${MKLLIB}" CACHE FILEPATH "") -SET(LAPACK_LIBRARY_NAMES "mkl_lapack95_lp64" - CACHE STRING "64-bit LAPACK with 32-bit integers") -SET(LAPACK_LIBRARY_DIRS "${MKLLIB}" CACHE FILEPATH "") diff --git a/cmake/ctest/drivers/pu241/mkl-12.0.4-options.cmake b/cmake/ctest/drivers/pu241/mkl-12.0.4-options.cmake deleted file mode 100644 index 7244df2026a7..000000000000 --- a/cmake/ctest/drivers/pu241/mkl-12.0.4-options.cmake +++ /dev/null @@ -1,13 +0,0 @@ - -SET(INTEL_12_0_4_ROOT /opt/intel/Compiler/composerxe-2011.4.191) -SET(MKLROOT ${INTEL_12_0_4_ROOT}/mkl) -SET(MKL_IFORT_MODULE_PATH ${MKLROOT}/include/intel64/lp64) -SET(MKL_GCC451_MODULE_PATH ${MKLROOT}/include/gcc-4.5.1) -SET(MKLLIB "${MKLROOT}/lib/intel64") - -SET(BLAS_LIBRARY_NAMES "mkl_intel_lp64;mkl_blas95_lp64;mkl_core;mkl_sequential" - CACHE STRING "Sequential 64-bit BLAS with 32-bit integers") -SET(BLAS_LIBRARY_DIRS "${MKLLIB}" CACHE FILEPATH "") -SET(LAPACK_LIBRARY_NAMES "mkl_lapack95_lp64" - CACHE STRING "64-bit LAPACK with 32-bit integers") -SET(LAPACK_LIBRARY_DIRS "${MKLLIB}" CACHE FILEPATH "") diff --git a/cmake/ctest/drivers/pu241/mkl-12.0.8-options.cmake b/cmake/ctest/drivers/pu241/mkl-12.0.8-options.cmake deleted file mode 100644 index 90d0250c3b26..000000000000 --- a/cmake/ctest/drivers/pu241/mkl-12.0.8-options.cmake +++ /dev/null @@ -1,13 +0,0 @@ - -SET(INTEL_12_0_8_ROOT /opt/intel-12.0.8) -SET(MKLROOT ${INTEL_12_0_8_ROOT}/mkl) -SET(MKL_IFORT_MODULE_PATH ${MKLROOT}/include/intel64/lp64) -#SET(MKL_GCC451_MODULE_PATH ${MKLROOT}/include/gcc-4.5.1) -SET(MKLLIB "${MKLROOT}/lib/intel64") - -SET(BLAS_LIBRARY_NAMES "mkl_intel_lp64;mkl_blas95_lp64;mkl_core;mkl_sequential" - CACHE STRING "Sequential 64-bit BLAS with 32-bit integers") -SET(BLAS_LIBRARY_DIRS "${MKLLIB}" CACHE FILEPATH "") -SET(LAPACK_LIBRARY_NAMES "mkl_lapack95_lp64" - CACHE STRING "64-bit LAPACK with 32-bit integers") -SET(LAPACK_LIBRARY_DIRS "${MKLLIB}" CACHE FILEPATH "") diff --git a/cmake/ctest/drivers/pu241/tbb-11.1.064-options.cmake b/cmake/ctest/drivers/pu241/tbb-11.1.064-options.cmake deleted file mode 100644 index 39694643b141..000000000000 --- a/cmake/ctest/drivers/pu241/tbb-11.1.064-options.cmake +++ /dev/null @@ -1,6 +0,0 @@ - -SET(INTEL_11_1_064_ROOT /opt/intel/Compiler/11.1/064) -SET(TBBROOT ${INTEL_11_1_064_ROOT}/tbb) - -SET(TBB_INCLUDE_DIRS ${TBBROOT}/include CACHE FILEPATH "") -SET(TBB_LIBRARY_DIRS ${TBBROOT}/lib/intel64 CACHE FILEPATH "") diff --git a/cmake/ctest/drivers/pu241/tbb-12.0.4-options.cmake b/cmake/ctest/drivers/pu241/tbb-12.0.4-options.cmake deleted file mode 100644 index c3cbb61d486a..000000000000 --- a/cmake/ctest/drivers/pu241/tbb-12.0.4-options.cmake +++ /dev/null @@ -1,6 +0,0 @@ - -SET(INTEL_12_0_4_ROOT /opt/intel/Compiler/composerxe-2011.4.191) -SET(TBBROOT ${INTEL_12_0_4_ROOT}/tbb) - -SET(TBB_INCLUDE_DIRS ${TBBROOT}/include CACHE FILEPATH "") -SET(TBB_LIBRARY_DIRS ${TBBROOT}/lib/intel64/cc4.1.0_libc2.4_kernel2.6.16.21 CACHE FILEPATH "") diff --git a/cmake/ctest/drivers/pu241/tbb-12.0.8-options.cmake b/cmake/ctest/drivers/pu241/tbb-12.0.8-options.cmake deleted file mode 100644 index 8925859ee4ed..000000000000 --- a/cmake/ctest/drivers/pu241/tbb-12.0.8-options.cmake +++ /dev/null @@ -1,6 +0,0 @@ - -SET(INTEL_12_0_8_ROOT /opt/intel-12.0.8) -SET(TBBROOT ${INTEL_12_0_8_ROOT}/tbb) - -SET(TBB_INCLUDE_DIRS ${TBBROOT}/include CACHE FILEPATH "") -SET(TBB_LIBRARY_DIRS ${TBBROOT}/lib/intel64/cc4.1.0_libc2.4_kernel2.6.16.21 CACHE FILEPATH "") diff --git a/cmake/ctest/drivers/pu241/trilinos-tpls-gcc.4.6.1.cmake b/cmake/ctest/drivers/pu241/trilinos-tpls-gcc.4.6.1.cmake deleted file mode 100644 index f952326e313b..000000000000 --- a/cmake/ctest/drivers/pu241/trilinos-tpls-gcc.4.6.1.cmake +++ /dev/null @@ -1,13 +0,0 @@ -# -# TPLs and other compiler-specific settings for Trilinos GCC 4.6.1 builds -# -# NOTE: This file only needs to get included when doing an actual configure, -# not during package dependency adjustment such as in the CI and Nightly -# CTest/CDash drivers. -# - -SET(HDF5_LIBRARY_NAMES "hdf5_hl;hdf5;hdf5_cpp" CACHE STRING "") -SET(HDF5_LIBRARY_DIRS /projects/gcc-4.6.1/tpls/hdf5-1.8.7/serial/lib CACHE FILEPATH "") -SET(HDF5_INCLUDE_DIRS /projects/gcc-4.6.1/tpls/hdf5-1.8.7/serial/include CACHE FILEPATH "") -SET(Netcdf_INCLUDE_DIRS /opt/gcc-4.6.1/tpls/netcdf-4.2/include CACHE FILEPATH "") -SET(Netcdf_LIBRARY_DIRS /opt/gcc-4.6.1/tpls/netcdf-4.2/lib CACHE FILEPATH "") diff --git a/cmake/ctest/drivers/rhel6-x86_64/MPI_OPT_GCC_4.4.7/ctest_linux_nightly_mpi_development_opt_gcc_4.4.7_rhel6-x86_64_xyce.cmake b/cmake/ctest/drivers/rhel6-x86_64/MPI_OPT_GCC_4.4.7/ctest_linux_nightly_mpi_development_opt_gcc_4.4.7_rhel6-x86_64_xyce.cmake deleted file mode 100644 index 1b2fa8177079..000000000000 --- a/cmake/ctest/drivers/rhel6-x86_64/MPI_OPT_GCC_4.4.7/ctest_linux_nightly_mpi_development_opt_gcc_4.4.7_rhel6-x86_64_xyce.cmake +++ /dev/null @@ -1,87 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../TrilinosCTestDriverCore.rhel6-x86_64.gcc4.4.7.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV_XYCE) -#SET(CTEST_TEST_TIMEOUT 900) -SET(CTEST_TEST_TYPE Nightly) - -#SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} PyTrilinos Kokkos Gtest RTOp Shards Thyra Xpetra Galeri Pamgen ML SEACAS Anasazi Stratimikos FEI Intrepid STK MueLu) -SET(Trilinos_PACKAGES NOX EpetraExt TrilinosCouplings Ifpack Isorropia AztecOO Belos Teuchos Amesos Sacado Zoltan Epetra Triutils) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DEpetraExt_BUILD_BTF=ON" - "-DTeuchos_ENABLE_COMPLEX=ON" - "-DNOX_ENABLE_LOCA=ON" - "-DTPL_ENABLE_ParMETIS:BOOL=OFF" - "-DTrilinos_ENABLE_ALL_OPTIONAL_PACKAGES=OFF" - "-DTrilinos_ENABLE_ALL_PACKAGES:BOOL=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/rhel6-x86_64/MPI_OPT_GCC_4.7.2/ctest_linux_nightly_mpi_development_debug_gcc_4.7.2_rhel6-x86_64.cmake b/cmake/ctest/drivers/rhel6-x86_64/MPI_OPT_GCC_4.7.2/ctest_linux_nightly_mpi_development_debug_gcc_4.7.2_rhel6-x86_64.cmake deleted file mode 100644 index c9be8476792e..000000000000 --- a/cmake/ctest/drivers/rhel6-x86_64/MPI_OPT_GCC_4.7.2/ctest_linux_nightly_mpi_development_debug_gcc_4.7.2_rhel6-x86_64.cmake +++ /dev/null @@ -1,111 +0,0 @@ -# @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 - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../TrilinosCTestDriverCore.rhel6-x86_64.gcc4.7.2-sems.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME openmpi-1.6.5_Debug_DEV_Werror) -#SET(CTEST_TEST_TIMEOUT 900) - -# Note: To send output to the "Specialized" track on CDash, we need to -# set Trilinos_TRACK to "Specialized" and set CTEST_TEST_TYPE to -# something other than "Experimental". -# Since "Nightly" "Continuous" and "Experimental" are special to -# Tribits, we'll set CTEST_TEST_TYPE to "Nightly" here. -SET(CTEST_TEST_TYPE Nightly) -SET(Trilinos_TRACK Specialized) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(EXTRA_EXCLUDE_PACKAGES MOOCHO Optika PyTrilinos Didasko) - -# -# SET(Trilinos_PACKAGES NOX EpetraExt TrilinosCouplings -# Ifpack Isorropia AztecOO -# Belos Teuchos Amesos -# Sacado Zoltan Epetra -# Triutils ) - -SET(EXTRA_CONFIGURE_OPTIONS - ${EXTRA_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DTPL_ENABLE_Netcdf:BOOL=ON" - "-DTPL_ENABLE_SuperLU:BOOL=ON" - - "-DTrilinos_SHOW_DEPRECATED_WARNINGS=OFF" - - "-DTrilinos_ENABLE_MOOCHO=OFF" - "-DTrilinos_ENABLE_Optika=OFF" - "-DTrilinos_ENABLE_Didasko=OFF" - - "-DZoltan2_ENABLE_Experimental:BOOL=ON" - - "-DCMAKE_CXX_FLAGS:STRING=-Wall -ansi -pedantic -Werror -Wno-unknown-pragmas -Wno-narrowing -Wno-pragmas -Wno-delete-non-virtual-dtor" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/rhel6-x86_64/MPI_OPT_GCC_4.9.3/ctest_linux_nightly_mpi_development_debug_gcc_4.9.3_rhel6-x86_64.cmake b/cmake/ctest/drivers/rhel6-x86_64/MPI_OPT_GCC_4.9.3/ctest_linux_nightly_mpi_development_debug_gcc_4.9.3_rhel6-x86_64.cmake deleted file mode 100644 index 20a35cae5917..000000000000 --- a/cmake/ctest/drivers/rhel6-x86_64/MPI_OPT_GCC_4.9.3/ctest_linux_nightly_mpi_development_debug_gcc_4.9.3_rhel6-x86_64.cmake +++ /dev/null @@ -1,117 +0,0 @@ -# @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 - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../TrilinosCTestDriverCore.rhel6-x86_64.gcc4.9.3-sems.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME openmpi-1.8.7_Debug_DEV_Werror) -#SET(CTEST_TEST_TIMEOUT 900) - -# Note: To send output to the "Specialized" track on CDash, we need to -# set Trilinos_TRACK to "Specialized" and set CTEST_TEST_TYPE to -# something other than "Experimental". -# Since "Nightly" "Continuous" and "Experimental" are special to -# Tribits, we'll set CTEST_TEST_TYPE to "Nightly" here. -SET(CTEST_TEST_TYPE Nightly) -SET(Trilinos_TRACK Specialized) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(EXTRA_EXCLUDE_PACKAGES MOOCHO Optika PyTrilinos Didasko) - -# -# SET(Trilinos_PACKAGES NOX EpetraExt TrilinosCouplings -# Ifpack Isorropia AztecOO -# Belos Teuchos Amesos -# Sacado Zoltan Epetra -# Triutils ) - -SET(EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DTPL_ENABLE_Netcdf:BOOL=ON" - - "-DTPL_ENABLE_SuperLU:BOOL=ON" - - "-DTrilinos_SHOW_DEPRECATED_WARNINGS=OFF" - - "-DTrilinos_ENABLE_MOOCHO=OFF" - "-DTrilinos_ENABLE_Optika=OFF" - "-DTrilinos_ENABLE_Didasko=OFF" - - "-DZoltan2_ENABLE_Experimental:BOOL=ON" - - # wcm: 2017-04-14: Added -Wno-unused-local-typedefs (EXPERIMENTAL). GCC 4.9.3 includes -Wunused-local-typedefs in -Wall - # but GCC 4.7.2 did not include that by default. I added it here to see how much this cleans the build - # on my experimental jenkins build towards moving things into sync with the 4.7.2 Werrr build. - # wcm: 2017-04-16: Adding -Wno-unused-function (EXPERIMENTAL). Trying this out because the GCC 4.9.3 -Werror - # build seems to fail on some unit tests in Thyra on unused functions. Curious that GCC 4.7.2 is supposed - # to enable -Werror=unused-functions when -Wall is enabled but it doesn't fail on Thyra. - "-DCMAKE_CXX_FLAGS:STRING=-Wall -ansi -pedantic -Werror -Wno-unknown-pragmas -Wno-narrowing -Wno-pragmas -Wno-delete-non-virtual-dtor -Wno-unused-local-typedefs" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/rhel6-x86_64/SERIAL_OPT_GCC_4.7.2/CMakeLists.txt b/cmake/ctest/drivers/rhel6-x86_64/SERIAL_OPT_GCC_4.7.2/CMakeLists.txt deleted file mode 100644 index 26ea676f6e25..000000000000 --- a/cmake/ctest/drivers/rhel6-x86_64/SERIAL_OPT_GCC_4.7.2/CMakeLists.txt +++ /dev/null @@ -1,28 +0,0 @@ -INCLUDE("../../../../../Version.cmake") - -TRILINOS_DRIVER_SETUP() - -set(CTEST_EXE "${CMAKE_CTEST_COMMAND}") -set(workingdir "${TrilinosDriver_BINARY_DIR}") - -# Get the day of the week -execute_process(COMMAND date +%A OUTPUT_VARIABLE DAYOFWEEK) - -IF(${Trilinos_REPOSITORY_BRANCH} STREQUAL "develop") - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_OPT_DEV - ctest_linux_nightly_serial_development_opt_gcc_4.7.2_rhel6-x86_64.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 300 - ) - -#if(${DAYOFWEEK} MATCHES "Saturday") -#endif() - -ELSE() -#release tests would go here -ENDIF() - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() - diff --git a/cmake/ctest/drivers/rhel6-x86_64/SERIAL_OPT_GCC_4.7.2/cron_driver.sh b/cmake/ctest/drivers/rhel6-x86_64/SERIAL_OPT_GCC_4.7.2/cron_driver.sh deleted file mode 100755 index a9752cb0ef32..000000000000 --- a/cmake/ctest/drivers/rhel6-x86_64/SERIAL_OPT_GCC_4.7.2/cron_driver.sh +++ /dev/null @@ -1,47 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on standard rhel6-x86_64: `date`" -echo - -# TrilinosDriver settings: -# -#update this after git is installed on the NFS mount -export TDD_GIT_EXE=/usr/bin/git - -export TDD_DRIVER_SUBDIRECTORY=rhel6-x86_64/SERIAL_OPT_GCC_4.7.2 -export TDD_PARALLEL_LEVEL=2 -export TDD_HTTP_PROXY="http://wwwproxy.sandia.gov:80/" - -# Trilinos settings: -# -export TDD_CTEST_TEST_TYPE=Nightly - -# Machine specific environment: -# -#export PATH=/usr/local/bin:/bin:/usr/bin/$PATH:/home/trilinos/tpl/gcc4.4.4/qt-4.5.2/bin - -# BASEDIR is the parent directory of this script's Trilinos source tree... -BASEDIR=`cd "\`dirname \"$0\"\`/../../../../..";pwd` -echo BASEDIR=$BASEDIR -BASEDATADIR=$BASEDIR - -export CVS_RSH=ssh - -#export LD_LIBRARY_PATH=/home/trilinos/compilers/gcc/support_libs/mpc-1.0.1/lib:/home/trilinos/compilers/gcc/support_libs/mpfr-3.1.2/lib:/home/trilinos/compilers/gcc/support_libs/gmp-5.1.1/lib:/home/trilinos/compilers/gcc/4.7.2/lib64:$LD_LIBRARY_PATH -#export PYTHONPATH="/home/trilinos/tpl/gcc4.4.4/mpi4py-1.3/lib64/python2.6:/home/trilinos/tpl/gcc4.4.4/numpy-1.6.2/lib64/python2.6/site-packages/" -export TRILINOSDATADIRECTORY="$BASEDATADIR/TrilinosData" - -pushd "$BASEDATADIR" -cvs -q -d :ext:software.sandia.gov:/space/CVS co TrilinosData -popd - -# Machine independent cron_driver: -# -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` -$SCRIPT_DIR/../../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on standard rhel6-x86_64: `date`" -echo - diff --git a/cmake/ctest/drivers/rhel6-x86_64/SERIAL_OPT_GCC_4.7.2/ctest_linux_nightly_serial_development_opt_gcc_4.7.2_rhel6-x86_64.cmake b/cmake/ctest/drivers/rhel6-x86_64/SERIAL_OPT_GCC_4.7.2/ctest_linux_nightly_serial_development_opt_gcc_4.7.2_rhel6-x86_64.cmake deleted file mode 100644 index e51da8dc8601..000000000000 --- a/cmake/ctest/drivers/rhel6-x86_64/SERIAL_OPT_GCC_4.7.2/ctest_linux_nightly_serial_development_opt_gcc_4.7.2_rhel6-x86_64.cmake +++ /dev/null @@ -1,93 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../TrilinosCTestDriverCore.rhel6-x86_64.gcc4.7.2.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_OPT_DEV) -SET(COMPILER_VERSION "GCC-4.7.2") -SET(ENV{LD_LIBRARY_PATH} "/projects/install/rhel6-x86_64/sems/compiler/gcc/4.7.2/base/lib64:$ENV{LD_LIBRARY_PATH}") -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) -#Stokhos is explicitly disabled below to prevent the package from being -#implicitly enabled. Sundance depends on Stokhos. -SET(EXTRA_EXCLUDE_PACKAGES Phalanx Stokhos Sundance Zoltan2 Panzer PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DCMAKE_CXX_COMPILER:FILEPATH=/projects/install/rhel6-x86_64/sems/compiler/gcc/4.7.2/base/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/projects/install/rhel6-x86_64/sems/compiler/gcc/4.7.2/base/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/projects/install/rhel6-x86_64/sems/compiler/gcc/4.7.2/base/bin/gfortran" - "-DTrilinos_ENABLE_Stokhos:BOOL=OFF" - "-DTPL_ENABLE_HDF5:BOOL=OFF" - "-DTPL_ENABLE_SuperLU:BOOL=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/rhel6-x86_64/TrilinosCTestDriverCore.rhel6-x86_64.gcc4.4.7.cmake b/cmake/ctest/drivers/rhel6-x86_64/TrilinosCTestDriverCore.rhel6-x86_64.gcc4.4.7.cmake deleted file mode 100644 index 2d8afb2ceaf5..000000000000 --- a/cmake/ctest/drivers/rhel6-x86_64/TrilinosCTestDriverCore.rhel6-x86_64.gcc4.4.7.cmake +++ /dev/null @@ -1,139 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for trilinos-test using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_BUILD_FLAGS "-j3 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "3" ) - - SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DCOVERAGE_COMMAND:FILEPATH=/usr/bin/gcov" - "-DMEMORYCHECK_COMMAND:FILEPATH=/usr/bin/valgrind" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DTPL_ENABLE_Matio=OFF" - "-DTrilinos_ENABLE_CXX11=OFF" - "-DCMAKE_MAKE_PROGRAM=make" - "-DCMAKE_CXX_FLAGS='-O3 -fPIC'" - "-DCMAKE_C_FLAGS='-O3 -fPIC'" - "-DParMETIS_LIBRARY_DIRS=$ENV{SEMS_PARMETIS_LIBRARY_PATH}" - "-DParMETIS_INCLUDE_DIRS=$ENV{SEMS_PARMETIS_INCLUDE_PATH}" - ) - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - SET_DEFAULT(COMPILER_VERSION "GCC-4.4.7") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR:PATH=$ENV{SEMS_OPENMPI_ROOT}" - ) -# "-DCMAKE_C_COMPILER=/usr/lib64/openmpi/bin/mpicc" -# "-DCMAKE_CXX_COMPILER=/usr/lib64/openmpi/bin/mpic++" -# "-DCMAKE_Fortran_COMPILER=/usr/lib64/openmpi/bin/mpif77" -# "-DMPI_EXEC=/usr/lib64/openmpi/bin/mpiexec" -# ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_openmpi_1.2.7.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ELSE() - -# SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS -# ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} -# "-DCMAKE_CXX_COMPILER:FILEPATH=/home/trilinos/gcc4.7.2/base/bin/g++" -# "-DCMAKE_C_COMPILER:FILEPATH=/home/trilinos/gcc4.7.2/base/bin/gcc" -# "-DCMAKE_Fortran_COMPILER:FILEPATH=/home/trilinos/gcc4.7.2/base/bin/gfortran" -# ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_gcc-4.1.2.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/rhel6-x86_64/TrilinosCTestDriverCore.rhel6-x86_64.gcc4.7.2-sems.cmake b/cmake/ctest/drivers/rhel6-x86_64/TrilinosCTestDriverCore.rhel6-x86_64.gcc4.7.2-sems.cmake deleted file mode 100644 index c3d29d6ae626..000000000000 --- a/cmake/ctest/drivers/rhel6-x86_64/TrilinosCTestDriverCore.rhel6-x86_64.gcc4.7.2-sems.cmake +++ /dev/null @@ -1,162 +0,0 @@ -# @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 - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for trilinos-test using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "24" ) - SET( CTEST_BUILD_FLAGS "-j24 -i" ) - - SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota ) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - - "-DBUILD_SHARED_LIBS:BOOL=ON" - "-DCOVERAGE_COMMAND:FILEPATH=/usr/bin/gcov" - "-DMEMORYCHECK_COMMAND:FILEPATH=/usr/bin/valgrind" - - "-DTrilinos_PRE_REPOSITORIES=''" - "-DTrilinos_EXTRA_REPOSITORIES=''" - "-DTrilinos_ENABLE_DEPENDENCY_UNIT_TESTS:BOOL=OFF" - - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - - "-DTrilinos_ENABLE_CXX11=ON" - "-DTrilinos_CXX11_FLAGS:STRING=--std=c++11" - - "-DTPL_ENABLE_BLAS:BOOL=ON" - "-DTPL_ENABLE_LAPACK:BOOL=ON" - "-DTPL_ENABLE_Matio:BOOL=OFF" - - "-DSuperLU_INCLUDE_DIRS:PATH=$ENV{SEMS_SUPERLU_ROOT}/include" - "-DSuperLU_LIBRARY_DIRS:PATH=$ENV{SEMS_SUPERLU_ROOT}/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu" - - "-DBoost_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_BOOST_ROOT}/include" - "-DBoost_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_BOOST_ROOT}/lib" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_BOOST_ROOT}/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_BOOST_ROOT}/lib" - - "-DHDF5_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_HDF5_ROOT}/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_HDF5_ROOT}/lib" - - "-DNetcdf_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_NETCDF_ROOT}/include" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_NETCDF_ROOT}/lib" - - "-DZlib_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_ZLIB_ROOT}/include" - "-DZlib_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_ZLIB_ROOT}/lib" - - "-DIntrepidCore_ENABLE_DEBUG_INF_CHECK=OFF" - ) - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - SET_DEFAULT(COMPILER_VERSION "GCC-4.7.2") - - IF (COMM_TYPE STREQUAL MPI) - - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR=$ENV{SEMS_OPENMPI_ROOT}" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_openmpi_1.2.7.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=$ENV{CXX}" - "-DCMAKE_C_COMPILER:FILEPATH=$ENV{CC}" - "-DCMAKE_Fortran_COMPILER:FILEPATH=$ENV{FC}" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_gcc-4.1.2.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() - - diff --git a/cmake/ctest/drivers/rhel6-x86_64/TrilinosCTestDriverCore.rhel6-x86_64.gcc4.7.2.cmake b/cmake/ctest/drivers/rhel6-x86_64/TrilinosCTestDriverCore.rhel6-x86_64.gcc4.7.2.cmake deleted file mode 100644 index 9219cd64f726..000000000000 --- a/cmake/ctest/drivers/rhel6-x86_64/TrilinosCTestDriverCore.rhel6-x86_64.gcc4.7.2.cmake +++ /dev/null @@ -1,129 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for trilinos-test using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_BUILD_FLAGS "-j8 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "8" ) - - SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DCOVERAGE_COMMAND:FILEPATH=/usr/bin/gcov" - "-DMEMORYCHECK_COMMAND:FILEPATH=/usr/bin/valgrind" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DTPL_ENABLE_Matio=OFF" - "-DIntrepidCore_ENABLE_DEBUG_INF_CHECK=OFF" - ) - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - SET_DEFAULT(COMPILER_VERSION "GCC-4.7.2") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR=/projects/install/rhel6-x86_64/sems/compiler/gcc/4.7.2/openmpi/1.6.5" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_openmpi_1.2.7.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/projects/install/rhel6-x86_64/sems/compiler/gcc/4.7.2/base/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/projects/install/rhel6-x86_64/sems/compiler/gcc/4.7.2/base/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/projects/install/rhel6-x86_64/sems/compiler/gcc/4.7.2/base/bin/gfortran" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_gcc-4.1.2.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/rhel6-x86_64/TrilinosCTestDriverCore.rhel6-x86_64.gcc4.9.3-sems.cmake b/cmake/ctest/drivers/rhel6-x86_64/TrilinosCTestDriverCore.rhel6-x86_64.gcc4.9.3-sems.cmake deleted file mode 100644 index d1a94c6775b8..000000000000 --- a/cmake/ctest/drivers/rhel6-x86_64/TrilinosCTestDriverCore.rhel6-x86_64.gcc4.9.3-sems.cmake +++ /dev/null @@ -1,164 +0,0 @@ -# @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 - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for trilinos-test using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "24" ) - SET( CTEST_BUILD_FLAGS "-j24 -i" ) - - SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota ) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - - "-DBUILD_SHARED_LIBS:BOOL=ON" - "-DCOVERAGE_COMMAND:FILEPATH=/usr/bin/gcov" - "-DMEMORYCHECK_COMMAND:FILEPATH=/usr/bin/valgrind" - - "-DTrilinos_PRE_REPOSITORIES=''" - "-DTrilinos_EXTRA_REPOSITORIES=''" - "-DTrilinos_ENABLE_DEPENDENCY_UNIT_TESTS:BOOL=OFF" - - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - - "-DTrilinos_ENABLE_CXX11=ON" - "-DTrilinos_CXX11_FLAGS:STRING=--std=c++11" - - "-DTPL_ENABLE_BLAS:BOOL=ON" - "-DTPL_ENABLE_LAPACK:BOOL=ON" - "-DTPL_ENABLE_Matio:BOOL=OFF" - - "-DSuperLU_INCLUDE_DIRS:PATH=$ENV{SEMS_SUPERLU_ROOT}/include" - "-DSuperLU_LIBRARY_DIRS:PATH=$ENV{SEMS_SUPERLU_ROOT}/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu" - - "-DBoost_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_BOOST_ROOT}/include" - "-DBoost_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_BOOST_ROOT}/lib" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_BOOST_ROOT}/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_BOOST_ROOT}/lib" - - "-DHDF5_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_HDF5_ROOT}/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_HDF5_ROOT}/lib" - - "-DNetcdf_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_NETCDF_ROOT}/include" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_NETCDF_ROOT}/lib" - - "-DZlib_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_ZLIB_ROOT}/include" - "-DZlib_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_ZLIB_ROOT}/lib" - - "-DIntrepidCore_ENABLE_DEBUG_INF_CHECK=OFF" - ) - # The Werror build in muir sets GLM_INCLUDE_DIRS, but this may not be needed. - #"-DGLM_INCLUDE_DIRS:PATH=$ENV{SEMS_GCC_ROOT}/???" - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - SET_DEFAULT(COMPILER_VERSION "GCC-4.9.3") - - IF (COMM_TYPE STREQUAL MPI) - - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR=$ENV{SEMS_OPENMPI_ROOT}" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_openmpi_1.2.7.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=$ENV{CXX}" - "-DCMAKE_C_COMPILER:FILEPATH=$ENV{CC}" - "-DCMAKE_Fortran_COMPILER:FILEPATH=$ENV{FC}" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_gcc-4.1.2.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() - - diff --git a/cmake/ctest/drivers/rhel6-x86_64/ctest_linux_nightly_jenkins_zoltan2.cmake b/cmake/ctest/drivers/rhel6-x86_64/ctest_linux_nightly_jenkins_zoltan2.cmake deleted file mode 100644 index 19313d7196b2..000000000000 --- a/cmake/ctest/drivers/rhel6-x86_64/ctest_linux_nightly_jenkins_zoltan2.cmake +++ /dev/null @@ -1,164 +0,0 @@ -# @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 - -# For cdash testing setup we disabled updates -IF( DEFINED ENV{CUSTOM_ENV_VARIABLES} ) - SET(CTEST_DO_UPDATES FALSE) -ENDIF() - -# Turn these on to disable Cdash testing -# SET(CTEST_DO_SUBMIT FALSE) -# SET(CTEST_SUBMIT_CDASH_SUBPROJECTS_DEPS_FILE FALSE) - -# This probably gets changed in the final setup -SET( CTEST_BUILD_NAME $ENV{JENKINS_CTEST_BUILD_NAME} ) - -# Currently just for Tech-X setup and not for normal Trilinos CDash testing -# We had to change the target build directories -IF( DEFINED ENV{CUSTOM_ENV_VARIABLES} ) - SET( CTEST_BINARY_DIRECTORY "$ENV{OVERRIDE_BINARY_LOCATION_ROOT}/${CTEST_BUILD_NAME}" ) - SET( CTEST_SOURCE_DIRECTORY "${CTEST_SCRIPT_DIRECTORY}/../../../../../Trilinos" ) -ENDIF() - -SET(CTEST_PARALLEL_LEVEL 8) -SET(CTEST_TEST_TYPE Experimental) -SET(CTEST_TEST_TIMEOUT 900) -SET(CTEST_START_WITH_EMPTY_BINARY_DIRECTORY FALSE) - -# Set up the Jenkins parameters -SET(COMM_TYPE $ENV{JENKINS_COMM_TYPE} ) -SET(BUILD_TYPE $ENV{JENKINS_BUILD_TYPE} ) - -# Clear out the base variables - this is probably not necessary anymore -SET( Trilinos_PACKAGES Zoltan2 ) -Set( EXTRA_EXCLUDE_PACKAGES "" ) # Start empty -Set( EXTRA_CONFIGURE_OPTIONS "" ) # Start empty - -# Macro helper to write a Bool value but skip if string is blank -MACRO( setConfig jenkinsValue trilinosSetting ) - # MESSAGE( "setConfig called with ${jenkinsValue} ${trilinosSetting}" ) - IF( NOT ${jenkinsValue} STREQUAL "BLANK" OR ${jenkinsValue} STREQUAL "" ) - SET( EXTRA_CONFIGURE_OPTIONS ${EXTRA_CONFIGURE_OPTIONS} "-D${trilinosSetting}=${jenkinsValue}" ) - ENDIF() -ENDMACRO() - -# Macro helper to setup a package - currently investigating 4 options -# "BLANK" or "" - Do nothing - no entry added -# "EXCLUDE" - Add to EXTRA_EXCLUDE_PACKAGES and set config setting FALSE -# "INCLUDE" - Add to Trilinos_PACKAGES and set config setting FALSE -# Set based on Bool value - which can be TRUE, FALSE -MACRO( checkPackage jenkinsValue trilinosSetting packageName ) - # MESSAGE( "checkPackage called with ${jenkinsValue} ${trilinosSetting} ${packageName}" ) - IF( ${jenkinsValue} STREQUAL "BLANK" OR ${jenkinsValue} STREQUAL "" ) - # Do nothing - ELSEIF( ${jenkinsValue} STREQUAL "EXCLUDE" ) - # Add to exclude and turn off - SET(EXTRA_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} ${packageName}) - SET( EXTRA_CONFIGURE_OPTIONS ${EXTRA_CONFIGURE_OPTIONS} "-D${trilinosSetting}=FALSE" ) - ELSEIF( ${jenkinsValue} STREQUAL "INCLUDE" ) - # Add to Trilinos_PACKAGES and turn on - SET(Trilinos_PACKAGES ${Trilinos_PACKAGES} ${packageName}) - SET( EXTRA_CONFIGURE_OPTIONS ${EXTRA_CONFIGURE_OPTIONS} "-D${trilinosSetting}=TRUE" ) - ELSE() # Set TRUE or FALSE based on setting - can be ON or OFF as well - SET( EXTRA_CONFIGURE_OPTIONS ${EXTRA_CONFIGURE_OPTIONS} "-D${trilinosSetting}=${jenkinsValue}" ) - ENDIF() -ENDMACRO() - -# Turning this off has caused difficulties as the code system hard codes it to true -# In our current working system we add this false but also add optionals to -# the EXTRA_EXCLUDE_PACKAGES if we don't want them to build in the first place -setConfig( $ENV{JENKINS_ENABLE_ALL_OPTIONAL_PACKAGES} Trilinos_ENABLE_ALL_OPTIONAL_PACKAGES ) - -setConfig( $ENV{JENKINS_ENABLE_EXPLICIT_INSTANTIATION} Trilinos_ENABLE_EXPLICIT_INSTANTIATION ) - -# setCong skips the addition of the config element if the string is blank: "" -setConfig( $ENV{JENKINS_TPL_ENABLE_PARMETIS} TPL_ENABLE_ParMETIS ) -setConfig( $ENV{JENKINS_TPL_ENABLE_SCOTCH} TPL_ENABLE_Scotch ) - -# This exists so we can handle the STK_DATA_TYPES define used in Zoltan2 -setConfig( $ENV{JENKINS_CMAKE_CXX_FLAGS} "CMAKE_CXX_FLAGS" ) - -# These settings write for TRUE or FALSE - we want to turn them off if FALSE -setConfig( $ENV{JENKINS_Tpetra_INST_DOUBLE} Tpetra_INST_DOUBLE ) -setConfig( $ENV{JENKINS_Tpetra_INST_FLOAT} Tpetra_INST_FLOAT ) -setConfig( $ENV{JENKINS_Tpetra_INST_INT_INT} Tpetra_INST_INT_INT ) -setConfig( $ENV{JENKINS_Tpetra_INST_INT_UNSIGNED} Tpetra_INST_INT_UNSIGNED ) -setConfig( $ENV{JENKINS_Tpetra_INST_INT_UNSIGNED_LONG} Tpetra_INST_INT_UNSIGNED_LONG ) -setConfig( $ENV{JENKINS_Tpetra_INST_INT_LONG} Tpetra_INST_INT_LONG ) -setConfig( $ENV{JENKINS_Tpetra_INST_INT_LONG_LONG} Tpetra_INST_INT_LONG_LONG ) - -# Special handling of the packages for cdash - handles Blank, TRUE, FALSE, EXCLUDE, or INCLUDE -checkPackage( $ENV{JENKINS_USE_EPETRA} Trilinos_ENABLE_Epetra Epetra ) -checkPackage( $ENV{JENKINS_USE_THYRA} Trilinos_ENABLE_Thyra Thyra ) -checkPackage( $ENV{JENKINS_USE_XPETRA} Trilinos_ENABLE_Xpetra Xpetra ) -checkPackage( $ENV{JENKINS_USE_GALERI} Trilinos_ENABLE_Galeri Galeri ) -checkPackage( $ENV{JENKINS_USE_PAMGEN} Trilinos_ENABLE_Pamgen Pamgen ) -checkPackage( $ENV{JENKINS_USE_EPETRAEXT} Trilinos_ENABLE_EpetraExt EpetraExt ) -checkPackage( $ENV{JENKINS_USE_TRIUTILS} Trilinos_ENABLE_TriUtils TriUtils ) -checkPackage( $ENV{JENKINS_USE_ZOLTAN} Trilinos_ENABLE_Zoltan Zoltan ) -checkPackage( $ENV{JENKINS_USE_RTOP} Trilinos_ENABLE_RTOp RTOp ) - -# Skipping this will cause problems if Trilinos_ENABLE_ALL_OPTIONAL_PACKAGES is OFF -checkPackage( TRUE Trilinos_ENABLE_Zoltan2 Zoltan2 ) - -# MESSAGE( "Zoltan2 test: ${CTEST_BUILD_NAME} setup:" ) -# MESSAGE( "EXTRA_CONFIGURE_OPTIONS set to: ${EXTRA_CONFIGURE_OPTIONS}" ) -# MESSAGE( "EXTRA_EXCLUDE_PACKAGES set to ${EXTRA_EXCLUDE_PACKAGES}" ) -# MESSAGE( "Trilinos_PACKAGES set to ${Trilinos_PACKAGES}" ) - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.generic.jenkins.cmake") - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() - diff --git a/cmake/ctest/drivers/ride/CMakeLists.txt b/cmake/ctest/drivers/ride/CMakeLists.txt deleted file mode 100644 index 2b151bf8c654..000000000000 --- a/cmake/ctest/drivers/ride/CMakeLists.txt +++ /dev/null @@ -1,11 +0,0 @@ -TRILINOS_DRIVER_SETUP() - -TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_Downstream_ETI_SERIAL-${Tpetra_INST_SERIAL}_OPENMP-${Tpetra_INST_OPENMP}_PTHREAD-${Tpetra_INST_PTHREAD}_CUDA-${Tpetra_INST_CUDA}_COMPLEX-${Teuchos_ENABLE_COMPLEX} - ctest_linux_nightly_mpi_release_downstream_ETI_generic_ride.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 420 -) - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/ride/TrilinosCTestDriverCore.ride.generic.cmake b/cmake/ctest/drivers/ride/TrilinosCTestDriverCore.ride.generic.cmake deleted file mode 100644 index 7c8ddd581141..000000000000 --- a/cmake/ctest/drivers/ride/TrilinosCTestDriverCore.ride.generic.cmake +++ /dev/null @@ -1,130 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for typhon using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j16 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "1" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENDENCY_UNIT_TESTS:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=ON" - - "-D Trilinos_ENABLE_CXX11=ON" - "-D Trilinos_CXX11_FLAGS:STRING=--std=c++11" - - "-DTPL_ENABLE_BLAS:BOOL=ON" - "-DTPL_ENABLE_LAPACK:BOOL=ON" - "-DSuperLU_INCLUDE_DIRS:PATH=$ENV{SUPERLU_ROOT}/include" - "-DSuperLU_LIBRARY_DIRS:PATH=$ENV{SUPERLU_ROOT}/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu_4.3" - "-DBoost_INCLUDE_DIRS:FILEPATH=$ENV{BOOST_ROOT}/include" - "-DBoost_LIBRARY_DIRS:FILEPATH=$ENV{BOOST_ROOT}/lib" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=$ENV{BOOST_ROOT}/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=$ENV{BOOST_ROOT}/lib" - "-DHDF5_INCLUDE_DIRS:FILEPATH=$ENV{HDF5_ROOT}/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=$ENV{HDF5_ROOT}/lib" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=$ENV{NETCDF_ROOT}/include" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=$ENV{NETCDF_ROOT}/lib" - "-DZlib_INCLUDE_DIRS:FILEPATH=$ENV{ZLIB_ROOT}/include" - "-DZlib_LIBRARY_DIRS:FILEPATH=$ENV{ZLIB_ROOT}/lib" - "-DTPL_ENABLE_X11:BOOL=OFF" - "-DTPL_ENABLE_Matio=OFF" - - ) - - SET_DEFAULT(COMPILER_VERSION "GCC-4.8.4") - - #Ensuring that MPI is on for all parallel builds that might be run. - IF(COMM_TYPE STREQUAL MPI) - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR=$ENV{MPI_ROOT}" - "-D MPI_CXX_COMPILER:FILEPATH=$ENV{MPI_ROOT}/bin/mpicxx" - "-D MPI_C_COMPILER:FILEPATH=$ENV{MPI_ROOT}/bin/mpicc" - "-D MPI_FORTRAN_COMPILER:FILEPATH=$ENV{MPI_ROOT}/bin/mpifort" - "-D CMAKE_CXX_COMPILER:FILEPATH=$ENV{MPI_ROOT}/bin/mpicxx" - "-D CMAKE_C_COMPILER:FILEPATH=$ENV{MPI_ROOT}/bin/mpicc" - "-D CMAKE_Fortran_COMPILER:FILEPATH=$ENV{MPI_ROOT}/bin/mpifort" - "-D MPI_EXEC:FILEPATH=$ENV{MPI_RUNNER}" - "-DMPI_EXEC_POST_NUMPROCS_FLAGS:STRING=--bind-to-socket" - - ) - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/ride/cron_driver.sh b/cmake/ctest/drivers/ride/cron_driver.sh deleted file mode 100755 index c833c2eb6fa8..000000000000 --- a/cmake/ctest/drivers/ride/cron_driver.sh +++ /dev/null @@ -1,58 +0,0 @@ -#!/bin/bash - -#necessary because the testbeds don't setup modules by -#default on the login node or compute nodes. -source /etc/profile.d/modules.sh - -# -# TrilinosDriver settings: -# - -export TDD_PARALLEL_LEVEL=1 - -# Trilinos settings: -# - -# Submission mode for the *TrilinosDriver* dashboard -export TDD_CTEST_TEST_TYPE=${JENKINS_JOB_TYPE} - -#export CTEST_DO_SUBMIT=FALSE -#export CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=FALSE - -# Machine specific environment -# -module load python/2.7.12 -export PATH=/home/rabartl/install/white-ride/cmake-3.11.2/bin:$PATH -module load git/2.10.1 - -export TRIBITS_TDD_USE_SYSTEM_CTEST=1 -export CUDA_LAUNCH_BLOCKING=1 -export CUDA_MANAGED_FORCE_DEVICE_ALLOC=1 -export OMP_NUM_THREADS=2 - -# Machine independent cron_driver: -# -#openmpi-1.7-cuda6 - -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` - -if [ "${JENKINS_DO_CUDA}" == 'ON' ]; then - module load ${CUDA_SUFFIX} - module load ${MPI_SUFFIX}/${COMPILER_SUFFIX}/${CUDA_SUFFIX} - export OMPI_CXX=$WORKSPACE/Trilinos/packages/kokkos/config/nvcc_wrapper -else - module load ${MPI_SUFFIX}/${COMPILER_SUFFIX} -fi - -module load ${BOOST_SUFFIX}/${MPI_SUFFIX}/${COMPILER_SUFFIX}/${CUDA_SUFFIX} -module load ${HDF5_SUFFIX}/${MPI_SUFFIX}/${COMPILER_SUFFIX}/${CUDA_SUFFIX} -module load ${NETCDF_SUFFIX}/${MPI_SUFFIX}/${COMPILER_SUFFIX}/${CUDA_SUFFIX} -module load ${ZLIB_SUFFIX} -module load ${SUPERLU_SUFFIX}/${COMPILER_SUFFIX} -#module load ${BLAS_SUFFIX}/${COMPILER_SUFFIX} -#module load ${LAPACK_SUFFIX}/${COMPILER_SUFFIX} - -module list - -$SCRIPT_DIR/../cron_driver.py - diff --git a/cmake/ctest/drivers/ride/ctest_linux_nightly_mpi_release_downstream_ETI_generic_ride.cmake b/cmake/ctest/drivers/ride/ctest_linux_nightly_mpi_release_downstream_ETI_generic_ride.cmake deleted file mode 100644 index cfcb1ab3fc97..000000000000 --- a/cmake/ctest/drivers/ride/ctest_linux_nightly_mpi_release_downstream_ETI_generic_ride.cmake +++ /dev/null @@ -1,98 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.ride.generic.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_RELEASE_DEV_DownStream_ETI_SERIAL-$ENV{JENKINS_DO_SERIAL}_OPENMP-$ENV{JENKINS_DO_OPENMP}_PTHREAD-$ENV{JENKINS_DO_PTHREAD}_CUDA-$ENV{JENKINS_DO_CUDA}_COMPLEX-$ENV{JENKINS_DO_COMPLEX}) -SET(CTEST_PARALLEL_LEVEL 1) -SET(CTEST_TEST_TYPE $ENV{JENKINS_JOB_TYPE}) -SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_PACKAGES Kokkos Tpetra Belos Ifpack2 MueLu Amesos Amesos2 Ifpack Epetra EpetraExt Zoltan Zoltan2 Xpetra Panzer Intrepid STK Seacas Anasazi Phalanx Sacado Stokhos Shylu Stratimikos Thyra) - -SET(EXTRA_CONFIGURE_OPTIONS - "-DTPL_ENABLE_SuperLU=OFF" - - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTeuchos_ENABLE_COMPLEX:BOOL=$ENV{JENKINS_DO_COMPLEX}" - "-DTrilinos_ENABLE_OpenMP:BOOL=$ENV{JENKINS_DO_OPENMP}" - "-DTPL_ENABLE_HWLOC:STRING=OFF" - "-DTPL_ENABLE_CUDA:STRING=$ENV{JENKINS_DO_CUDA}" - - "-DKokkos_ENABLE_Pthread:BOOL=$ENV{JENKINS_DO_PTHREAD}" - "-DKokkos_ENABLE_Cuda_UVM:BOOL=$ENV{JENKINS_DO_CUDA}" - - "-DTpetra_INST_SERIAL:BOOL=$ENV{JENKINS_DO_SERIAL}" - "-DTpetra_INST_OPENMP:BOOL=$ENV{JENKINS_DO_OPENMP}" - "-DTpetra_INST_PTHREAD:BOOL=$ENV{JENKINS_DO_PTHREAD}" - "-DTpetra_INST_CUDA:BOOL=$ENV{JENKINS_DO_CUDA}" - "-D Tpetra_INST_COMPLEX_DOUBLE:BOOL=$ENV{JENKINS_DO_COMPLEX}" - "-D MueLu_INST_DOUBLE_INT_LONGINT:BOOL=ON" - -) - -#"-DMPI_EXEC_POST_NUMPROCS_FLAGS:STRING=-bind-to;socket;--map-by;socket" -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/rouson-mp/CMakeLists.txt b/cmake/ctest/drivers/rouson-mp/CMakeLists.txt deleted file mode 100644 index a1a8e702e061..000000000000 --- a/cmake/ctest/drivers/rouson-mp/CMakeLists.txt +++ /dev/null @@ -1,50 +0,0 @@ -INCLUDE("../../../../Version.cmake") - -TRILINOS_DRIVER_SETUP() - -IF(${Trilinos_REPOSITORY_BRANCH} STREQUAL "master") - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_OPT_GCC - ctest_mac_nightly_mpi_opt_gcc_rouson-mp.cmake - RUN_SERIAL - TIMEOUT_MINUTES 240 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_OPT_NAG - ctest_mac_nightly_mpi_opt_nag_rouson-mp.cmake - RUN_SERIAL - TIMEOUT_MINUTES 240 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG_GCC - ctest_mac_nightly_serial_debug_gcc_rouson-mp.cmake - RUN_SERIAL - TIMEOUT_MINUTES 330 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG_NAG - ctest_mac_nightly_serial_debug_nag_rouson-mp.cmake - RUN_SERIAL - TIMEOUT_MINUTES 330 - ) - -ELSE() - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_OPT_RELEASE_NAG - ctest_mac_nightly_mpi_opt_release_nag_rouson-mp.cmake - RUN_SERIAL - TIMEOUT_MINUTES 240 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG_RELEASE_NAG - ctest_mac_nightly_serial_debug_release_nag_rouson-mp.cmake - RUN_SERIAL - TIMEOUT_MINUTES 330 - ) -ENDIF() - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/rouson-mp/TrilinosCTestDriverCore.rouson-mp.gcc.cmake b/cmake/ctest/drivers/rouson-mp/TrilinosCTestDriverCore.rouson-mp.gcc.cmake deleted file mode 100644 index 5a89b59f3fb6..000000000000 --- a/cmake/ctest/drivers/rouson-mp/TrilinosCTestDriverCore.rouson-mp.gcc.cmake +++ /dev/null @@ -1,113 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for rouson-mp using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - -# SET( CTEST_BUILD_FLAGS "-j8 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "8" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENCENCY_UNIT_TESTS:BOOL=ON" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - ) - - SET_DEFAULT(COMPILER_VERSION "GCC-4.7") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/usr/local/openmpi/GCC47" - "-DCMAKE_CXX_COMPILER:FILEPATH=/usr/local/openmpi/GCC47/bin/mpicxx" - "-DCMAKE_C_COMPILER:FILEPATH=/usr/local/openmpi/GCC47/bin/mpicc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/usr/local/openmpi/GCC47/bin/mpif90" - ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/opt/local/bin/x86_64-apple-darwin10-g++-mp-4.7" - "-DCMAKE_C_COMPILER:FILEPATH=/opt/local/bin/x86_64-apple-darwin10-gcc-mp-4.7" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/opt/local/bin/x86_64-apple-darwin10-gfortran-mp-4.7" - ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/rouson-mp/TrilinosCTestDriverCore.rouson-mp.nag.cmake b/cmake/ctest/drivers/rouson-mp/TrilinosCTestDriverCore.rouson-mp.nag.cmake deleted file mode 100644 index 6d00690af183..000000000000 --- a/cmake/ctest/drivers/rouson-mp/TrilinosCTestDriverCore.rouson-mp.nag.cmake +++ /dev/null @@ -1,115 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for rouson-mp using gcc and nagfor -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - -# SET( CTEST_BUILD_FLAGS "-j8 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "8" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENCENCY_UNIT_TESTS:BOOL=ON" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - ) - - SET_DEFAULT(COMPILER_VERSION "GCC-4.2") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/usr/local/openmpi/nagfor" - "-DCMAKE_CXX_COMPILER:FILEPATH=/usr/local/openmpi/nagfor/bin/mpicxx" - "-DCMAKE_C_COMPILER:FILEPATH=/usr/local/openmpi/nagfor/bin/mpicc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/usr/local/openmpi/nagfor/bin/mpif90" - "-DCMAKE_Fortran_FLAGS:STRING=-f2003 -g -C=all -wmismatch=mpi_scatterv,mpi_alltoallv,mpi_gatherv,mpi_allgatherv,mpi_bcast" - ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/usr/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/usr/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/usr/bin/nagfor" - "-DCMAKE_Fortran_FLAGS:STRING=-f2003 -g -C=all" - ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/rouson-mp/cron_driver.sh b/cmake/ctest/drivers/rouson-mp/cron_driver.sh deleted file mode 100755 index 98e0f59028dc..000000000000 --- a/cmake/ctest/drivers/rouson-mp/cron_driver.sh +++ /dev/null @@ -1,42 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on rouson-mp: `date`" -echo - -# TrilinosDriver settings: -# - -export TDD_GIT_EXE=/usr/local/git/bin/git -export TDD_PARALLEL_LEVEL=2 -export TDD_HTTP_PROXY="http://wwwproxy.ca.sandia.gov:80/" - -# Trilinos settings: -# - -export TDD_CTEST_TEST_TYPE=Nightly -export CTEST_TEST_TYPE=Experimental -export CTEST_DO_SUBMIT=ON -export TDD_DO_SUBMIT=ON -export Trilinos_PACKAGES=ForTrilinos -export CTEST_DO_UPDATES=TRUE -export TDD_IN_TESTING_MODE=ON -export CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=TRUE -#export TDD_FORCE_CMAKE_INSTALL=0 -#export TDD_FORCE_INNER_CMAKE_INSTALL=0 -export CTEST_EXPLICITLY_ENABLE_IMPLICITLY_ENABLED_PACKAGES=TRUE - -# Machine specific environment: -# - -export PYTHONPATH=/usr/bin/python - -# Machine independent cron_driver: -# - -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on rouson-mp: `date`" -echo diff --git a/cmake/ctest/drivers/rouson-mp/cron_driver_release_rouson-mp.sh b/cmake/ctest/drivers/rouson-mp/cron_driver_release_rouson-mp.sh deleted file mode 100755 index 2eed783dd095..000000000000 --- a/cmake/ctest/drivers/rouson-mp/cron_driver_release_rouson-mp.sh +++ /dev/null @@ -1,50 +0,0 @@ -#!/bin/bash - -#get the date for use in log files -DATE=`date "+%m-%d-%Y"` - -CTEST_EXE=/usr/bin/ctest -GIT_EXE=/usr/local/git/bin/git -BASEDIR=/Users/knmorri/NightlyTestingTrilinos/Trilinos -DRIVER_SCRIPT_DIR=$BASEDIR/cmake/ctest/drivers/rouson-mp -BRANCH="trilinos-release-10-10-branch" -#BRANCH="master" -TRILINOS_REPOSITORY_LOCATION="software.sandia.gov:/space/git/Trilinos" -export PYTHONPATH=/usr/bin/python - -echo -echo "Starting nightly Trilinos Release 10.10 testing on rouson-mp: `date`" -echo - -echo -echo "Checking out just the drivers: `date`" -echo - -cd $BASEDIR -if [ -d Trilinos ]; then - echo Doing an update of existing directory - cd Trilinos - $GIT_EXE pull - cd .. -else - echo Cloning the repository because none exists yets - $GIT_EXE clone $TRILINOS_REPOSITORY_LOCATION -fi - - -echo -echo "Doing mpi optimized Release 10.10 build: `date`" -echo - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_mac_nightly_mpi_opt_release_nag_rouson-mp.cmake -VV &> "MPI_OPT_RELEASE_NAG_10.10_$DATE.log" - -echo -echo "Doing serial debug Release 10.10 build: `date`" -echo - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_mac_nightly_serial_debug_release_nag_rouson-mp.cmake -VV &> "SERIAL_DEBUG_RELEASE_NAG_10.10_$DATE.log" - -echo -echo "Ending nightly Trilinos Release 10.10 testing on rouson-mp: `date`" -echo - diff --git a/cmake/ctest/drivers/rouson-mp/cron_driver_rouson-mp.sh b/cmake/ctest/drivers/rouson-mp/cron_driver_rouson-mp.sh deleted file mode 100755 index b7a2cde927c2..000000000000 --- a/cmake/ctest/drivers/rouson-mp/cron_driver_rouson-mp.sh +++ /dev/null @@ -1,49 +0,0 @@ -#!/bin/bash - -#get the date for use in log files -DATE=`date "+%m-%d-%Y"` - -CTEST_EXE=/usr/bin/ctest -GIT_EXE=/usr/local/git/bin/git -BASEDIR=/Users/knmorri/NightlyTestingTrilinos/Trilinos -DRIVER_SCRIPT_DIR=$BASEDIR/cmake/ctest/drivers/rouson-mp -BRANCH="master" -TRILINOS_REPOSITORY_LOCATION="software.sandia.gov:/space/git/Trilinos" -export PYTHONPATH=/usr/bin/python - -echo -echo "Starting nightly Trilinos development testing on rouson-mp: `date`" -echo - -echo -echo "Checking out just the drivers: `date`" -echo - -cd $BASEDIR -if [ -d Trilinos ]; then - echo Doing an update of existing directory - cd Trilinos - $EG_EXE pull - cd .. -else - echo Cloning the repository because none exists yets - $EG_EXE clone $TRILINOS_REPOSITORY_LOCATION -fi - - -echo -echo "Doing mpi optimized development build: `date`" -echo - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_mac_nightly_mpi_opt_nag_rouson-mp.cmake -VV &> "MPI_OPT_DEV_NAG_$DATE.log" - -echo -echo "Doing serial debug development build: `date`" -echo - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_mac_nightly_serial_debug_nag_rouson-mp.cmake -VV &> "SERIAL_DEBUG_DEV_NAG_$DATE.log" - -echo -echo "Ending nightly Trilinos development testing on rouson-mp: `date`" -echo - diff --git a/cmake/ctest/drivers/rouson-mp/ctest_mac_nightly_mpi_opt_gcc_rouson-mp.cmake b/cmake/ctest/drivers/rouson-mp/ctest_mac_nightly_mpi_opt_gcc_rouson-mp.cmake deleted file mode 100644 index 136f66fbcfdd..000000000000 --- a/cmake/ctest/drivers/rouson-mp/ctest_mac_nightly_mpi_opt_gcc_rouson-mp.cmake +++ /dev/null @@ -1,85 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.rouson-mp.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV_GCC) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(EXTRA_EXCLUDE_PACKAGES Zoltan PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DForTrilinos_ENABLE_TESTS:BOOL=ON" - "-DForTrilinos_ENABLE_EXAMPLES:BOOL=ON" - "-DForTrilinos_ENABLE_OBJECT_ORIENTED:BOOL=ON" - "-DForTrilinos_DISABLE_DEFERRED_LENGTH_CHARACTERS:BOOL=ON" - "-DForTrilinos_DISABLE_FINAL_SUBROUTINES:BOOL=ON" - "-DForTrilinos_DISABLE_TYPE_BOUND_CONSTRUCTOR:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/rouson-mp/ctest_mac_nightly_mpi_opt_nag_rouson-mp.cmake b/cmake/ctest/drivers/rouson-mp/ctest_mac_nightly_mpi_opt_nag_rouson-mp.cmake deleted file mode 100644 index e509326ef8af..000000000000 --- a/cmake/ctest/drivers/rouson-mp/ctest_mac_nightly_mpi_opt_nag_rouson-mp.cmake +++ /dev/null @@ -1,82 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.rouson-mp.nag.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV_NAG) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(EXTRA_EXCLUDE_PACKAGES Zoltan PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DForTrilinos_ENABLE_TESTS:BOOL=ON" - "-DForTrilinos_ENABLE_EXAMPLES:BOOL=ON" - "-DForTrilinos_ENABLE_OBJECT_ORIENTED:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/rouson-mp/ctest_mac_nightly_mpi_opt_release_nag_rouson-mp.cmake b/cmake/ctest/drivers/rouson-mp/ctest_mac_nightly_mpi_opt_release_nag_rouson-mp.cmake deleted file mode 100644 index de8c08681dec..000000000000 --- a/cmake/ctest/drivers/rouson-mp/ctest_mac_nightly_mpi_opt_release_nag_rouson-mp.cmake +++ /dev/null @@ -1,85 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.rouson-mp.nag.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "MPI_OPT_NAG${Trilinos_VERSION}") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(EXTRA_EXCLUDE_PACKAGES Zoltan PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DForTrilinos_ENABLE_TESTS:BOOL=ON" - "-DForTrilinos_ENABLE_EXAMPLES:BOOL=ON" - "-DForTrilinos_ENABLE_OBJECT_ORIENTED:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/rouson-mp/ctest_mac_nightly_serial_debug_gcc_rouson-mp.cmake b/cmake/ctest/drivers/rouson-mp/ctest_mac_nightly_serial_debug_gcc_rouson-mp.cmake deleted file mode 100644 index 07721343e910..000000000000 --- a/cmake/ctest/drivers/rouson-mp/ctest_mac_nightly_serial_debug_gcc_rouson-mp.cmake +++ /dev/null @@ -1,87 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.rouson-mp.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_DEV_GCC) -SET(CTEST_PARALLEL_LEVEL 8) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -# Exclude Sundance because of strange segfault (see bug 4382) -SET(EXTRA_EXCLUDE_PACKAGES Sundance PyTrilinos STK) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DForTrilinos_ENABLE_TESTS:BOOL=ON" - "-DForTrilinos_ENABLE_EXAMPLES:BOOL=ON" - "-DForTrilinos_ENABLE_OBJECT_ORIENTED:BOOL=ON" - "-DForTrilinos_DISABLE_DEFERRED_LENGTH_CHARACTERS:BOOL=ON" - "-DForTrilinos_DISABLE_FINAL_SUBROUTINES:BOOL=ON" - "-DForTrilinos_DISABLE_TYPE_BOUND_CONSTRUCTOR:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/rouson-mp/ctest_mac_nightly_serial_debug_nag_rouson-mp.cmake b/cmake/ctest/drivers/rouson-mp/ctest_mac_nightly_serial_debug_nag_rouson-mp.cmake deleted file mode 100644 index ded7ed5f2370..000000000000 --- a/cmake/ctest/drivers/rouson-mp/ctest_mac_nightly_serial_debug_nag_rouson-mp.cmake +++ /dev/null @@ -1,84 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.rouson-mp.nag.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_DEV_NAG) -SET(CTEST_PARALLEL_LEVEL 8) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -# Exclude Sundance because of strange segfault (see bug 4382) -SET(EXTRA_EXCLUDE_PACKAGES Sundance PyTrilinos STK) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DForTrilinos_ENABLE_TESTS:BOOL=ON" - "-DForTrilinos_ENABLE_EXAMPLES:BOOL=ON" - "-DForTrilinos_ENABLE_OBJECT_ORIENTED:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/rouson-mp/ctest_mac_nightly_serial_debug_release_nag_rouson-mp.cmake b/cmake/ctest/drivers/rouson-mp/ctest_mac_nightly_serial_debug_release_nag_rouson-mp.cmake deleted file mode 100644 index 524151d9fa48..000000000000 --- a/cmake/ctest/drivers/rouson-mp/ctest_mac_nightly_serial_debug_release_nag_rouson-mp.cmake +++ /dev/null @@ -1,86 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.rouson-mp.nag.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "SERIAL_DEBUG_NAG${Trilinos_VERSION}") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -# Exclude Sundance because of strange segfault (see bug 4382) -SET(EXTRA_EXCLUDE_PACKAGES Sundance PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DForTrilinos_ENABLE_TESTS:BOOL=ON" - "-DForTrilinos_ENABLE_EXAMPLES:BOOL=ON" - "-DForTrilinos_ENABLE_OBJECT_ORIENTED:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s861036/CMakeLists.txt b/cmake/ctest/drivers/s861036/CMakeLists.txt deleted file mode 100644 index 40400f8aac88..000000000000 --- a/cmake/ctest/drivers/s861036/CMakeLists.txt +++ /dev/null @@ -1,39 +0,0 @@ -INCLUDE("../../../../Version.cmake") - -TRILINOS_DRIVER_SETUP() - -# -# Zoltan only, with Parmetis and Scotch -# Zoltan uses 64-bit global IDs (unless compiled on 32-bit machine) -# Parmetis and Scotch use 32-bit IDs -# -TRILINOS_DRIVER_ADD_DASHBOARD( - ZOLTAN_ONLY_64 - ctest_zoltan_only_ids64.cmake - CTEST_INSTALLER_TYPE release - TIMEOUT_MINUTES 120 -) - -# -# Zoltan only, with Scotch -# Zoltan uses 64-bit global IDs (unless compiled on 32-bit machine) -# Scotch uses 64-bit IDs -# -TRILINOS_DRIVER_ADD_DASHBOARD( - ZOLTAN_W_SCOTCH64 - ctest_zoltan_only_ids64_scotch64.cmake - CTEST_INSTALLER_TYPE release - TIMEOUT_MINUTES 120 -) - -# -# Zoltan and packages that use Zoltan, global IDs are unsigned int -# -TRILINOS_DRIVER_ADD_DASHBOARD( - ZOLTAN_PLUS_USERS - ctest_zoltan_plus.cmake - CTEST_INSTALLER_TYPE release - TIMEOUT_MINUTES 300 -) - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/s861036/cron_driver.sh b/cmake/ctest/drivers/s861036/cron_driver.sh deleted file mode 100755 index 60e307b0694e..000000000000 --- a/cmake/ctest/drivers/s861036/cron_driver.sh +++ /dev/null @@ -1,62 +0,0 @@ -#!/bin/bash - -echo -echo "Testing Zoltan on s861036.srn.sandia.gov: `date`" -echo - -# -# Is mpd running -# - -mpdhost=$(mpdtrace) - -if [ "$mpdhost" != "s861036" ] ; then - echo "Starting mpd" - mpd & -fi - -# TrilinosDriver settings: -# -export CTEST_TEST_TIMEOUT="1800" -export TDD_GIT_EXE=/usr/local/bin/git -export TDD_PARALLEL_LEVEL=1 -export TDD_HTTP_PROXY="http://wwwproxy.sandia.gov:80/" -export COMPILER_VERSION="GCC-4.1.2" -export Trilinos_PACKAGES=Zoltan - -# -# just testing -# -#export TDD_IN_TESTING_MODE=ON -#export CTEST_DO_SUBMIT=FALSE -#export CTEST_DO_UPDATES=FALSE -# - -# Machine specific environment: -# -export PATH=.:/usr/local/bin:/usr/kerberos/bin:/usr/bin:/bin:/usr/X11R6/bin:/sbin:/home/lriesen/bin - -# BASEDIR is the parent directory of this script's Trilinos source tree... -BASEDIR=`cd "\`dirname \"$0\"\`/../../../../..";pwd` -echo BASEDIR=$BASEDIR -BASEDATADIR=$BASEDIR - -export CVS_RSH=ssh -export LD_LIBRARY_PATH="$BASEDIR/MPI_OPT_DEV_SHARED/BUILD/packages/PyTrilinos/src" -export PYTHONPATH="/usr/local/lib/python2.7:/usr/local/lib/python2.7/site-packages:/usr/local/lib/python2.7/lib-dynload" - -export TRILINOSDATADIRECTORY="$BASEDATADIR/TrilinosData" - -pushd "$BASEDATADIR" -cvs -q -d :ext:software.sandia.gov:/space/CVS co TrilinosData -popd - -# Machine independent cron_driver: -# -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on trilinos-test: `date`" -echo - diff --git a/cmake/ctest/drivers/s861036/ctest_zoltan_only_ids64.cmake b/cmake/ctest/drivers/s861036/ctest_zoltan_only_ids64.cmake deleted file mode 100644 index d14cdb93a814..000000000000 --- a/cmake/ctest/drivers/s861036/ctest_zoltan_only_ids64.cmake +++ /dev/null @@ -1,99 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Build Zoltan and its examples and tests. -# Zoltan's global IDs are 64 bits on 64 bit machines. -# Scotch and Parmetis use 32 bit IDs -# - -SET(COMM_TYPE MPI) -SET(TPL_ENABLE_MPI ON) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME ZOLTAN_ONLY_64) -SET(Trilinos_PACKAGES Zoltan) -SET(CTEST_TEST_TIMEOUT "1800") -#SET(CTEST_TEST_TYPE Nightly) -SET(CTEST_TEST_TYPE Experimental) -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_EXEC_MAX_NUMPROCS:STRING=11" - "-DTrilinos_ENABLE_ALL_PACKAGES:BOOL=OFF" - "-DTrilinos_ENABLE_EXAMPLES:BOOL=ON" - "-DTrilinos_ENABLE_TESTS:BOOL=ON" - "-DTrilinos_ENABLE_Zoltan:BOOL=ON" - "-DZoltan_ENABLE_ULONG_IDS:BOOL=ON" - "-DZoltan_ENABLE_ParMETIS:BOOL=ON" - "-DZoltan_ENABLE_Scotch:BOOL=ON" - "-DParMETIS_INCLUDE_DIRS:FILEPATH=/home/lafisk/system/parmetis/ParMetis-3.1" - "-DParMETIS_LIBRARY_DIRS:FILEPATH=/home/lafisk/system/parmetis/ParMetis-3.1" - "-DScotch_INCLUDE_DIRS:FILEPATH=/home/lriesen/local/system/scotch_5.1.10a-32/include" - "-DScotch_LIBRARY_DIRS:FILEPATH=/home/lriesen/local/system/scotch_5.1.10a-32/lib" - ) - -SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) -SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) -SET( CTEST_BUILD_FLAGS "-j4 -i" ) -SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) -SET( CTEST_MEMORYCHECK_COMMAND /usr/local/bin/valgrind ) - -TRILINOS_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s861036/ctest_zoltan_only_ids64_scotch64.cmake b/cmake/ctest/drivers/s861036/ctest_zoltan_only_ids64_scotch64.cmake deleted file mode 100644 index 70c994264c40..000000000000 --- a/cmake/ctest/drivers/s861036/ctest_zoltan_only_ids64_scotch64.cmake +++ /dev/null @@ -1,97 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Build Zoltan and its examples and tests. -# Zoltan's global IDs are 64 bits on 64 bit machines. -# Scotch uses 64 bit IDs -# - -SET(COMM_TYPE MPI) -SET(TPL_ENABLE_MPI ON) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME ZOLTAN_W_SCOTCH64) -SET(Trilinos_PACKAGES Zoltan) -SET(CTEST_TEST_TIMEOUT "1800") -#SET(CTEST_TEST_TYPE Nightly) -SET(CTEST_TEST_TYPE Experimental) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_EXEC_MAX_NUMPROCS:STRING=11" - "-DTrilinos_ENABLE_ALL_PACKAGES:BOOL=OFF" - "-DTrilinos_ENABLE_EXAMPLES:BOOL=ON" - "-DTrilinos_ENABLE_TESTS:BOOL=ON" - "-DTrilinos_ENABLE_Zoltan:BOOL=ON" - "-DZoltan_ENABLE_ULONG_IDS:BOOL=ON" - "-DZoltan_ENABLE_Scotch:BOOL=ON" - "-DScotch_INCLUDE_DIRS:FILEPATH=/home/lriesen/local/system/scotch_5.1.10a/include" - "-DScotch_LIBRARY_DIRS:FILEPATH=/home/lriesen/local/system/scotch_5.1.10a/lib" - ) - -SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) -SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) -SET( CTEST_BUILD_FLAGS "-j4 -i" ) -SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) -SET( CTEST_MEMORYCHECK_COMMAND /usr/local/bin/valgrind ) - -TRILINOS_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s861036/ctest_zoltan_plus.cmake b/cmake/ctest/drivers/s861036/ctest_zoltan_plus.cmake deleted file mode 100644 index f2949b2e2674..000000000000 --- a/cmake/ctest/drivers/s861036/ctest_zoltan_plus.cmake +++ /dev/null @@ -1,104 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Build Zoltan and all Trilinos packages that have optional or -# required dependencies on it. -# -# Zoltan will use 32-bit global IDs. ParMetis and -# Scotch are using 32-bit global IDs. - -SET(COMM_TYPE MPI) -SET(TPL_ENABLE_MPI ON) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME ZOLTAN_PLUS_USERS) -SET(Trilinos_PACKAGES Zoltan) -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) -SET(CTEST_TEST_TIMEOUT "1800") -#SET(CTEST_TEST_TYPE Nightly) -SET(CTEST_TEST_TYPE Experimental) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_EXEC_MAX_NUMPROCS:STRING=11" - "-DTrilinos_ENABLE_ALL_PACKAGES:BOOL=OFF" - "-DTrilinos_ENABLE_EXAMPLES:BOOL=ON" - "-DTrilinos_ENABLE_TESTS:BOOL=ON" - "-DTrilinos_ENABLE_Zoltan:BOOL=ON" - "-DZoltan_ENABLE_UINT_IDS:BOOL=ON" - "-DTrilinos_ENABLE_ALL_FORWARD_DEP_PACKAGES:BOOL=ON" - "-DZoltan_ENABLE_ParMETIS:BOOL=ON" - "-DZoltan_ENABLE_Scotch:BOOL=ON" - "-DParMETIS_INCLUDE_DIRS:FILEPATH=/home/lafisk/system/parmetis/ParMetis-3.1" - "-DParMETIS_LIBRARY_DIRS:FILEPATH=/home/lafisk/system/parmetis/ParMetis-3.1" - "-DScotch_INCLUDE_DIRS:FILEPATH=/home/lriesen/local/system/scotch_5.1.10a-32/include" - "-DScotch_LIBRARY_DIRS:FILEPATH=/home/lriesen/local/system/scotch_5.1.10a-32/lib" - "-DLAPACK_LIBRARY_DIRS:FILEPATH=/usr/local/lib" - "-DBLAS_LIBRARY_DIRS:FILEPATH=/usr/local/lib" - "-DTPL_LAPACK_LIBRARIES:STRING=-llapack -lblas -lgfortran" - ) - -SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) -SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) -SET( CTEST_BUILD_FLAGS "-j4 -i" ) -SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) -SET( CTEST_MEMORYCHECK_COMMAND /usr/local/bin/valgrind ) - -TRILINOS_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s903186/CMakeLists.txt b/cmake/ctest/drivers/s903186/CMakeLists.txt deleted file mode 100644 index 45d78590e0e8..000000000000 --- a/cmake/ctest/drivers/s903186/CMakeLists.txt +++ /dev/null @@ -1,43 +0,0 @@ -TRILINOS_DRIVER_SETUP() - -#TRILINOS_DRIVER_ADD_DASHBOARD( -# MPI_OPT_CLANG_NO_FORTRAN -# ctest_mac_nightly_clang_mpi_opt_s903186.cmake -# CTEST_INSTALLER_TYPE release -# RUN_SERIAL -# TIMEOUT_MINUTES 360 -#) - -TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG_CLANG_NO_FORTRAN - ctest_mac_nightly_clang_serial_debug_s903186.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 360 -) - -#TRILINOS_DRIVER_ADD_DASHBOARD( -# MPI_OPT -# ctest_mac_nightly_mpi_opt_s903186.cmake -# CTEST_INSTALLER_TYPE release -# TIMEOUT_MINUTES 360 -#) - -TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG - ctest_mac_nightly_serial_debug_s903186.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 330 -) - -TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_OPT_SHARED - ctest_mac_nightly_mpi_opt_shared_s903186.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 300 -) - - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/s903186/TrilinosCTestDriverCore.s903186.clang.cmake b/cmake/ctest/drivers/s903186/TrilinosCTestDriverCore.s903186.clang.cmake deleted file mode 100644 index 03add97b44cc..000000000000 --- a/cmake/ctest/drivers/s903186/TrilinosCTestDriverCore.s903186.clang.cmake +++ /dev/null @@ -1,118 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for s903186 using clang -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j8 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "8" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_Fortran=OFF" - "-DTrilinos_ENABLE_DEPENCENCY_UNIT_TESTS:BOOL=OFF" - "-DBoost_INCLUDE_DIRS:FILEPATH=/Volumes/SnowLeopardOSX/Users/trilinos/tpl/gcc/boost-1.49.0" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DSuperLU_INCLUDE_DIRS:PATH=/Volumes/SnowLeopardOSX/Users/trilinos/tpl/gcc/SuperLU_4.3/SRC" - "-DSuperLU_LIBRARY_DIRS:PATH=/Volumes/SnowLeopardOSX/Users/trilinos/tpl/gcc/SuperLU_4.3/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu_4.3" - "-DTPL_ENABLE_Matio=OFF" - "-DTPL_ENABLE_SuperLU=ON" - "-DIntrepid_ENABLE_DEBUG_INF_CHECK=OFF" - ) - - SET_DEFAULT(COMPILER_VERSION "Clang-3.3") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/Users/trilinos/compilers/clang/openmpi_1.6.5_clang_3.3" - ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/usr/bin/clang++" - "-DCMAKE_C_COMPILER:FILEPATH=/usr/bin/clang" - ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/s903186/TrilinosCTestDriverCore.s903186.gcc.cmake b/cmake/ctest/drivers/s903186/TrilinosCTestDriverCore.s903186.gcc.cmake deleted file mode 100644 index b9f78d78c648..000000000000 --- a/cmake/ctest/drivers/s903186/TrilinosCTestDriverCore.s903186.gcc.cmake +++ /dev/null @@ -1,121 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for s903186 using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j8 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "8" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_Fortran=OFF" - "-DTrilinos_ENABLE_DEPENCENCY_UNIT_TESTS:BOOL=OFF" - "-DBoost_INCLUDE_DIRS:FILEPATH=/Users/trilinos/tpl/gcc/boost-1.49.0" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DMesquite_ENABLE_TESTS:BOOL=ON" - "-DCPPUNIT_LIBRARY:STRING=/Users/jmwille/install/cppunit-1.12.1/lib/libcppunit.a" - "-DCPPUNIT_INCLUDES:STRING=/Users/jmwille/install/cppunit-1.12.1/include" - "-DSuperLU_INCLUDE_DIRS:PATH=/Users/trilinos/tpl/gcc/SuperLU_4.3/SRC" - "-DSuperLU_LIBRARY_DIRS:PATH=/Users/trilinos/tpl/gcc/SuperLU_4.3/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu_4.3" - "-DTPL_ENABLE_Matio=OFF" - "-DTPL_ENABLE_SuperLU=ON" - "-DIntrepid_ENABLE_DEBUG_INF_CHECK=OFF" - ) - - SET_DEFAULT(COMPILER_VERSION "GCC-4.2.1") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - # No MPI wrappers for this version of GCC yet, so don't run any MPI jobs - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/Users/trilinos/compilers/gcc/openmpi_1.6.5_gcc_4.8.2" - ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/usr/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/usr/bin/gcc" - ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/s903186/TrilinosCTestDriverCore.s903186.gcc4.8.1.cmake b/cmake/ctest/drivers/s903186/TrilinosCTestDriverCore.s903186.gcc4.8.1.cmake deleted file mode 100644 index 4dabcdcf4698..000000000000 --- a/cmake/ctest/drivers/s903186/TrilinosCTestDriverCore.s903186.gcc4.8.1.cmake +++ /dev/null @@ -1,114 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for s903186 using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j7 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "7" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENCENCY_UNIT_TESTS:BOOL=OFF" - "-DBoost_INCLUDE_DIRS:FILEPATH=/Users/trilinos/tpl/gcc/boost-1.49.0" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DTPL_ENABLE_Matio=OFF" - "-DIntrepid_ENABLE_DEBUG_INF_CHECK=OFF" - ) - - SET_DEFAULT(COMPILER_VERSION "GCC-4.8.1") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/Volumes/SnowLeopardOSX/Users/trilinos/openmpi_1.6.5_gcc_4.8.1/" - ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/usr/local/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/usr/local/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/usr/local/bin/gfortran" - ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/s903186/cron_driver.sh b/cmake/ctest/drivers/s903186/cron_driver.sh deleted file mode 100755 index 663ad8170ac3..000000000000 --- a/cmake/ctest/drivers/s903186/cron_driver.sh +++ /dev/null @@ -1,38 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on s903186: `date`" -echo - -# TrilinosDriver settings: -# - -CTEST_EXE=/Volumes/SnowLeopardOSX/Users/trilinos/CMake-2.8.12/bin/ctest -export TDD_GIT_EXE=/usr/bin/git -export TDD_PARALLEL_LEVEL=2 - -# Trilinos settings: -# - -export TDD_CTEST_TEST_TYPE=Nightly - -#export CTEST_DO_SUBMIT=FALSE - -#export CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=FALSE - -#export Trilinos_PACKAGES=Teuchos - -# Machine specific environment: -# - -export PYTHONPATH=/Users/jmwille/install/lib/python2.5/site-packages - -# Machine independent cron_driver: -# - -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on s903186: `date`" -echo diff --git a/cmake/ctest/drivers/s903186/ctest_mac_nightly_clang_mpi_opt_s903186.cmake b/cmake/ctest/drivers/s903186/ctest_mac_nightly_clang_mpi_opt_s903186.cmake deleted file mode 100644 index a2dbaf566451..000000000000 --- a/cmake/ctest/drivers/s903186/ctest_mac_nightly_clang_mpi_opt_s903186.cmake +++ /dev/null @@ -1,85 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.s903186.clang.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV_CLANG) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(EXTRA_EXCLUDE_PACKAGES PyTrilinos SEACAS) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DNetcdf_LIBRARY_DIRS=/Users/trilinos/tpl/gcc/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/Users/trilinos/tpl/gcc/pnetcdf_4.2/include" - "-DHDF5_LIBRARY_DIRS=/Users/trilinos/tpl/gcc/phdf5-1.8.6/lib" - "-DHDF5_INCLUDE_DIRS=/Users/trilinos/tpl/gcc/phdf5-1.8.6/include" - "-DZoltan2_ENABLE_Experimental=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s903186/ctest_mac_nightly_clang_serial_debug_s903186.cmake b/cmake/ctest/drivers/s903186/ctest_mac_nightly_clang_serial_debug_s903186.cmake deleted file mode 100644 index 00bda11f0598..000000000000 --- a/cmake/ctest/drivers/s903186/ctest_mac_nightly_clang_serial_debug_s903186.cmake +++ /dev/null @@ -1,84 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.s903186.clang.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_DEV_CLANG) -SET(CTEST_PARALLEL_LEVEL 7) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(EXTRA_EXCLUDE_PACKAGES PyTrilinos SEACAS Panzer) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS=/Volumes/SnowLeopardOSX/Users/trilinos/tpl/gcc/netcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/Volumes/SnowLeopardOSX/Users/trilinos/tpl/gcc/netcdf_4.2/include" - "-DHDF5_LIBRARY_DIRS=/Volumes/SnowLeopardOSX/Users/trilinos/tpl/gcc/hdf5-1.8.6/lib" - "-DHDF5_INCLUDE_DIRS=/Volumes/SnowLeopardOSX/Users/trilinos/tpl/gcc/hdf5-1.8.6/include" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s903186/ctest_mac_nightly_clang_stable_mpi_opt_s903186.cmake b/cmake/ctest/drivers/s903186/ctest_mac_nightly_clang_stable_mpi_opt_s903186.cmake deleted file mode 100644 index 4f9e7abf7928..000000000000 --- a/cmake/ctest/drivers/s903186/ctest_mac_nightly_clang_stable_mpi_opt_s903186.cmake +++ /dev/null @@ -1,86 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.s903186.clang.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV_CLANG_STABLE) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(EXTRA_EXCLUDE_PACKAGES PyTrilinos SEACAS) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS=/Users/trilinos/tpl/gcc/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/Users/trilinos/tpl/gcc/pnetcdf_4.2/include" - "-DHDF5_LIBRARY_DIRS=/Users/trilinos/tpl/gcc/phdf5-1.8.6/lib" - "-DHDF5_INCLUDE_DIRS=/Users/trilinos/tpl/gcc/phdf5-1.8.6/include" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DZoltan2_ENABLE_Experimental=ON" - "-DFEI_ENABLE_TESTS:BOOL=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s903186/ctest_mac_nightly_mpi_opt_release_s903186.cmake b/cmake/ctest/drivers/s903186/ctest_mac_nightly_mpi_opt_release_s903186.cmake deleted file mode 100644 index 5b9fbc0286b5..000000000000 --- a/cmake/ctest/drivers/s903186/ctest_mac_nightly_mpi_opt_release_s903186.cmake +++ /dev/null @@ -1,87 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.s903186.gcc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "MPI_OPT_${Trilinos_VERSION}") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(EXTRA_EXCLUDE_PACKAGES Zoltan PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS=/Users/trilinos/tpl/gcc/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/Users/trilinos/tpl/gcc/pnetcdf_4.2/include" - "-DHDF5_LIBRARY_DIRS=/Users/trilinos/tpl/gcc/phdf5-1.8.6/lib" - "-DHDF5_INCLUDE_DIRS=/Users/trilinos/tpl/gcc/phdf5-1.8.6/include" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s903186/ctest_mac_nightly_mpi_opt_release_shared_s903186.cmake b/cmake/ctest/drivers/s903186/ctest_mac_nightly_mpi_opt_release_shared_s903186.cmake deleted file mode 100644 index 81b57f577c0a..000000000000 --- a/cmake/ctest/drivers/s903186/ctest_mac_nightly_mpi_opt_release_shared_s903186.cmake +++ /dev/null @@ -1,89 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.s903186.gcc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "MPI_OPT_SHARED__${Trilinos_VERSION}") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(EXTRA_EXCLUDE_PACKAGES Zoltan STK ) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DBUILD_SHARED_LIBS:BOOL=ON" - "-DSWIG_EXECUTABLE:FILEPATH=/Users/jmwille/install/swig-2.0.4/bin/swig" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS=/Users/trilinos/tpl/gcc/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/Users/trilinos/tpl/gcc/pnetcdf_4.2/include" - "-DHDF5_LIBRARY_DIRS=/Users/trilinos/tpl/gcc/phdf5-1.8.6/lib" - "-DHDF5_INCLUDE_DIRS=/Users/trilinos/tpl/gcc/phdf5-1.8.6/include" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s903186/ctest_mac_nightly_mpi_opt_s903186.cmake b/cmake/ctest/drivers/s903186/ctest_mac_nightly_mpi_opt_s903186.cmake deleted file mode 100644 index 381c8fa095a9..000000000000 --- a/cmake/ctest/drivers/s903186/ctest_mac_nightly_mpi_opt_s903186.cmake +++ /dev/null @@ -1,85 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.s903186.gcc4.8.1.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(EXTRA_EXCLUDE_PACKAGES Zoltan PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS=/Volumes/SnowLeopardOSX/Users/trilinos/tpl/gcc/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/Volumes/SnowLeopardOSX/Users/trilinos/tpl/gcc/pnetcdf_4.2/include" - "-DHDF5_LIBRARY_DIRS=/Volumes/SnowLeopardOSX/Users/trilinos/tpl/gcc/phdf5-1.8.6/lib" - "-DHDF5_INCLUDE_DIRS=/Volumes/SnowLeopardOSX/Users/trilinos/tpl/gcc/phdf5-1.8.6/include" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s903186/ctest_mac_nightly_mpi_opt_shared_s903186.cmake b/cmake/ctest/drivers/s903186/ctest_mac_nightly_mpi_opt_shared_s903186.cmake deleted file mode 100644 index 0262b8ea4f44..000000000000 --- a/cmake/ctest/drivers/s903186/ctest_mac_nightly_mpi_opt_shared_s903186.cmake +++ /dev/null @@ -1,89 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.s903186.gcc4.8.1.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_SHARED) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(EXTRA_EXCLUDE_PACKAGES PyTrilinos Zoltan STK FEI NOX Piro Sundance) - -#Disabling STK below also so it is not turned on by TrilinosCouplings -SET( EXTRA_CONFIGURE_OPTIONS - "-DBUILD_SHARED_LIBS:BOOL=ON" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DTPL_ENABLE_X11:BOOL=OFF" - "-DNetcdf_LIBRARY_DIRS=/Volumes/SnowLeopardOSX/Users/trilinos/tpl/gcc/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/Volumes/SnowLeopardOSX/Users/trilinos/tpl/gcc/pnetcdf_4.2/include" - "-DHDF5_LIBRARY_DIRS=/Volumes/SnowLeopardOSX/Users/trilinos/tpl/gcc/phdf5-1.8.6/lib" - "-DHDF5_INCLUDE_DIRS=/Volumes/SnowLeopardOSX/Users/trilinos/tpl/gcc/phdf5-1.8.6/include" - "-DTrilinos_ENABLE_STK:BOOL=OFF" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s903186/ctest_mac_nightly_serial_debug_release_s903186.cmake b/cmake/ctest/drivers/s903186/ctest_mac_nightly_serial_debug_release_s903186.cmake deleted file mode 100644 index cf460bcf2f47..000000000000 --- a/cmake/ctest/drivers/s903186/ctest_mac_nightly_serial_debug_release_s903186.cmake +++ /dev/null @@ -1,89 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.s903186.gcc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME "SERIAL_DEBUG_${Trilinos_VERSION}") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(CTEST_PARALLEL_LEVEL 8) - -# Exclude Sundance because of strange segfault (see bug 4382) -SET(EXTRA_EXCLUDE_PACKAGES Sundance PyTrilinos Panzer) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS=/Users/trilinos/tpl/gcc/netcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/Users/trilinos/tpl/gcc/netcdf_4.2/include" - "-DHDF5_LIBRARY_DIRS=/Users/trilinos/tpl/gcc/hdf5-1.8.6/lib" - "-DHDF5_INCLUDE_DIRS=/Users/trilinos/tpl/gcc/hdf5-1.8.6/include" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s903186/ctest_mac_nightly_serial_debug_s903186.cmake b/cmake/ctest/drivers/s903186/ctest_mac_nightly_serial_debug_s903186.cmake deleted file mode 100644 index 284e25f04fce..000000000000 --- a/cmake/ctest/drivers/s903186/ctest_mac_nightly_serial_debug_s903186.cmake +++ /dev/null @@ -1,87 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.s903186.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_DEV) -SET(CTEST_PARALLEL_LEVEL 8) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -# Exclude Sundance because of strange segfault (see bug 4382) -SET(EXTRA_EXCLUDE_PACKAGES Sundance PyTrilinos STK Panzer) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DTPL_ENABLE_X11:BOOL=OFF" - "-DNetcdf_LIBRARY_DIRS=/Users/trilinos/tpl/gcc/netcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/Users/trilinos/tpl/gcc/netcdf_4.2/include" - "-DHDF5_LIBRARY_DIRS=/Users/trilinos/tpl/gcc/hdf5-1.8.6/lib" - "-DHDF5_INCLUDE_DIRS=/Users/trilinos/tpl/gcc/hdf5-1.8.6/include" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s909348/CMakeLists.txt b/cmake/ctest/drivers/s909348/CMakeLists.txt deleted file mode 100644 index 3a1710a6b723..000000000000 --- a/cmake/ctest/drivers/s909348/CMakeLists.txt +++ /dev/null @@ -1,35 +0,0 @@ -INCLUDE("../../../../Version.cmake") - -TRILINOS_DRIVER_SETUP() - -IF(${Trilinos_REPOSITORY_BRANCH} STREQUAL "master") - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_OPT - ctest_mac_nightly_mpi_opt_s909348.cmake - TIMEOUT_MINUTES 240 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG - ctest_mac_nightly_serial_debug_s909348.cmake - RUN_SERIAL - TIMEOUT_MINUTES 300 - ) -ELSE() - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_RELEASE - ctest_mac_nightly_mpi_release_s909348.cmake - TIMEOUT_MINUTES 330 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_RELEASE - ctest_mac_nightly_serial_release_s909348.cmake - RUN_SERIAL - TIMEOUT_MINUTES 300 - ) - -ENDIF() - - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/s909348/TrilinosCTestDriverCore.s909348.gcc.cmake b/cmake/ctest/drivers/s909348/TrilinosCTestDriverCore.s909348.gcc.cmake deleted file mode 100644 index 905a5e90894b..000000000000 --- a/cmake/ctest/drivers/s909348/TrilinosCTestDriverCore.s909348.gcc.cmake +++ /dev/null @@ -1,114 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for godel using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j2 -i" ) - - SET( CTEST_PARALLEL_LEVEL "2" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} PyTrilinos TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENCENCY_UNIT_TESTS:BOOL=OFF" - "-DBoost_INCLUDE_DIRS:FILEPATH=/Users/bmpersc/lib/boost_1_49_0" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DTPL_ENABLE_Matio=OFF" - "-DIntrepid_ENABLE_DEBUG_INF_CHECK=OFF" - ) - - SET_DEFAULT(COMPILER_VERSION "GCC-4.3.3") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/Users/bmpersc/bin/openmpi-1.3.2" - ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/Users/bmpersc/bin/gcc-4.3.3/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/Users/bmpersc/bin/gcc-4.3.3/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/Users/bmpersc/bin/gcc-4.3.3/bin/gfortran" - ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/s909348/cron_driver.sh b/cmake/ctest/drivers/s909348/cron_driver.sh deleted file mode 100755 index a590c1decf48..000000000000 --- a/cmake/ctest/drivers/s909348/cron_driver.sh +++ /dev/null @@ -1,38 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on s909348: `date`" -echo - -# TrilinosDriver settings: -# - -export TDD_GIT_EXE=/Users/bmpersc/bin/eg -export TDD_PARALLEL_LEVEL=2 -export TDD_CTEST_TEST_TYPE=Nightly - -# Trilinos settings: -# - -#export CTEST_TEST_TYPE=Experimental - -#export CTEST_DO_SUBMIT=FALSE - -#export CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=FALSE - -#export Trilinos_PACKAGES=Teuchos - -# Machine specific environment: -# - -#export PYTHONPATH=/Users/jmwille/install/lib/python2.5/site-packages - -# Machine independent cron_driver: -# - -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on s909348: `date`" -echo diff --git a/cmake/ctest/drivers/s909348/ctest_mac_nightly_mpi_debug_s909348.cmake b/cmake/ctest/drivers/s909348/ctest_mac_nightly_mpi_debug_s909348.cmake deleted file mode 100644 index cbb79bd12181..000000000000 --- a/cmake/ctest/drivers/s909348/ctest_mac_nightly_mpi_debug_s909348.cmake +++ /dev/null @@ -1,83 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.s909348.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG_DEV) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(EXTRA_EXCLUDE_PACKAGES Zoltan ) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS=/Users/bmpersc/lib/pnetcdf-4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/Users/bmpersc/lib/pnetcdf-4.2/include" - "-DHDF5_LIBRARY_DIRS=/Users/bmpersc/lib/phdf5-1.8.6/lib" - "-DHDF5_INCLUDE_DIRS=/Users/bmpersc/lib/phdf5=1.8.6/include" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s909348/ctest_mac_nightly_mpi_opt_s909348.cmake b/cmake/ctest/drivers/s909348/ctest_mac_nightly_mpi_opt_s909348.cmake deleted file mode 100644 index 4feb57689cfd..000000000000 --- a/cmake/ctest/drivers/s909348/ctest_mac_nightly_mpi_opt_s909348.cmake +++ /dev/null @@ -1,85 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.s909348.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(EXTRA_EXCLUDE_PACKAGES Zoltan) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DNetcdf_LIBRARY_DIRS=/Users/bmpersc/lib/pnetcdf-4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/Users/bmpersc/lib/pnetcdf-4.2/include" - "-DHDF5_LIBRARY_DIRS=/Users/bmpersc/lib/phdf5-1.8.6/lib" - "-DHDF5_INCLUDE_DIRS=/Users/bmpersc/lib/phdf5=1.8.6/include" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s909348/ctest_mac_nightly_mpi_release_s909348.cmake b/cmake/ctest/drivers/s909348/ctest_mac_nightly_mpi_release_s909348.cmake deleted file mode 100644 index 947868dbcca5..000000000000 --- a/cmake/ctest/drivers/s909348/ctest_mac_nightly_mpi_release_s909348.cmake +++ /dev/null @@ -1,89 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.s909348.gcc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "MPI_RELEASE_${Trilinos_VERSION}") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) - -SET(EXTRA_EXCLUDE_PACKAGES Zoltan) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS=/Users/bmpersc/lib/pnetcdf-4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/Users/bmpersc/lib/pnetcdf-4.2/include" - "-DHDF5_LIBRARY_DIRS=/Users/bmpersc/lib/phdf5-1.8.6/lib" - "-DHDF5_INCLUDE_DIRS=/Users/bmpersc/lib/phdf5=1.8.6/include" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s909348/ctest_mac_nightly_serial_debug_s909348.cmake b/cmake/ctest/drivers/s909348/ctest_mac_nightly_serial_debug_s909348.cmake deleted file mode 100644 index ab0000f0724f..000000000000 --- a/cmake/ctest/drivers/s909348/ctest_mac_nightly_serial_debug_s909348.cmake +++ /dev/null @@ -1,85 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.s909348.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_DEV) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -# Exclude Sundance because of strange segfault (see bug 4382) -SET(EXTRA_EXCLUDE_PACKAGES Sundance Panzer) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS=/Users/bmpersc/lib/netcdf-4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/Users/bmpersc/lib/netcdf-4.2/include" - "-DHDF5_LIBRARY_DIRS=/Users/bmpersc/lib/hdf5-1.8.6/lib" - "-DHDF5_INCLUDE_DIRS=/Users/bmpersc/lib/hdf5=1.8.6/include" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s909348/ctest_mac_nightly_serial_release_s909348.cmake b/cmake/ctest/drivers/s909348/ctest_mac_nightly_serial_release_s909348.cmake deleted file mode 100644 index 6a638be6d6a1..000000000000 --- a/cmake/ctest/drivers/s909348/ctest_mac_nightly_serial_release_s909348.cmake +++ /dev/null @@ -1,90 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.s909348.gcc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "SERIAL_RELEASE_${Trilinos_VERSION}") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) - -# Exclude Sundance because of strange segfault (see bug 4382) -SET(EXTRA_EXCLUDE_PACKAGES Sundance Panzer) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS=/Users/bmpersc/lib/netcdf-4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/Users/bmpersc/lib/netcdf-4.2/include" - "-DHDF5_LIBRARY_DIRS=/Users/bmpersc/lib/hdf5-1.8.6/lib" - "-DHDF5_INCLUDE_DIRS=/Users/bmpersc/lib/hdf5=1.8.6/include" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s921620/CMakeLists.txt b/cmake/ctest/drivers/s921620/CMakeLists.txt deleted file mode 100644 index 89878e44301a..000000000000 --- a/cmake/ctest/drivers/s921620/CMakeLists.txt +++ /dev/null @@ -1,13 +0,0 @@ -TRILINOS_DRIVER_SETUP() - -TRILINOS_DRIVER_ADD_DASHBOARD( - SHYLU_MPI - ctest_s921620_shylu.cmake -) - -TRILINOS_DRIVER_ADD_DASHBOARD( - AMESOS2_MPI - ctest_s921620_amesos2.cmake -) - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/s921620/cron_driver_s921620.sh b/cmake/ctest/drivers/s921620/cron_driver_s921620.sh deleted file mode 100755 index e23271c0547f..000000000000 --- a/cmake/ctest/drivers/s921620/cron_driver_s921620.sh +++ /dev/null @@ -1,7 +0,0 @@ - -export MAILTO="shylu-regression@software.sandia.gov" -export TDD_HTTP_PROXY="http://sonproxy.sandia.gov:80/" -export TDD_CTEST_TEST_TYPE=Nightly -export HTTP_PROXY="http://sonproxy.sandia.gov:80/" -/usr/local/bin/git pull -env ../cron_driver.py diff --git a/cmake/ctest/drivers/s921620/ctest_s921620_amesos2.cmake b/cmake/ctest/drivers/s921620/ctest_s921620_amesos2.cmake deleted file mode 100644 index f6737136e746..000000000000 --- a/cmake/ctest/drivers/s921620/ctest_s921620_amesos2.cmake +++ /dev/null @@ -1,123 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "AMESOS2_MPI") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) -SET(CTEST_TEST_TYPE Nightly) -SET(CTEST_TEST_TIMEOUT "2400") - -# -# Set the rest of the system-specific options and run the dashboard build/test -# Platform/compiler specific options for octopi -# - -# Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - -SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - -SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - -SET( CTEST_BUILD_FLAGS "-j8 -i" ) - -SET_DEFAULT( CTEST_PARALLEL_LEVEL "1" ) -#SET_DEFAULT(COMPILER_VERSION "GCC-3.4.6") - - -#SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -# Only turn on PyTrilinos for shared libraries -#SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES TriKota Optika) -SET(Trilinos_PACKAGES Amesos2 ShyLU) - -# Output of "mpicc --showme:compile" and "mpiCC --showme:compile" -SET(MY_CFLAGS "-m64") -SET(MY_CXXFLAGS "-m64") - -# MPI info; needed for mpirun; also need this in path. -set(MY_MPI "/usr/lib64/openmpi/1.4-gcc") -set(TPL_ENABLE_MPI ON) - -set(TDD_HTTP_PROXY "http://sonproxy.sandia.gov:80/") - -SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DTrilinos_ALLOW_NO_PACKAGES:BOOL=OFF" - "-DMPI_BASE_DIR:STRING=${MY_MPI}" - "-DCMAKE_C_FLAGS:STRING=${MY_CFLAGS}" - "-DCMAKE_CXX_FLAGS:STRING=${MY_CXXFLAGS}" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=ON " - "-DTrilinos_ENABLE_EXAMPLES:BOOL=ON " - "-DTrilinos_ENABLE_Amesos2:BOOL=ON " - "-DTrilinos_VERBOSE_CONFIGURE:BOOL=ON " - "-DAmesos2_ENABLE_TESTS:BOOL=ON " - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENCENCY_UNIT_TESTS:BOOL=OFF" - "-DTPL_LAPACK_LIBRARIES:FILEPATH=/home/srajama/lapack/lapack-3.2.1/lapack_LINUX.a" - "-DTPL_BLAS_LIBRARIES:FILEPATH=/home/srajama/lapack/lapack-3.2.1/blas_LINUX.a" - ) - -TRILINOS_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s921620/ctest_s921620_shylu.cmake b/cmake/ctest/drivers/s921620/ctest_s921620_shylu.cmake deleted file mode 100644 index 5827c86a1866..000000000000 --- a/cmake/ctest/drivers/s921620/ctest_s921620_shylu.cmake +++ /dev/null @@ -1,123 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "SHYLU_MPI") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) -SET(CTEST_TEST_TYPE Nightly) -SET(CTEST_TEST_TIMEOUT "2400") - -# -# Set the rest of the system-specific options and run the dashboard build/test -# Platform/compiler specific options for octopi -# - -# Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - -SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - -SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - -SET( CTEST_BUILD_FLAGS "-j8 -i" ) - -SET_DEFAULT( CTEST_PARALLEL_LEVEL "1" ) -#SET_DEFAULT(COMPILER_VERSION "GCC-3.4.6") - - -#SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -# Only turn on PyTrilinos for shared libraries -#SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES TriKota Optika) -SET(Trilinos_PACKAGES Amesos2 ShyLU) - -# Output of "mpicc --showme:compile" and "mpiCC --showme:compile" -SET(MY_CFLAGS "-m64") -SET(MY_CXXFLAGS "-m64") - -# MPI info; needed for mpirun; also need this in path. -set(MY_MPI "/usr/lib64/openmpi/1.4-gcc") -set(TPL_ENABLE_MPI ON) - -set(TDD_HTTP_PROXY "http://sonproxy.sandia.gov:80/") - -SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DTrilinos_ALLOW_NO_PACKAGES:BOOL=OFF" - "-DMPI_BASE_DIR:STRING=${MY_MPI}" - "-DCMAKE_C_FLAGS:STRING=${MY_CFLAGS}" - "-DCMAKE_CXX_FLAGS:STRING=${MY_CXXFLAGS}" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=ON " - "-DTrilinos_ENABLE_EXAMPLES:BOOL=ON " - "-DTrilinos_ENABLE_ShyLU:BOOL=ON " - "-DTrilinos_VERBOSE_CONFIGURE:BOOL=ON " - "-DShyLU_ENABLE_TESTS:BOOL=ON " - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENCENCY_UNIT_TESTS:BOOL=OFF" - "-DTPL_LAPACK_LIBRARIES:FILEPATH=/home/srajama/lapack/lapack-3.2.1/lapack_LINUX.a" - "-DTPL_BLAS_LIBRARIES:FILEPATH=/home/srajama/lapack/lapack-3.2.1/blas_LINUX.a" - ) - -TRILINOS_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s956330/CMakeLists.txt b/cmake/ctest/drivers/s956330/CMakeLists.txt deleted file mode 100644 index a6acdf1280b5..000000000000 --- a/cmake/ctest/drivers/s956330/CMakeLists.txt +++ /dev/null @@ -1,44 +0,0 @@ -INCLUDE("../../../../Version.cmake") - -TRILINOS_DRIVER_SETUP() - -set(CTEST_EXE "${CMAKE_CTEST_COMMAND}") -set(workingdir "${TrilinosDriver_BINARY_DIR}") - -# Get the day of the week -#execute_process(COMMAND date +%A OUTPUT_VARIABLE DAYOFWEEK) - -IF(${Trilinos_REPOSITORY_BRANCH} STREQUAL "master") - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_DEBUG_DEV - ctest_linux_nightly_mpi_development_debug_gcc_4.8.2_s956330.cmake - CTEST_INSTALLER_TYPE release - TIMEOUT_MINUTES 480 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_OPT_DEV - ctest_linux_nightly_serial_development_opt_gcc_4.8.2_s956330.cmake - CTEST_INSTALLER_TYPE release - TIMEOUT_MINUTES 480 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_OPT_DEV_SHARED - ctest_linux_nightly_mpi_development_opt_shared_gcc_4.8.2_s956330.cmake - CTEST_INSTALLER_TYPE release - TIMEOUT_MINUTES 480 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_OPT_DEV_CLANG - ctest_linux_nightly_serial_development_opt_clang_3.4_s956330.cmake - CTEST_INSTALLER_TYPE release - TIMEOUT_MINUTES 480 - ) - -ELSE() -#release tests would go here -ENDIF() - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/s956330/TrilinosCTestDriverCore.s956330.clang3.4.cmake b/cmake/ctest/drivers/s956330/TrilinosCTestDriverCore.s956330.clang3.4.cmake deleted file mode 100644 index da3e2692916e..000000000000 --- a/cmake/ctest/drivers/s956330/TrilinosCTestDriverCore.s956330.clang3.4.cmake +++ /dev/null @@ -1,121 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for trilinos-test using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_BUILD_FLAGS "-j11 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "11" ) - - #SET( CTEST_COVERAGE_COMMAND /projects/sems/compilers/clang/3.4/bin/gcov ) - #SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DTPL_ENABLE_Matio=OFF" - "-DIntrepid_ENABLE_DEBUG_INF_CHECK=OFF" - ) - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - SET_DEFAULT(COMPILER_VERSION "Clang-3.4") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR=/projects/sems/compilers/clang/openmpi_1.6.5_clang_3.4" - ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/projects/sems/compilers/clang/3.4/bin/clang++" - "-DCMAKE_C_COMPILER:FILEPATH=/projects/sems/compilers/clang/3.4/bin/clang" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/projects/sems/compilers/gcc/4.8.2/bin/gfortran" - ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/s956330/TrilinosCTestDriverCore.s956330.gcc4.8.2.cmake b/cmake/ctest/drivers/s956330/TrilinosCTestDriverCore.s956330.gcc4.8.2.cmake deleted file mode 100644 index 5778eab07cc2..000000000000 --- a/cmake/ctest/drivers/s956330/TrilinosCTestDriverCore.s956330.gcc4.8.2.cmake +++ /dev/null @@ -1,128 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for trilinos-test using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_BUILD_FLAGS "-j11 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "11" ) - - SET( CTEST_COVERAGE_COMMAND /projects/sems/compilers/gcc/4.8.2/bin/gcov ) - #SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DCOVERAGE_COMMAND:FILEPATH=/projects/sems/compilers/gcc/4.8.2/bin/gcov" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DTPL_ENABLE_Matio=OFF" - "-DIntrepid_ENABLE_DEBUG_INF_CHECK=OFF" - ) - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - SET_DEFAULT(COMPILER_VERSION "GCC-4.8.2") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR=/projects/sems/compilers/gcc/openmpi_1.6.5_gcc_4.8.2" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_openmpi_1.2.7.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/projects/sems/compilers/gcc/4.8.2/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/projects/sems/compilers/gcc/4.8.2/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/projects/sems/compilers/gcc/4.8.2/bin/gfortran" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_gcc-4.1.2.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/s956330/cron_driver.sh b/cmake/ctest/drivers/s956330/cron_driver.sh deleted file mode 100755 index a2ef4dfc5b28..000000000000 --- a/cmake/ctest/drivers/s956330/cron_driver.sh +++ /dev/null @@ -1,43 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on s956330: `date`" -echo - -# TrilinosDriver settings: -# - -export TDD_GIT_EXE=/usr/bin/git -export TDD_PARALLEL_LEVEL=2 - -# Trilinos settings: -# - -export TDD_CTEST_TEST_TYPE=Experimental - -#export CTEST_DO_SUBMIT=FALSE - -#export CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=FALSE - -#export Trilinos_PACKAGES=Teuchos - -# Machine specific environment: -# - -#export PYTHONPATH=/Users/jmwille/install/lib/python2.5/site-packages - -export PATH=/projects/sems/utilities/bin:/projects/sems/compilers/clang/3.4/bin:/projects/sems/compilers/gcc/4.8.2/bin:/projects/sems/compilers/gcc/openmpi_1.6.5_gcc_4.8.2/bin:$PATH - -export DYLD_LIBRARY_PATH=/projects/sems/compilers/clang/3.4/lib:/projects/sems/compilers/gcc/4.8.2/lib:/projects/sems/compilers/gcc/openmpi_1.6.5_gcc_4.8.2/lib:$DYLD_LIBRARY_PATH -export LD_LIBRARY_PATH=/projects/sems/compilers/clang/3.4/lib:/projects/sems/compilers/gcc/4.8.2/lib:/projects/sems/compilers/gcc/openmpi_1.6.5_gcc_4.8.2/lib:$LD_LIBRARY_PATH -export PYTHONPATH="/projects/sems/tpls/gcc_4.8.2/arch_x86/numpy_1.8.0/lib/python2.7/site-packages" - -# Machine independent cron_driver: -# - -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on s956330: `date`" -echo diff --git a/cmake/ctest/drivers/s956330/ctest_linux_nightly_mpi_development_debug_gcc_4.8.2_s956330.cmake b/cmake/ctest/drivers/s956330/ctest_linux_nightly_mpi_development_debug_gcc_4.8.2_s956330.cmake deleted file mode 100644 index 2d7f87c866c8..000000000000 --- a/cmake/ctest/drivers/s956330/ctest_linux_nightly_mpi_development_debug_gcc_4.8.2_s956330.cmake +++ /dev/null @@ -1,107 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.s956330.gcc4.8.2.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG_DEV) -SET(ENV{LD_LIBRARY_PATH} "/projects/sems/compilers/gcc/4.8.2/lib:/projects/sems/compilers/gcc/openmpi_1.6.5_gcc_4.8.2/lib:$ENV{LD_LIBRARY_PATH}") -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) -SET( CTEST_BUILD_FLAGS "-j12 -i" ) -SET( CTEST_PARALLEL_LEVEL "12" ) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(EXTRA_EXCLUDE_PACKAGES PyTrilinos ) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DBoost_INCLUDE_DIRS:FILEPATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/boost_1.49.0" - "-DTPL_ENABLE_SuperLU=ON" - "-DSuperLU_INCLUDE_DIRS:PATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/SuperLU_4.3/SRC" - "-DSuperLU_LIBRARY_DIRS:PATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/SuperLU_4.3/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu_4.3" - "-DZoltan2_ENABLE_Experimental:BOOL=ON" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/phdf5_1.8.12/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/phdf5_1.8.12/lib" - "-DTPL_ENABLE_Netcdf:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS=/projects/sems/tpls/gcc_4.8.2/arch_x86/pnetcdf_4.3.0/lib" - "-DNetcdf_INCLUDE_DIRS=/projects/sems/tpls/gcc_4.8.2/arch_x86/pnetcdf_4.3.0/include" - "-DTPL_ENABLE_ParMETIS:BOOL=ON" - "-DTPL_ParMETIS_LIBRARIES:STRING=-L/projects/sems/tpls/gcc_4.8.2/arch_x86/parmetis_4.0.3/lib -lparmetis -L/projects/sems/tpls/gcc_4.8.2/arch_x86/metis_5.1.0/lib -lmetis" - "-DTPL_ParMETIS_INCLUDE_DIRS=/projects/sems/tpls/gcc_4.8.2/arch_x86/parmetis_4.0.3/include" - "-DZoltan_ENABLE_ParMETIS=OFF" - "-DTPL_ENABLE_METIS:BOOL=ON" - "-DMETIS_LIBRARY_DIRS:PATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/metis_5.1.0/lib" - "-DMETIS_INCLUDE_DIRS:PATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/metis_5.1.0/include" - "-DSWIG_EXECUTABLE:FILEPATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/swig_2.0.11/bin/swig" - "-DTPL_QT_QMAKE_EXECUTABLE:FILEPATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/qt_4.8.5/bin/qmake" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s956330/ctest_linux_nightly_mpi_development_opt_shared_gcc_4.8.2_s956330.cmake b/cmake/ctest/drivers/s956330/ctest_linux_nightly_mpi_development_opt_shared_gcc_4.8.2_s956330.cmake deleted file mode 100644 index c50a93a483e2..000000000000 --- a/cmake/ctest/drivers/s956330/ctest_linux_nightly_mpi_development_opt_shared_gcc_4.8.2_s956330.cmake +++ /dev/null @@ -1,107 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.s956330.gcc4.8.2.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV_SHARED) -SET(ENV{LD_LIBRARY_PATH} "/projects/sems/compilers/gcc/4.8.2/lib:/projects/sems/compilers/gcc/openmpi_1.6.5_gcc_4.8.2/lib:$ENV{LD_LIBRARY_PATH}") -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) -SET( CTEST_BUILD_FLAGS "-j11 -i" ) -SET( CTEST_PARALLEL_LEVEL "11" ) -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(EXTRA_EXCLUDE_PACKAGES Optika ) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DPyTrilinos_ENABLE_STK=OFF" - "-DBUILD_SHARED_LIBS:BOOL=ON" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DBoost_INCLUDE_DIRS:FILEPATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/boost_1.49.0" - "-DTPL_ENABLE_SuperLU=ON" - "-DSuperLU_INCLUDE_DIRS:PATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/SuperLU_4.3/SRC" - "-DSuperLU_LIBRARY_DIRS:PATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/SuperLU_4.3/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu_4.3" - "-DZoltan2_ENABLE_Experimental:BOOL=ON" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/phdf5_1.8.12/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/phdf5_1.8.12/lib" - "-DTPL_ENABLE_Netcdf:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS=/projects/sems/tpls/gcc_4.8.2/arch_x86/pnetcdf_4.3.0/lib" - "-DNetcdf_INCLUDE_DIRS=/projects/sems/tpls/gcc_4.8.2/arch_x86/pnetcdf_4.3.0/include" - "-DTPL_ENABLE_ParMETIS:BOOL=ON" - "-DTPL_ParMETIS_LIBRARIES:STRING=-L/projects/sems/tpls/gcc_4.8.2/arch_x86/parmetis_4.0.3/lib -lparmetis -L/projects/sems/tpls/gcc_4.8.2/arch_x86/metis_5.1.0/lib -lmetis" - "-DTPL_ParMETIS_INCLUDE_DIRS=/projects/sems/tpls/gcc_4.8.2/arch_x86/parmetis_4.0.3/include" - "-DZoltan_ENABLE_ParMETIS=OFF" - "-DTPL_ENABLE_METIS:BOOL=ON" - "-DMETIS_LIBRARY_DIRS:PATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/metis_5.1.0/lib" - "-DMETIS_INCLUDE_DIRS:PATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/metis_5.1.0/include" - "-DSWIG_EXECUTABLE:FILEPATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/swig_2.0.11/bin/swig" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s956330/ctest_linux_nightly_serial_development_opt_clang_3.4_s956330.cmake b/cmake/ctest/drivers/s956330/ctest_linux_nightly_serial_development_opt_clang_3.4_s956330.cmake deleted file mode 100644 index 44123493e958..000000000000 --- a/cmake/ctest/drivers/s956330/ctest_linux_nightly_serial_development_opt_clang_3.4_s956330.cmake +++ /dev/null @@ -1,110 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.s956330.clang3.4.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_OPT_DEV_CLANG) -SET(COMPILER_VERSION "Clang-3.4") -SET(ENV{LD_LIBRARY_PATH} "/projects/sems/compilers/clang/3.4/lib:$ENV{LD_LIBRARY_PATH}") -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) -SET( CTEST_BUILD_FLAGS "-j11 -i" ) -SET( CTEST_PARALLEL_LEVEL "11" ) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) -#Stokhos is explicitly disabled below to prevent the package from being -#implicitly enabled. Sundance depends on Stokhos. -SET(EXTRA_EXCLUDE_PACKAGES PyTrilinos Optika ) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DBoost_INCLUDE_DIRS:FILEPATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/boost_1.49.0" - "-DTPL_ENABLE_SuperLU=ON" - "-DSuperLU_INCLUDE_DIRS:PATH=/projects/sems/tpls/clang_3.4/arch_x86_64/SuperLU_4.3/SRC" - "-DSuperLU_LIBRARY_DIRS:PATH=/projects/sems/tpls/clang_3.4/arch_x86_64/SuperLU_4.3/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu_4.3" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DCMAKE_CXX_COMPILER:FILEPATH=/projects/sems/compilers/clang/3.4/bin/clang++" - "-DCMAKE_C_COMPILER:FILEPATH=/projects/sems/compilers/clang/3.4/bin/clang" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/projects/sems/compilers/gcc/4.8.2/bin/gfortran" - "-DTPL_ENABLE_HDF5:BOOL=OFF" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/hdf5_1.8.12/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/hdf5_1.8.12/lib" - "-DTPL_ENABLE_Netcdf:BOOL=OFF" - "-DNetcdf_LIBRARY_DIRS=/projects/sems/tpls/gcc_4.8.2/arch_x86/pnetcdf_4.3.0/lib" - "-DNetcdf_INCLUDE_DIRS=/projects/sems/tpls/gcc_4.8.2/arch_x86/pnetcdf_4.3.0/include" - "-DSWIG_EXECUTABLE:FILEPATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/swig_2.0.11/bin/swig" - "-DTPL_ENABLE_METIS:BOOL=OFF" - "-DMETIS_LIBRARY_DIRS:PATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/metis_5.1.0/lib" - "-DMETIS_INCLUDE_DIRS:PATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/metis_5.1.0/include" - "-DZoltan_ENABLE_ParMETIS=OFF" - "-DZoltan_ENABLE_METIS=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/s956330/ctest_linux_nightly_serial_development_opt_gcc_4.8.2_s956330.cmake b/cmake/ctest/drivers/s956330/ctest_linux_nightly_serial_development_opt_gcc_4.8.2_s956330.cmake deleted file mode 100644 index 74910838c892..000000000000 --- a/cmake/ctest/drivers/s956330/ctest_linux_nightly_serial_development_opt_gcc_4.8.2_s956330.cmake +++ /dev/null @@ -1,110 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.s956330.gcc4.8.2.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_OPT_DEV) -SET(COMPILER_VERSION "GCC-4.8.2") -SET(ENV{LD_LIBRARY_PATH} "/projects/sems/compilers/gcc/4.8.2/lib:$ENV{LD_LIBRARY_PATH}") -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) -SET( CTEST_BUILD_FLAGS "-j11 -i" ) -SET( CTEST_PARALLEL_LEVEL "11" ) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) -#Stokhos is explicitly disabled below to prevent the package from being -#implicitly enabled. Sundance depends on Stokhos. -SET(EXTRA_EXCLUDE_PACKAGES PyTrilinos Optika) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DBoost_INCLUDE_DIRS:FILEPATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/boost_1.49.0" - "-DTPL_ENABLE_SuperLU=ON" - "-DSuperLU_INCLUDE_DIRS:PATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/SuperLU_4.3/SRC" - "-DSuperLU_LIBRARY_DIRS:PATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/SuperLU_4.3/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu_4.3" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DCMAKE_CXX_COMPILER:FILEPATH=/projects/sems/compilers/gcc/4.8.2/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/projects/sems/compilers/gcc/4.8.2/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/projects/sems/compilers/gcc/4.8.2/bin/gfortran" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/hdf5_1.8.12/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/hdf5_1.8.12/lib" - "-DTPL_ENABLE_Netcdf:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS=/projects/sems/tpls/gcc_4.8.2/arch_x86/pnetcdf_4.3.0/lib" - "-DNetcdf_INCLUDE_DIRS=/projects/sems/tpls/gcc_4.8.2/arch_x86/pnetcdf_4.3.0/include" - "-DSWIG_EXECUTABLE:FILEPATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/swig_2.0.11/bin/swig" - "-DTPL_ENABLE_METIS:BOOL=ON" - "-DMETIS_LIBRARY_DIRS:PATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/metis_5.1.0/lib" - "-DMETIS_INCLUDE_DIRS:PATH=/projects/sems/tpls/gcc_4.8.2/arch_x86/metis_5.1.0/include" - "-DZoltan_ENABLE_ParMETIS=OFF" - "-DZoltan_ENABLE_METIS=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/sadl30906/TrilinosCTestDriverCore.sadl30906.gcc.cmake b/cmake/ctest/drivers/sadl30906/TrilinosCTestDriverCore.sadl30906.gcc.cmake deleted file mode 100644 index dd001b734f31..000000000000 --- a/cmake/ctest/drivers/sadl30906/TrilinosCTestDriverCore.sadl30906.gcc.cmake +++ /dev/null @@ -1,148 +0,0 @@ -# @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 - -SET(PythonInterp_FIND_VERSION 2.7) -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for trilinos-test2 using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_BUILD_FLAGS "-j10 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "10" ) - - SET( CTEST_COVERAGE_COMMAND gcov ) - SET( CTEST_MEMORYCHECK_COMMAND valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} PyTrilinos TriKota) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DCOVERAGE_COMMAND:FILEPATH=${CTEST_COVERAGE_COMMAND}" - "-DMEMORYCHECK_COMMAND:FILEPATH=${CTEST_MEMORYCHECK_COMMAND}" - "-DTrilinos_ENABLE_COMPLEX:BOOL=ON" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" -# "-DCppUnit_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/cppunit-1.12.1/include" -# "-DCppUnit_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.1.2/cppunit-1.12.1/lib" - "-DParMETIS_INCLUDE_DIRS:PATH=$ENV{SEMS_PARMETIS_INCLUDE_PATH}" - "-DParMETIS_LIBRARY_DIRS:PATH=$ENV{SEMS_PARMETIS_LIBRARY_PATH}" - "-DSuperLU_INCLUDE_DIRS:PATH=$ENV{SEMS_SUPERLU_INCLUDE_PATH}" - "-DSuperLU_LIBRARY_DIRS:PATH=$ENV{SEMS_SUPERLU_LIBRARY_PATH}" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu" - "-DBoost_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_BOOST_INCLUDE_PATH}" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=$ENV{SEMS_BOOST_INCLUDE_PATH}" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=$ENV{SEMS_BOOST_LIBRARY_PATH}" - "-DZlib_INCLUDE_DIRS:PATH=$ENV{SEMS_ZLIB_INCLUDE_PATH}" - "-DZlib_LIBRARY_DIRS:PATH=$ENV{SEMS_ZLIB_LIBRARY_PATH}" - "-DHDF5_INCLUDE_DIRS:PATH=$ENV{SEMS_HDF5_INCLUDE_PATH}" - "-DHDF5_LIBRARY_DIRS:PATH=$ENV{SEMS_HDF5_LIBRARY_PATH}" - "-DNetcdf_INCLUDE_DIRS:PATH=$ENV{SEMS_NETCDF_INCLUDE_PATH}" - "-DNetcdf_LIBRARY_DIRS:PATH=$ENV{SEMS_NETCDF_LIBRARY_PATH}" - "-DTPL_ENABLE_Matio=OFF" - "-DTPL_ENABLE_GLM=OFF" - "-DTPL_ENABLE_X11=OFF" - "-DIntrepid2_ENABLE_DEBUG_INF_CHECK:BOOL=OFF" - "-DPythonInterp_FIND_VERSION=2.7" - ) - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - SET_DEFAULT(COMPILER_VERSION "$ENV{SEMS_COMPILER_NAME}-$ENV{SEMS_COMPILER_VERSION}") - - IF (COMM_TYPE STREQUAL MPI) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR=$ENV{SEMS_OPENMPI_ROOT}" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test2_openmpi_1.2.7.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=$ENV{CXX}" - "-DCMAKE_C_COMPILER:FILEPATH=$ENV{CC}" - "-DCMAKE_Fortran_COMPILER:FILEPATH=$ENV{FC}" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test2_gcc-4.1.2.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/sadl30906/ctest_linux_continuous_mpi_opt_shared_sadl30906_jenkins.cmake b/cmake/ctest/drivers/sadl30906/ctest_linux_continuous_mpi_opt_shared_sadl30906_jenkins.cmake deleted file mode 100644 index 01625f5ae702..000000000000 --- a/cmake/ctest/drivers/sadl30906/ctest_linux_continuous_mpi_opt_shared_sadl30906_jenkins.cmake +++ /dev/null @@ -1,161 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.sadl30906.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME CONTINUOUS_${COMM_TYPE}_OPT_DEV_SHARED) -#SET(CTEST_TEST_TIMEOUT 900) - -#override the default number of processors to run on. -SET( CTEST_BUILD_FLAGS "-j10 -i" ) -SET( CTEST_PARALLEL_LEVEL "10" ) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - -SET(Trilinos_BRANCH develop) - -SET(EXTRA_EXCLUDE_PACKAGES Optika) - -SET(Trilinos_ENABLE_Phalanx OFF) -SET(Trilinos_ENABLE_Panzer OFF) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_COMPLEX=OFF" - "-DTrilinos_TEST_CATEGORIES=BASIC" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - "-DTrilinos_ENABLE_DEBUG_SYMBOLS=OFF" - "-DBUILD_SHARED_LIBS:BOOL=ON" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DTPL_ENABLE_BoostLib:BOOL=ON" - "-DTPL_ENABLE_ParMETIS:BOOL=ON" - "-DTPL_ENABLE_Zlib:BOOL=ON" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DTPL_ENABLE_Netcdf:BOOL=ON" - "-DTPL_ENABLE_SuperLU:BOOL=ON" -# "-DTPL_ENABLE_CppUnit:BOOL=ON" - "-DSTK_stk_mesh_unit_tests_MPI_4_DISABLE=ON" - "-DSTK_util_parallel_UnitTest_MPI_4_DISABLE=ON" - "-DTrilinos_ENABLE_Phalanx=OFF" - "-DTrilinos_ENABLE_Panzer=OFF" - "-DAmesos2_ENABLE_KLU2=ON" - "-DTeuchos_ENABLE_DEFAULT_STACKTRACE=OFF" - "-DTrilinos_TRACE_ADD_TEST=ON" - "-DPiro_EpetraSolver_MPI_4_DISABLE=ON" - ) - -# Previous option to disable long-failing Pir test until it can be fixed (#826) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -SET(CTEST_TEST_TYPE Continuous) - -# Set the following variables to reasonable values so the Jenkins job -# provides useful feedback, rather then always returning an error -# because they aren't defined. - -# The Jenkins checkout of the scripts repository. -SET(CTEST_SOURCE_DIRECTORY "$ENV{WORKSPACE}/Trilinos") -# The location where the Jenkins script gets run. -SET(CTEST_BINARY_DIRECTORY "$ENV{WORKSPACE}/continuous-development") -# The CTest command being used by Jenkins. -SET(CTEST_COMMAND "ctest") - -function(VISIBLE_MESSAGE message) - message("\n***") - message("*** ${message}") - message("***\n") -endfunction() - -# Check to see if we need to start with an empty binary directory or enabling -# modified packages only. First, get the current time in seconds past the -# epoch. -execute_process( - COMMAND date +%s - OUTPUT_VARIABLE _current_time -) -set(_timestamp_file timestamp.txt) -if(NOT EXISTS ${_timestamp_file}) - VISIBLE_MESSAGE("No timestamp file exists, performing a clean build.") - SET(CTEST_START_WITH_EMPTY_BINARY_DIRECTORY ON) - SET(CTEST_ENABLE_MODIFIED_PACKAGES_ONLY OFF) - file(WRITE ${_timestamp_file} ${_current_time}) -else() - file(READ ${_timestamp_file} _last_time) - math(EXPR _difference "${_current_time} - ${_last_time}") - if(${_difference} GREATER 72000) # 20 hours - VISIBLE_MESSAGE("Timestamp is more than 20 hours old, performing a clean build.") - SET(CTEST_START_WITH_EMPTY_BINARY_DIRECTORY ON) - SET(CTEST_ENABLE_MODIFIED_PACKAGES_ONLY OFF) - file(WRITE ${_timestamp_file} ${_current_time}) - else() - VISIBLE_MESSAGE("Timestamp is less than 20 hours old, performing an incremental build.") - SET(CTEST_START_WITH_EMPTY_BINARY_DIRECTORY OFF) - SET(CTEST_ENABLE_MODIFIED_PACKAGES_ONLY ON) - endif() -endif() - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() - diff --git a/cmake/ctest/drivers/shiller/CMakeLists.txt b/cmake/ctest/drivers/shiller/CMakeLists.txt deleted file mode 100644 index dab4e2151680..000000000000 --- a/cmake/ctest/drivers/shiller/CMakeLists.txt +++ /dev/null @@ -1,11 +0,0 @@ -TRILINOS_DRIVER_SETUP() - -TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_Downstream_ETI_SERIAL-${Tpetra_INST_SERIAL}_OPENMP-${Tpetra_INST_OPENMP}_PTHREAD-${Tpetra_INST_PTHREAD}_CUDA-${Tpetra_INST_CUDA}_COMPLEX-${Teuchos_ENABLE_COMPLEX} - ctest_linux_nightly_mpi_release_downstream_ETI_generic_shiller.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 420 -) - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/shiller/TrilinosCTestDriverCore.shiller.generic.cmake b/cmake/ctest/drivers/shiller/TrilinosCTestDriverCore.shiller.generic.cmake deleted file mode 100644 index 7c8ddd581141..000000000000 --- a/cmake/ctest/drivers/shiller/TrilinosCTestDriverCore.shiller.generic.cmake +++ /dev/null @@ -1,130 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for typhon using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_BUILD_FLAGS "-j16 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "1" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENDENCY_UNIT_TESTS:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=ON" - - "-D Trilinos_ENABLE_CXX11=ON" - "-D Trilinos_CXX11_FLAGS:STRING=--std=c++11" - - "-DTPL_ENABLE_BLAS:BOOL=ON" - "-DTPL_ENABLE_LAPACK:BOOL=ON" - "-DSuperLU_INCLUDE_DIRS:PATH=$ENV{SUPERLU_ROOT}/include" - "-DSuperLU_LIBRARY_DIRS:PATH=$ENV{SUPERLU_ROOT}/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu_4.3" - "-DBoost_INCLUDE_DIRS:FILEPATH=$ENV{BOOST_ROOT}/include" - "-DBoost_LIBRARY_DIRS:FILEPATH=$ENV{BOOST_ROOT}/lib" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=$ENV{BOOST_ROOT}/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=$ENV{BOOST_ROOT}/lib" - "-DHDF5_INCLUDE_DIRS:FILEPATH=$ENV{HDF5_ROOT}/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=$ENV{HDF5_ROOT}/lib" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=$ENV{NETCDF_ROOT}/include" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=$ENV{NETCDF_ROOT}/lib" - "-DZlib_INCLUDE_DIRS:FILEPATH=$ENV{ZLIB_ROOT}/include" - "-DZlib_LIBRARY_DIRS:FILEPATH=$ENV{ZLIB_ROOT}/lib" - "-DTPL_ENABLE_X11:BOOL=OFF" - "-DTPL_ENABLE_Matio=OFF" - - ) - - SET_DEFAULT(COMPILER_VERSION "GCC-4.8.4") - - #Ensuring that MPI is on for all parallel builds that might be run. - IF(COMM_TYPE STREQUAL MPI) - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR=$ENV{MPI_ROOT}" - "-D MPI_CXX_COMPILER:FILEPATH=$ENV{MPI_ROOT}/bin/mpicxx" - "-D MPI_C_COMPILER:FILEPATH=$ENV{MPI_ROOT}/bin/mpicc" - "-D MPI_FORTRAN_COMPILER:FILEPATH=$ENV{MPI_ROOT}/bin/mpifort" - "-D CMAKE_CXX_COMPILER:FILEPATH=$ENV{MPI_ROOT}/bin/mpicxx" - "-D CMAKE_C_COMPILER:FILEPATH=$ENV{MPI_ROOT}/bin/mpicc" - "-D CMAKE_Fortran_COMPILER:FILEPATH=$ENV{MPI_ROOT}/bin/mpifort" - "-D MPI_EXEC:FILEPATH=$ENV{MPI_RUNNER}" - "-DMPI_EXEC_POST_NUMPROCS_FLAGS:STRING=--bind-to-socket" - - ) - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/shiller/cron_driver.sh b/cmake/ctest/drivers/shiller/cron_driver.sh deleted file mode 100755 index ee80d8f88f03..000000000000 --- a/cmake/ctest/drivers/shiller/cron_driver.sh +++ /dev/null @@ -1,56 +0,0 @@ -#!/bin/bash - -#necessary because the testbeds don't setup modules by -#default on the login node or compute nodes. -source /etc/profile.d/modules.sh - -# -# TrilinosDriver settings: -# - -export TDD_PARALLEL_LEVEL=1 - -# Trilinos settings: -# - -# Submission mode for the *TrilinosDriver* dashboard -export TDD_CTEST_TEST_TYPE=${JENKINS_JOB_TYPE} - -#export CTEST_DO_SUBMIT=FALSE -#export CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=FALSE - -# Machine specific environment -# -module load python/2.7.9 -export PATH=/home/rabartl/install/hansen-shiller/cmake-3.11.2/bin:$PATH -module load git/20150310 - -export TRIBITS_TDD_USE_SYSTEM_CTEST=1 -export CUDA_LAUNCH_BLOCKING=1 -export CUDA_MANAGED_FORCE_DEVICE_ALLOC=1 -export OMP_NUM_THREADS=2 - -# Machine independent cron_driver: -# -#openmpi-1.7-cuda6 - -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` - -if [ "${JENKINS_DO_CUDA}" == 'ON' ]; then - module load ${CUDA_SUFFIX} - module load ${MPI_SUFFIX}/${COMPILER_SUFFIX}/${CUDA_SUFFIX} - export OMPI_CXX=$WORKSPACE/Trilinos/packages/kokkos/config/nvcc_wrapper -else - module load ${MPI_SUFFIX}/${COMPILER_SUFFIX} -fi - -module load ${BOOST_SUFFIX}/${MPI_SUFFIX}/${COMPILER_SUFFIX}/${CUDA_SUFFIX} -module load ${HDF5_SUFFIX}/${MPI_SUFFIX}/${COMPILER_SUFFIX}/${CUDA_SUFFIX} -module load ${NETCDF_SUFFIX}/${MPI_SUFFIX}/${COMPILER_SUFFIX}/${CUDA_SUFFIX} -module load ${ZLIB_SUFFIX} -module load ${SUPERLU_SUFFIX}/${COMPILER_SUFFIX} - -module list - -$SCRIPT_DIR/../cron_driver.py - diff --git a/cmake/ctest/drivers/shiller/ctest_linux_nightly_mpi_release_downstream_ETI_generic_shiller.cmake b/cmake/ctest/drivers/shiller/ctest_linux_nightly_mpi_release_downstream_ETI_generic_shiller.cmake deleted file mode 100644 index b61b13bdc03c..000000000000 --- a/cmake/ctest/drivers/shiller/ctest_linux_nightly_mpi_release_downstream_ETI_generic_shiller.cmake +++ /dev/null @@ -1,98 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.shiller.generic.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_RELEASE_DEV_DownStream_ETI_SERIAL-$ENV{JENKINS_DO_SERIAL}_OPENMP-$ENV{JENKINS_DO_OPENMP}_PTHREAD-$ENV{JENKINS_DO_PTHREAD}_CUDA-$ENV{JENKINS_DO_CUDA}_COMPLEX-$ENV{JENKINS_DO_COMPLEX}) -SET(CTEST_PARALLEL_LEVEL 1) -SET(CTEST_TEST_TYPE $ENV{JENKINS_JOB_TYPE}) -SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_PACKAGES Kokkos Tpetra Belos Ifpack2 MueLu Amesos Amesos2 Ifpack Epetra EpetraExt Zoltan Zoltan2 Xpetra Panzer Intrepid STK Seacas Anasazi Phalanx Sacado Stokhos Shylu Stratimikos Thyra) - -SET(EXTRA_CONFIGURE_OPTIONS - "-DTPL_ENABLE_SuperLU=OFF" - - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTeuchos_ENABLE_COMPLEX:BOOL=$ENV{JENKINS_DO_COMPLEX}" - "-DTrilinos_ENABLE_OpenMP:BOOL=$ENV{JENKINS_DO_OPENMP}" - "-DTPL_ENABLE_HWLOC:STRING=OFF" - "-DTPL_ENABLE_CUDA:STRING=$ENV{JENKINS_DO_CUDA}" - - "-DKokkos_ENABLE_Pthread:BOOL=$ENV{JENKINS_DO_PTHREAD}" - "-DKokkos_ENABLE_Cuda_UVM:BOOL=$ENV{JENKINS_DO_CUDA}" - - "-DTpetra_INST_SERIAL:BOOL=$ENV{JENKINS_DO_SERIAL}" - "-DTpetra_INST_OPENMP:BOOL=$ENV{JENKINS_DO_OPENMP}" - "-DTpetra_INST_PTHREAD:BOOL=$ENV{JENKINS_DO_PTHREAD}" - "-DTpetra_INST_CUDA:BOOL=$ENV{JENKINS_DO_CUDA}" - "-D Tpetra_INST_COMPLEX_DOUBLE:BOOL=$ENV{JENKINS_DO_COMPLEX}" - "-D MueLu_INST_DOUBLE_INT_LONGINT:BOOL=ON" - -) - -#"-DMPI_EXEC_POST_NUMPROCS_FLAGS:STRING=-bind-to;socket;--map-by;socket" -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/sourcery/CMakeLists.txt b/cmake/ctest/drivers/sourcery/CMakeLists.txt deleted file mode 100644 index 0224a48203d0..000000000000 --- a/cmake/ctest/drivers/sourcery/CMakeLists.txt +++ /dev/null @@ -1,50 +0,0 @@ -INCLUDE("../../../../Version.cmake") - -TRILINOS_DRIVER_SETUP() - -IF(${Trilinos_REPOSITORY_BRANCH} STREQUAL "master") - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_OPT_GCC - ctest_mac_nightly_mpi_opt_gcc_sourcery.cmake - RUN_SERIAL - TIMEOUT_MINUTES 240 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_OPT_NAG - ctest_mac_nightly_mpi_opt_nag_sourcery.cmake - RUN_SERIAL - TIMEOUT_MINUTES 240 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG_GCC - ctest_mac_nightly_serial_debug_gcc_sourcery.cmake - RUN_SERIAL - TIMEOUT_MINUTES 330 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG_NAG - ctest_mac_nightly_serial_debug_nag_sourcery.cmake - RUN_SERIAL - TIMEOUT_MINUTES 330 - ) - -ELSE() - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_OPT_RELEASE_NAG - ctest_mac_nightly_mpi_opt_release_nag_sourcery.cmake - RUN_SERIAL - TIMEOUT_MINUTES 240 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG_RELEASE_NAG - ctest_mac_nightly_serial_debug_release_nag_sourcery.cmake - RUN_SERIAL - TIMEOUT_MINUTES 330 - ) -ENDIF() - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/sourcery/TrilinosCTestDriverCore.sourcery.gcc.cmake b/cmake/ctest/drivers/sourcery/TrilinosCTestDriverCore.sourcery.gcc.cmake deleted file mode 100644 index 1dc50ffbaf0b..000000000000 --- a/cmake/ctest/drivers/sourcery/TrilinosCTestDriverCore.sourcery.gcc.cmake +++ /dev/null @@ -1,113 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for sourcery using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - -# SET( CTEST_BUILD_FLAGS "-j8 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "8" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENCENCY_UNIT_TESTS:BOOL=ON" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - ) - - SET_DEFAULT(COMPILER_VERSION "GCC-4.7") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/usr/local/openmpi/GCC47" - "-DCMAKE_CXX_COMPILER:FILEPATH=/usr/local/openmpi/GCC47/bin/mpicxx" - "-DCMAKE_C_COMPILER:FILEPATH=/usr/local/openmpi/GCC47/bin/mpicc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/usr/local/openmpi/GCC47/bin/mpif90" - ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/opt/local/bin/x86_64-apple-darwin10-g++-mp-4.7" - "-DCMAKE_C_COMPILER:FILEPATH=/opt/local/bin/x86_64-apple-darwin10-gcc-mp-4.7" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/opt/local/bin/x86_64-apple-darwin10-gfortran-mp-4.7" - ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/sourcery/TrilinosCTestDriverCore.sourcery.nag.cmake b/cmake/ctest/drivers/sourcery/TrilinosCTestDriverCore.sourcery.nag.cmake deleted file mode 100644 index bd50a512ca29..000000000000 --- a/cmake/ctest/drivers/sourcery/TrilinosCTestDriverCore.sourcery.nag.cmake +++ /dev/null @@ -1,115 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for sourcery using gcc and nagfor -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - -# SET( CTEST_BUILD_FLAGS "-j8 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "8" ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT(Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DTrilinos_ENABLE_DEPENCENCY_UNIT_TESTS:BOOL=ON" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - ) - - SET_DEFAULT(COMPILER_VERSION "GCC-4.2") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/usr/local/openmpi/nagfor" - "-DCMAKE_CXX_COMPILER:FILEPATH=/usr/local/openmpi/nagfor/bin/mpicxx" - "-DCMAKE_C_COMPILER:FILEPATH=/usr/local/openmpi/nagfor/bin/mpicc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/usr/local/openmpi/nagfor/bin/mpif90" - "-DCMAKE_Fortran_FLAGS:STRING=-f2003 -g -C=all -wmismatch=mpi_scatterv,mpi_alltoallv,mpi_gatherv,mpi_allgatherv,mpi_bcast" - ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/usr/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/usr/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/usr/bin/nagfor" - "-DCMAKE_Fortran_FLAGS:STRING=-f2003 -g -C=all" - ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/sourcery/cron_driver.sh b/cmake/ctest/drivers/sourcery/cron_driver.sh deleted file mode 100755 index 41b842378155..000000000000 --- a/cmake/ctest/drivers/sourcery/cron_driver.sh +++ /dev/null @@ -1,42 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on sourcery: `date`" -echo - -# TrilinosDriver settings: -# - -export TDD_GIT_EXE=/usr/local/git/bin/git -export TDD_PARALLEL_LEVEL=2 -export TDD_HTTP_PROXY="http://wwwproxy.ca.sandia.gov:80/" - -# Trilinos settings: -# - -export TDD_CTEST_TEST_TYPE=Nightly -export CTEST_TEST_TYPE=Experimental -export CTEST_DO_SUBMIT=ON -export TDD_DO_SUBMIT=ON -export Trilinos_PACKAGES=ForTrilinos -export CTEST_DO_UPDATES=TRUE -export TDD_IN_TESTING_MODE=ON -export CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=TRUE -#export TDD_FORCE_CMAKE_INSTALL=0 -#export TDD_FORCE_INNER_CMAKE_INSTALL=0 -export CTEST_EXPLICITLY_ENABLE_IMPLICITLY_ENABLED_PACKAGES=TRUE - -# Machine specific environment: -# - -export PYTHONPATH=/usr/bin/python - -# Machine independent cron_driver: -# - -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on sourcery: `date`" -echo diff --git a/cmake/ctest/drivers/sourcery/cron_driver_release_sourcery.sh b/cmake/ctest/drivers/sourcery/cron_driver_release_sourcery.sh deleted file mode 100755 index 6e515fb34208..000000000000 --- a/cmake/ctest/drivers/sourcery/cron_driver_release_sourcery.sh +++ /dev/null @@ -1,50 +0,0 @@ -#!/bin/bash - -#get the date for use in log files -DATE=`date "+%m-%d-%Y"` - -CTEST_EXE=/usr/bin/ctest -GIT_EXE=/usr/local/git/bin/git -BASEDIR=/Users/knmorri/NightlyTestingTrilinos/Trilinos -DRIVER_SCRIPT_DIR=$BASEDIR/cmake/ctest/drivers/sourcery -BRANCH="trilinos-release-10-12-branch" -#BRANCH="master" -TRILINOS_REPOSITORY_LOCATION="software.sandia.gov:/space/git/Trilinos" -export PYTHONPATH=/usr/bin/python - -echo -echo "Starting nightly Trilinos Release 10.12 testing on sourcery: `date`" -echo - -echo -echo "Checking out just the drivers: `date`" -echo - -cd $BASEDIR -if [ -d Trilinos ]; then - echo Doing an update of existing directory - cd Trilinos - $GIT_EXE pull - cd .. -else - echo Cloning the repository because none exists yets - $GIT_EXE clone $TRILINOS_REPOSITORY_LOCATION -fi - - -echo -echo "Doing mpi optimized Release 10.12 build: `date`" -echo - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_mac_nightly_mpi_opt_release_nag_sourcery.cmake -VV &> "MPI_OPT_RELEASE_NAG_10.12_$DATE.log" - -echo -echo "Doing serial debug Release 10.12 build: `date`" -echo - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_mac_nightly_serial_debug_release_nag_sourcery.cmake -VV &> "SERIAL_DEBUG_RELEASE_NAG_10.12_$DATE.log" - -echo -echo "Ending nightly Trilinos Release 10.12 testing on sourcery: `date`" -echo - diff --git a/cmake/ctest/drivers/sourcery/cron_driver_sourcery.sh b/cmake/ctest/drivers/sourcery/cron_driver_sourcery.sh deleted file mode 100755 index d758f3966ec8..000000000000 --- a/cmake/ctest/drivers/sourcery/cron_driver_sourcery.sh +++ /dev/null @@ -1,49 +0,0 @@ -#!/bin/bash - -#get the date for use in log files -DATE=`date "+%m-%d-%Y"` - -CTEST_EXE=/usr/bin/ctest -GIT_EXE=/usr/local/git/bin/git -BASEDIR=/Users/knmorri/NightlyTestingTrilinos/Trilinos -DRIVER_SCRIPT_DIR=$BASEDIR/cmake/ctest/drivers/sourcery -BRANCH="master" -TRILINOS_REPOSITORY_LOCATION="software.sandia.gov:/space/git/Trilinos" -export PYTHONPATH=/usr/bin/python - -echo -echo "Starting nightly Trilinos development testing on sourcery: `date`" -echo - -echo -echo "Checking out just the drivers: `date`" -echo - -cd $BASEDIR -if [ -d Trilinos ]; then - echo Doing an update of existing directory - cd Trilinos - $EG_EXE pull - cd .. -else - echo Cloning the repository because none exists yets - $EG_EXE clone $TRILINOS_REPOSITORY_LOCATION -fi - - -echo -echo "Doing mpi optimized development build: `date`" -echo - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_mac_nightly_mpi_opt_nag_sourcery.cmake -VV &> "MPI_OPT_DEV_NAG_$DATE.log" - -echo -echo "Doing serial debug development build: `date`" -echo - -time ${CTEST_EXE} -S $DRIVER_SCRIPT_DIR/ctest_mac_nightly_serial_debug_nag_sourcery.cmake -VV &> "SERIAL_DEBUG_DEV_NAG_$DATE.log" - -echo -echo "Ending nightly Trilinos development testing on sourcery: `date`" -echo - diff --git a/cmake/ctest/drivers/sourcery/ctest_mac_nightly_mpi_opt_gcc_sourcery.cmake b/cmake/ctest/drivers/sourcery/ctest_mac_nightly_mpi_opt_gcc_sourcery.cmake deleted file mode 100644 index ff532c5eea16..000000000000 --- a/cmake/ctest/drivers/sourcery/ctest_mac_nightly_mpi_opt_gcc_sourcery.cmake +++ /dev/null @@ -1,85 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.sourcery.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV_GCC) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(EXTRA_EXCLUDE_PACKAGES Zoltan PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DForTrilinos_ENABLE_TESTS:BOOL=ON" - "-DForTrilinos_ENABLE_EXAMPLES:BOOL=ON" - "-DForTrilinos_ENABLE_OBJECT_ORIENTED:BOOL=ON" - "-DForTrilinos_DISABLE_DEFERRED_LENGTH_CHARACTERS:BOOL=ON" - "-DForTrilinos_DISABLE_FINAL_SUBROUTINES:BOOL=ON" - "-DForTrilinos_DISABLE_TYPE_BOUND_CONSTRUCTOR:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/sourcery/ctest_mac_nightly_mpi_opt_nag_sourcery.cmake b/cmake/ctest/drivers/sourcery/ctest_mac_nightly_mpi_opt_nag_sourcery.cmake deleted file mode 100644 index 195a21793543..000000000000 --- a/cmake/ctest/drivers/sourcery/ctest_mac_nightly_mpi_opt_nag_sourcery.cmake +++ /dev/null @@ -1,82 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.sourcery.nag.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV_NAG) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(EXTRA_EXCLUDE_PACKAGES Zoltan PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DForTrilinos_ENABLE_TESTS:BOOL=ON" - "-DForTrilinos_ENABLE_EXAMPLES:BOOL=ON" - "-DForTrilinos_ENABLE_OBJECT_ORIENTED:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/sourcery/ctest_mac_nightly_mpi_opt_release_nag_sourcery.cmake b/cmake/ctest/drivers/sourcery/ctest_mac_nightly_mpi_opt_release_nag_sourcery.cmake deleted file mode 100644 index 7656a4be3668..000000000000 --- a/cmake/ctest/drivers/sourcery/ctest_mac_nightly_mpi_opt_release_nag_sourcery.cmake +++ /dev/null @@ -1,85 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.sourcery.nag.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "MPI_OPT_NAG${Trilinos_VERSION}") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(EXTRA_EXCLUDE_PACKAGES Zoltan PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DForTrilinos_ENABLE_TESTS:BOOL=ON" - "-DForTrilinos_ENABLE_EXAMPLES:BOOL=ON" - "-DForTrilinos_ENABLE_OBJECT_ORIENTED:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/sourcery/ctest_mac_nightly_serial_debug_gcc_sourcery.cmake b/cmake/ctest/drivers/sourcery/ctest_mac_nightly_serial_debug_gcc_sourcery.cmake deleted file mode 100644 index 8d38bab6cfe3..000000000000 --- a/cmake/ctest/drivers/sourcery/ctest_mac_nightly_serial_debug_gcc_sourcery.cmake +++ /dev/null @@ -1,87 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.sourcery.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_DEV_GCC) -SET(CTEST_PARALLEL_LEVEL 8) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -# Exclude Sundance because of strange segfault (see bug 4382) -SET(EXTRA_EXCLUDE_PACKAGES Sundance PyTrilinos STK) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DForTrilinos_ENABLE_TESTS:BOOL=ON" - "-DForTrilinos_ENABLE_EXAMPLES:BOOL=ON" - "-DForTrilinos_ENABLE_OBJECT_ORIENTED:BOOL=ON" - "-DForTrilinos_DISABLE_DEFERRED_LENGTH_CHARACTERS:BOOL=ON" - "-DForTrilinos_DISABLE_FINAL_SUBROUTINES:BOOL=ON" - "-DForTrilinos_DISABLE_TYPE_BOUND_CONSTRUCTOR:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/sourcery/ctest_mac_nightly_serial_debug_nag_sourcery.cmake b/cmake/ctest/drivers/sourcery/ctest_mac_nightly_serial_debug_nag_sourcery.cmake deleted file mode 100644 index 100561078b81..000000000000 --- a/cmake/ctest/drivers/sourcery/ctest_mac_nightly_serial_debug_nag_sourcery.cmake +++ /dev/null @@ -1,84 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.sourcery.nag.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_DEV_NAG) -SET(CTEST_PARALLEL_LEVEL 8) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -# Exclude Sundance because of strange segfault (see bug 4382) -SET(EXTRA_EXCLUDE_PACKAGES Sundance PyTrilinos STK) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DForTrilinos_ENABLE_TESTS:BOOL=ON" - "-DForTrilinos_ENABLE_EXAMPLES:BOOL=ON" - "-DForTrilinos_ENABLE_OBJECT_ORIENTED:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/sourcery/ctest_mac_nightly_serial_debug_release_nag_sourcery.cmake b/cmake/ctest/drivers/sourcery/ctest_mac_nightly_serial_debug_release_nag_sourcery.cmake deleted file mode 100644 index c2222dc63841..000000000000 --- a/cmake/ctest/drivers/sourcery/ctest_mac_nightly_serial_debug_release_nag_sourcery.cmake +++ /dev/null @@ -1,86 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.sourcery.nag.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "SERIAL_DEBUG_NAG${Trilinos_VERSION}") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -# Exclude Sundance because of strange segfault (see bug 4382) -SET(EXTRA_EXCLUDE_PACKAGES Sundance PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DForTrilinos_ENABLE_TESTS:BOOL=ON" - "-DForTrilinos_ENABLE_EXAMPLES:BOOL=ON" - "-DForTrilinos_ENABLE_OBJECT_ORIENTED:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/thumper/cron_driver_thumper.sh b/cmake/ctest/drivers/thumper/cron_driver_thumper.sh deleted file mode 100755 index 36d5e33e6991..000000000000 --- a/cmake/ctest/drivers/thumper/cron_driver_thumper.sh +++ /dev/null @@ -1,12 +0,0 @@ -#!/bin/bash - -# Source the -cd $HOME -source .bash_profile - -cd /scratch/rabartl/dashboards/Trilinos/cmake/ctest -cvs -q update -dP - -ctest -S /scratch/rabartl/dashboards/Trilinos/cmake/ctest/ctest_linux_nightly_serial_debug_thumper.cmake - -$HOME/mailmsg.py "Trilinos serial debug on thumper: http://trilinos.sandia.gov/cdash/index.php?project=Trilinos" diff --git a/cmake/ctest/drivers/tribits-refactor-continuous/CMakeLists.txt b/cmake/ctest/drivers/tribits-refactor-continuous/CMakeLists.txt deleted file mode 100644 index 8e3d9b63a431..000000000000 --- a/cmake/ctest/drivers/tribits-refactor-continuous/CMakeLists.txt +++ /dev/null @@ -1,35 +0,0 @@ -TRILINOS_DRIVER_SETUP() - -find_program(PYTHON_EXE python) - -TRILINOS_DRIVER_ADD_DASHBOARD( - TRIBITS_MPI - ctest_tribits_refactor.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 240 -) - -SET(INSTALLATION_DIR "${CMAKE_BINARY_DIR}/../installation/installed") -SET(INSTALLATION_WORKING_DIR "${CMAKE_BINARY_DIR}/../installation") -ADD_TEST(Install_Trilinos ${PYTHON_EXE} - "${CMAKE_CURRENT_SOURCE_DIR}/build_tarball.py" - "--no-dashboard" - "--working-dir=${INSTALLATION_WORKING_DIR}" - "--install-dir=${INSTALLATION_DIR}" - "--disable-boost" - "--disable-netcdf" - "--repository=software.sandia.gov:/home/rabartl/PROJECTS/backups/Trilinos" - "--branch=tribits_refactor" - ) - -TRILINOS_DRIVER_ADD_DASHBOARD( - TRIBITS_INSTALL - ctest_tribits_installation_testing.cmake - CTEST_INSTALLER_TYPE release - DEPENDS Install_Trilinos - REQUIRED_FILES ${INSTALLATION_DIR}/lib/cmake/Trilinos/TrilinosConfig.cmake -) - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() - diff --git a/cmake/ctest/drivers/tribits-refactor-continuous/build_tarball.py b/cmake/ctest/drivers/tribits-refactor-continuous/build_tarball.py deleted file mode 100755 index 9b22ef0773d4..000000000000 --- a/cmake/ctest/drivers/tribits-refactor-continuous/build_tarball.py +++ /dev/null @@ -1,18 +0,0 @@ -#!/usr/bin/env python - -import os -import sys - -impl_path = os.path.join('..', 'trilinos-test2') -sys.path.append(os.path.join(os.path.abspath(os.path.dirname(__file__)), impl_path)) -import nightly_create_tarball - -packages = [ - ('Teuchos', True), - ('Epetra', True), -] - -options, args = nightly_create_tarball.get_options(os.getcwd()) -options.enableBoost = False -options.enableNetcdf = False -nightly_create_tarball.main(packages, options) diff --git a/cmake/ctest/drivers/tribits-refactor-continuous/cron_driver.sh b/cmake/ctest/drivers/tribits-refactor-continuous/cron_driver.sh deleted file mode 100755 index 9f8f3f1de16d..000000000000 --- a/cmake/ctest/drivers/tribits-refactor-continuous/cron_driver.sh +++ /dev/null @@ -1,30 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on brain: `date`" -echo - -# TrilinosDriver settings: -# - -export TDD_GIT_EXE=/usr/local/bin/git -export TDD_PARALLEL_LEVEL=8 - -# CTest Settings -# - -# Trilinos settings: -# - -# Machine specific environment: -# - -# Machine independent cron_driver: -# - -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on brain: `date`" -echo diff --git a/cmake/ctest/drivers/tribits-refactor-continuous/ctest_tribits_installation_testing.cmake b/cmake/ctest/drivers/tribits-refactor-continuous/ctest_tribits_installation_testing.cmake deleted file mode 100644 index 353ed922fad7..000000000000 --- a/cmake/ctest/drivers/tribits-refactor-continuous/ctest_tribits_installation_testing.cmake +++ /dev/null @@ -1,89 +0,0 @@ -# @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 - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME TRIBITS_INSTALLATION) -SET(COMPILER_VERSION "GCC-4.1.2") -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_PACKAGES Teuchos Epetra) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_INSTALLATION_DIR=${CMAKE_CURRENT_BINARY_DIR}/../../installation/installed" - "-DTrilinos_ENABLE_DEVELOPMENT_MODE:BOOL=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -# Use the scripts repository as the main repository. We do this to avoid getting -# an archaic master branch on the initial clone for an out of date repository. -SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) -SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) -SET( CTEST_BUILD_FLAGS "-j8 -i" ) - -SET_DEFAULT( CTEST_PARALLEL_LEVEL "8" ) - -TRILINOS_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/tribits-refactor-continuous/ctest_tribits_refactor.cmake b/cmake/ctest/drivers/tribits-refactor-continuous/ctest_tribits_refactor.cmake deleted file mode 100644 index 9ce744744e9b..000000000000 --- a/cmake/ctest/drivers/tribits-refactor-continuous/ctest_tribits_refactor.cmake +++ /dev/null @@ -1,89 +0,0 @@ -# @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 - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME TRIBITS_MPI) -SET(COMPILER_VERSION "GCC-4.1.2") -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_PACKAGES Teuchos TriBITS) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/usr/local" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -# Use the scripts repository as the main repository. We do this to avoid getting -# an archaic master branch on the initial clone for an out of date repository. -SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) -SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) -SET( CTEST_BUILD_FLAGS "-j8 -i" ) - -SET_DEFAULT( CTEST_PARALLEL_LEVEL "8" ) - -TRILINOS_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test/CMakeLists.txt b/cmake/ctest/drivers/trilinos-test/CMakeLists.txt deleted file mode 100644 index 1172d0dc5765..000000000000 --- a/cmake/ctest/drivers/trilinos-test/CMakeLists.txt +++ /dev/null @@ -1,110 +0,0 @@ -INCLUDE("../../../../Version.cmake") - -TRILINOS_DRIVER_SETUP() - -set(CTEST_EXE "${CMAKE_CTEST_COMMAND}") -set(workingdir "${TrilinosDriver_BINARY_DIR}") - -# Get the day of the week -execute_process(COMMAND date +%A OUTPUT_VARIABLE DAYOFWEEK) - -IF(${Trilinos_REPOSITORY_BRANCH} STREQUAL "develop") - #TRILINOS_DRIVER_ADD_DASHBOARD( - # MPI_OPT_DEV - # ctest_linux_nightly_mpi_development_opt_trilinos-test.cmake - # CTEST_INSTALLER_TYPE release - # TIMEOUT_MINUTES 300 - #) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_OPT_DEV - ctest_linux_nightly_serial_development_opt_gcc_4.5.1_trilinos-test.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 210 - ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_DEBUG_DEV - ctest_linux_nightly_mpi_development_debug_trilinos-test.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 420 - ) - - #TRILINOS_DRIVER_ADD_DASHBOARD( - # MPI_OPT_DEV_SHARED - # ctest_linux_nightly_mpi_development_opt_shared_trilinos-test.cmake - # CTEST_INSTALLER_TYPE release - # TIMEOUT_MINUTES 300 - #) - - #TRILINOS_DRIVER_ADD_DASHBOARD( - # SERIAL_DEBUG_DEV - # ctest_linux_nightly_serial_development_debug_trilinos-test.cmake - # CTEST_INSTALLER_TYPE release - # TIMEOUT_MINUTES 300 - #) - - #TRILINOS_DRIVER_ADD_DASHBOARD( - # SERIAL_OPT_DEV2 - # ctest_linux_nightly_serial_development_opt_pgi_10.9_trilinos-test.cmake - # CTEST_INSTALLER_TYPE release - # RUN_SERIAL - # TIMEOUT_MINUTES 450 - #) - - # mfh 16 Feb 2015: Turning off PGI 11.1 builds. PGI compiler has - # changed significantly between versions 11 and 15, such that it no - # longer makes sense to test version 11, just as it doesn't make - # sense to test old GCC versions. - - # TRILINOS_DRIVER_ADD_DASHBOARD( - # SERIAL_OPT_DEV1 - # ctest_linux_nightly_serial_development_opt_pgi_11.1_stable_trilinos-test.cmake - # CTEST_INSTALLER_TYPE release - # RUN_SERIAL - # TIMEOUT_MINUTES 420 - # ) - - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG_DEV2 - ctest_linux_nightly_serial_development_debug_gcc_4.6.0_trilinos-test.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 210 - ) - -# #Only run this build once a week -# if(${DAYOFWEEK} MATCHES "Saturday") -# TRILINOS_DRIVER_ADD_DASHBOARD( -# SERIAL_OPT_DEV3 -# ctest_linux_nightly_serial_development_opt_pgi_11.1_trilinos-test.cmake -# CTEST_INSTALLER_TYPE release -# RUN_SERIAL -# TIMEOUT_MINUTES 600 -# ) -# endif() - -ELSE() - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_RELEASE - ctest_linux_nightly_mpi_release_trilinos-test.cmake - RUN_SERIAL - TIMEOUT_MINUTES 300 - ) - TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_RELEASE_SHARED - ctest_linux_nightly_mpi_release_shared_trilinos-test.cmake - RUN_SERIAL - TIMEOUT_MINUTES 300 - ) - TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_RELEASE - ctest_linux_nightly_serial_release_trilinos-test.cmake - RUN_SERIAL - TIMEOUT_MINUTES 300 - ) -ENDIF() - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/trilinos-test/TrilinosCTestDriverCore.trilinos-test.gcc.cmake b/cmake/ctest/drivers/trilinos-test/TrilinosCTestDriverCore.trilinos-test.gcc.cmake deleted file mode 100644 index bfcb66b7a78d..000000000000 --- a/cmake/ctest/drivers/trilinos-test/TrilinosCTestDriverCore.trilinos-test.gcc.cmake +++ /dev/null @@ -1,138 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for trilinos-test using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_BUILD_FLAGS "-j8 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "8" ) - - SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DCOVERAGE_COMMAND:FILEPATH=/usr/bin/gcov" - "-DMEMORYCHECK_COMMAND:FILEPATH=/usr/bin/valgrind" - "-DTPL_ENABLE_SuperLU:BOOL=ON" - "-DSuperLU_INCLUDE_DIRS:PATH=/home/trilinos/tpl/gcc4.1.2/SuperLU_4.3/SRC" - "-DSuperLU_LIBRARY_DIRS:PATH=/home/trilinos/tpl/gcc4.1.2/SuperLU_4.3/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu_4.3" - "-DMPI4PY_INCLUDE_DIR=/home/trilinos/tpl/gcc4.1.2/mpi4py-1.3/include" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DMesquite_ENABLE_TESTS:BOOL=ON" - "-DCppUnit_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/cppunit-1.12.1/include" - "-DCppUnit_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.1.2/cppunit-1.12.1/lib" - "-DTPL_ENABLE_Matio=OFF" - "-DIntrepidCore_ENABLE_DEBUG_INF_CHECK=OFF" - ) - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - SET_DEFAULT(COMPILER_VERSION "GCC-4.7.2") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - ) -# "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" -# ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_openmpi_1.2.7.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/home/trilinos/gcc4.7.2/base/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/home/trilinos/gcc4.7.2/base/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/home/trilinos/gcc4.7.2/base/bin/gfortran" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_gcc-4.1.2.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/trilinos-test/TrilinosCTestDriverCore.trilinos-test.pgi10.cmake b/cmake/ctest/drivers/trilinos-test/TrilinosCTestDriverCore.trilinos-test.pgi10.cmake deleted file mode 100644 index 693e8d4bfea3..000000000000 --- a/cmake/ctest/drivers/trilinos-test/TrilinosCTestDriverCore.trilinos-test.pgi10.cmake +++ /dev/null @@ -1,132 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for trilinos-test using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_BUILD_FLAGS "-j6 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "8" ) - -# SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} PyTrilinos TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=RELEASE" - "-DMEMORYCHECK_COMMAND:FILEPATH=/usr/bin/valgrind" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DMesquite_ENABLE_TESTS:BOOL=ON" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DTPL_ENABLE_Matio=OFF" - "-DIntrepidCore_ENABLE_DEBUG_INF_CHECK=OFF" - ) - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - SET_DEFAULT(COMPILER_VERSION "PGI-10.9") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - ) -# "-DMPI_BASE_DIR:PATH=/home/trilinos/openmpi-1.4" -# ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_openmpi_1.2.7.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/home/trilinos/pgi10.9/linux86-64/10.9/bin/pgCC" - "-DCMAKE_C_COMPILER:FILEPATH=/home/trilinos/pgi10.9/linux86-64/10.9/bin/pgcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/home/trilinos/pgi10.9/linux86-64/10.9/bin/pgf90" - "-DTrilinos_EXTRA_LINK_FLAGS:STRING='-L/home/trilinos/pgi10.9/linux86-64/10.9/lib -L/usr/lib64 -L/usr/lib/gcc/x86_64-redhat-linux/4.1.2 -lpgf90 -lpgf90_rpm1 -lpgf902 -lpgf90rtl -lpgftnrtl -lnspgc -lpgc -lrt -lpthread -lm -lgcc -lc -lgcc'" - "-DTrilinos_SKIP_FORTRANCINTERFACE_VERIFY_TEST:BOOL=ON" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_gcc-4.1.2.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/trilinos-test/TrilinosCTestDriverCore.trilinos-test.pgi11.cmake b/cmake/ctest/drivers/trilinos-test/TrilinosCTestDriverCore.trilinos-test.pgi11.cmake deleted file mode 100644 index f633fa934e90..000000000000 --- a/cmake/ctest/drivers/trilinos-test/TrilinosCTestDriverCore.trilinos-test.pgi11.cmake +++ /dev/null @@ -1,132 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for trilinos-test using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_BUILD_FLAGS "-j4 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "8" ) - -# SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} PyTrilinos TriKota Optika) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=RELEASE" - "-DMEMORYCHECK_COMMAND:FILEPATH=/usr/bin/valgrind" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DMesquite_ENABLE_TESTS:BOOL=ON" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DTPL_ENABLE_Matio=OFF" - "-DIntrepidCore_ENABLE_DEBUG_INF_CHECK=OFF" - ) - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - SET_DEFAULT(COMPILER_VERSION "PGI-11.1") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - ) -# "-DMPI_BASE_DIR:PATH=/home/trilinos/openmpi-1.4" -# ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_openmpi_1.2.7.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/home/trilinos/pgi11.1/linux86-64/11.1/bin/pgCC" - "-DCMAKE_C_COMPILER:FILEPATH=/home/trilinos/pgi11.1/linux86-64/11.1/bin/pgcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/home/trilinos/pgi11.1/linux86-64/11.1/bin/pgf90" - "-DTrilinos_EXTRA_LINK_FLAGS:STRING='-L/home/trilinos/pgi11.1/linux86-64/11.1/lib -L/usr/lib64 -L/usr/lib/gcc/x86_64-redhat-linux/4.1.2 -lpgf90 -lpgf90_rpm1 -lpgf902 -lpgf90rtl -lpgftnrtl -lnspgc -lpgc -lrt -lpthread -lm -lgcc -lc -lgcc'" - "-DTrilinos_SKIP_FORTRANCINTERFACE_VERIFY_TEST:BOOL=ON" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test_gcc-4.1.2.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/trilinos-test/cron_driver.sh b/cmake/ctest/drivers/trilinos-test/cron_driver.sh deleted file mode 100755 index adf2514e6240..000000000000 --- a/cmake/ctest/drivers/trilinos-test/cron_driver.sh +++ /dev/null @@ -1,44 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on trilinos-test: `date`" -echo - -# TrilinosDriver settings: -# -export TDD_GIT_EXE=/home/trilinos/git/bin/git -export TDD_PARALLEL_LEVEL=2 -export TDD_HTTP_PROXY="http://wwwproxy.sandia.gov:80/" - -# Trilinos settings: -# -export TDD_CTEST_TEST_TYPE=Nightly -export TRIBITS_TDD_USE_SYSTEM_CTEST=1 - -# Machine specific environment: -# -export PATH=/home/trilinos/gcc4.7.2/base/bin:/home/trilinos/cmake/bin:/home/trilinos/git/bin:/home/trilinos/tpl/gcc4.1.2/qt-4.5.2/bin:/usr/kerberos/bin:/usr/local/bin:/bin:/usr/bin - -# BASEDIR is the parent directory of this script's Trilinos source tree... -BASEDIR=`cd "\`dirname \"$0\"\`/../../../../..";pwd` -echo BASEDIR=$BASEDIR -BASEDATADIR=$BASEDIR - -export CVS_RSH=ssh -export LD_LIBRARY_PATH="/home/trilinos/gcc4.7.2/base/lib64:/home/trilinos/gcc4.7.2/openmpi-1.6.5/lib:$BASEDIR/MPI_OPT_DEV_SHARED/BUILD/packages/PyTrilinos/src" -export PYTHONPATH="/home/trilinos/tpl/gcc4.1.2/mpi4py-1.3/lib64/python:/home/trilinos/tpl/gcc4.1.2/numpy1.4.0/lib64/python2.4/site-packages" -export TRILINOSDATADIRECTORY="$BASEDATADIR/TrilinosData" - -pushd "$BASEDATADIR" -cvs -q -d :ext:software.sandia.gov:/space/CVS co TrilinosData -popd - -# Machine independent cron_driver: -# -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on trilinos-test: `date`" -echo - diff --git a/cmake/ctest/drivers/trilinos-test/cron_driver_continuous_trilinos-test.sh b/cmake/ctest/drivers/trilinos-test/cron_driver_continuous_trilinos-test.sh deleted file mode 100755 index 91fbf33b980c..000000000000 --- a/cmake/ctest/drivers/trilinos-test/cron_driver_continuous_trilinos-test.sh +++ /dev/null @@ -1,51 +0,0 @@ -#!/bin/bash - -CTEST_EXE=/home/trilinos/cmake/bin/ctest -EG_EXE=/home/trilinos/git/bin/eg -BASEDIR=/home/trilinos/dashboards/dev -DRIVER_SCRIPT_DIR=$BASEDIR/Trilinos/cmake/ctest/drivers/trilinos-test -TRILINOS_REPOSITORY_LOCATION="software.sandia.gov:/space/git/Trilinos" - -# Source the -cd $HOME -source .bash_profile - -if [ "$_DAYOFWEEK" == "" ] ; then - _DAYOFWEEK=`date +%A` -fi - -DATE=`date "+%Y%m%d"` - -echo "_DAYOFWEEK=$_DAYOFWEEK" - -echo -echo "Starting Trilinos continuous integration testing on trilinos-test: `date`" -echo - - -echo -echo "Checking out just the skeleton cmake/ctest code: `date`" -echo - -cd $BASEDIR -if [ -d Trilinos ]; then - echo Doing an update of existing directory - cd Trilinos - $EG_EXE pull - cd .. -else - echo Cloning the repository because none exists yet - $EG_EXE clone $TRILINOS_REPOSITORY_LOCATION -fi - - -echo -echo "Doing continuous mpi optimized development shared library build: `date`" -echo - -time ${CTEST_EXE} -j 11 -S $DRIVER_SCRIPT_DIR/ctest_linux_continuous_mpi_development_opt_shared_trilinos-test.cmake -VV &> "CONTINUOUS_MPI_OPT_DEV_SHARED_$DATE.log" - - -echo -echo "Ending Trilinos continuous integration testing on trilinos-test. `date`" -echo diff --git a/cmake/ctest/drivers/trilinos-test/ctest_linux_continuous_mpi_debug_shared_trilinos-test.cmake b/cmake/ctest/drivers/trilinos-test/ctest_linux_continuous_mpi_debug_shared_trilinos-test.cmake deleted file mode 100644 index 19e2c730bf23..000000000000 --- a/cmake/ctest/drivers/trilinos-test/ctest_linux_continuous_mpi_debug_shared_trilinos-test.cmake +++ /dev/null @@ -1,91 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG_CONTINUOUS) -SET(CTEST_TEST_TYPE CONTINUOUS) -#SET(CTEST_TEST_TYPE EXPERIMENTAL) -# Wipe binary tree once per script invocation -SET (CTEST_START_WITH_EMPTY_BINARY_DIRECTORY_ONCE TRUE) -# How long to run in minutes -SET (CTEST_CONTINUOUS_DURATION 600) -SET (CTEST_CONTINUOUS_INTERVAL 20) -SET (CTEST_TEST_TIMEOUT 720) -#SET(CTEST_DO_COVERAGE_TESTING TRUE) -#SET(CTEST_DO_MEMORY_TESTING TRUE) -#override the default number of processors to run on. -SET( CTEST_BUILD_FLAGS "-j11 -i" ) -SET( CTEST_PARALLEL_LEVEL "4" ) - -SET(EXTRA_EXCLUDE_PACKAGES PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DBUILD_SHARED_LIBS:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test/ctest_linux_continuous_mpi_development_opt_shared_trilinos-test.cmake b/cmake/ctest/drivers/trilinos-test/ctest_linux_continuous_mpi_development_opt_shared_trilinos-test.cmake deleted file mode 100644 index 7415c42934b5..000000000000 --- a/cmake/ctest/drivers/trilinos-test/ctest_linux_continuous_mpi_development_opt_shared_trilinos-test.cmake +++ /dev/null @@ -1,127 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME CONTINUOUS_${COMM_TYPE}_OPT_DEV_SHARED) -#SET(CTEST_TEST_TIMEOUT 900) - -#override the default number of processors to run on. -SET( CTEST_BUILD_FLAGS "-j11 -i" ) -SET( CTEST_PARALLEL_LEVEL "4" ) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -#disabling Mesquite because of a build error when shared libs is turned on. -SET(EXTRA_EXCLUDE_PACKAGES STK PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - "-DBUILD_SHARED_LIBS:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DBoost_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/lib" - "-DGLM_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/glm-0.9.4.6" - ) - -# 2009/11/26: rabartl: Do we really wantk to be pointing to Trilinos_DATA_DIR? -# Unless the CI sever is going to be updatting this every iteration this is -# likely to cause an inconsistency and a test failure. For example, if -# someone adds a new test and then adds new test data, the CI server will only -# get the new test but not the new test data. Therefore, I am removing this. -# # "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -SET(CTEST_TEST_TYPE Continuous) - -SET(CTEST_START_WITH_EMPTY_BINARY_DIRECTORY ON) -SET(CTEST_ENABLE_MODIFIED_PACKAGES_ONLY OFF) -SET(done 0) - -WHILE(NOT done) - SET(START_TIME ${CTEST_ELAPSED_TIME}) - - TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() - - SET(CTEST_START_WITH_EMPTY_BINARY_DIRECTORY OFF) - SET(CTEST_ENABLE_MODIFIED_PACKAGES_ONLY ON) - - MESSAGE("Before CTEST_SLEEP: CTEST_ELAPSED_TIME='${CTEST_ELAPSED_TIME}'") - - # Loop at most once every 3 minutes (180 seconds) - CTEST_SLEEP(${START_TIME} 180 ${CTEST_ELAPSED_TIME}) - - # Stop after 14 hours: - IF(${CTEST_ELAPSED_TIME} GREATER 50400) - SET(done 1) - ENDIF() - - MESSAGE("Bottom of continuous while loop: CTEST_ELAPSED_TIME='${CTEST_ELAPSED_TIME}'") -ENDWHILE() diff --git a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_mpi_development_debug_trilinos-test.cmake b/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_mpi_development_debug_trilinos-test.cmake deleted file mode 100644 index c46c620c39e0..000000000000 --- a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_mpi_development_debug_trilinos-test.cmake +++ /dev/null @@ -1,101 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG_DEV) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(EXTRA_EXCLUDE_PACKAGES PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DBoost_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/lib" - "-DGLM_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/glm-0.9.4.6" - "-DTPL_ENABLE_ParMETIS:BOOL=ON" - "-DParMETIS_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.7.2/ParMETIS-4.0.3_32bit/lib" - "-DParMETIS_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.7.2/ParMETIS-4.0.3_32bit/include" - "-DTPL_ENABLE_Scotch:BOOL=ON" - "-DScotch_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.7.2/scotch_6.0.3_32bit/lib" - "-DScotch_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.7.2/scotch_6.0.3_32bit/include" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/include" - "-DZoltan2_ENABLE_Experimental:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_mpi_development_opt_shared_trilinos-test.cmake b/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_mpi_development_opt_shared_trilinos-test.cmake deleted file mode 100644 index ea4e9220c3f7..000000000000 --- a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_mpi_development_opt_shared_trilinos-test.cmake +++ /dev/null @@ -1,99 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV_SHARED) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -#disabling Mesquite because of a build error when shared libs is turned on. -SET(EXTRA_EXCLUDE_PACKAGES STK ) -SET( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DBUILD_SHARED_LIBS:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DBoost_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/lib" - "-DGLM_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/glm-0.9.4.6" - "-DSWIG_EXECUTABLE:FILEPATH=/home/trilinos/tpl/gcc4.1.2/swig-2.0.0/bin/swig" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/include" - "-DPyTrilinos_ENABLE_STK=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_mpi_development_opt_trilinos-test.cmake b/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_mpi_development_opt_trilinos-test.cmake deleted file mode 100644 index 1b112115c9c0..000000000000 --- a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_mpi_development_opt_trilinos-test.cmake +++ /dev/null @@ -1,99 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DBoost_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/lib" - "-DGLM_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/glm-0.9.4.6" - "-DTPL_ENABLE_ParMETIS:BOOL=ON" - "-DParMETIS_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.7.2/ParMETIS-4.0.3_32bit/lib" - "-DParMETIS_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.7.2/ParMETIS-4.0.3_32bit/include" - "-DTPL_ENABLE_Scotch:BOOL=ON" - "-DScotch_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.7.2/scotch_6.0.3_32bit/lib" - "-DScotch_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.7.2/scotch_6.0.3_32bit/include" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/include" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_mpi_release_shared_trilinos-test.cmake b/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_mpi_release_shared_trilinos-test.cmake deleted file mode 100644 index 6cc4c5707c60..000000000000 --- a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_mpi_release_shared_trilinos-test.cmake +++ /dev/null @@ -1,99 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.gcc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "MPI_RELEASE_${Trilinos_VERSION}_SHARED") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -#disabling Mesquite because of a build error when shared libs is turned on. -SET(EXTRA_EXCLUDE_PACKAGES STK PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DBUILD_SHARED_LIBS:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DBoost_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/lib" - "-DGLM_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/glm-0.9.4.6" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/include" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_mpi_release_trilinos-test.cmake b/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_mpi_release_trilinos-test.cmake deleted file mode 100644 index 13fff8960098..000000000000 --- a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_mpi_release_trilinos-test.cmake +++ /dev/null @@ -1,103 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.gcc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "MPI_RELEASE_${Trilinos_VERSION}") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DBoost_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/lib" - "-DGLM_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/glm-0.9.4.6" - "-DTPL_ENABLE_ParMETIS:BOOL=ON" - "-DParMETIS_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.7.2/ParMETIS-4.0.3_32bit/lib" - "-DParMETIS_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.7.2/ParMETIS-4.0.3_32bit/include" - "-DTPL_ENABLE_Scotch:BOOL=ON" - "-DScotch_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.7.2/scotch_6.0.3_32bit/lib" - "-DScotch_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.7.2/scotch_6.0.3_32bit/include" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/include" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_debug_gcc_4.6.0_trilinos-test.cmake b/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_debug_gcc_4.6.0_trilinos-test.cmake deleted file mode 100644 index 412dd14b8385..000000000000 --- a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_debug_gcc_4.6.0_trilinos-test.cmake +++ /dev/null @@ -1,107 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_DEV2) -SET(COMPILER_VERSION "GCC-4.6.0") -SET(ENV{LD_LIBRARY_PATH} "/home/trilinos/install/gmp-4.3.2/lib:/home/trilinos/install/mpfr2.4.2/lib:/home/trilinos/install/mpc-0.8.1/lib:/home/trilinos/gcc4.6.0/lib64:$ENV{LD_LIBRARY_PATH}") -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) -#Disabling the following packages due to issues with them with the gc 4.6 compiler -#MOOCHO there were many test failures -#Piro there was one test failure -#Amesos there was one test failure -#Stratimikos there was one test failure -#Rythmos Disabling Stratimikos caused a lot of build errors -#stokhos there was one build error -SET(EXTRA_EXCLUDE_PACKAGES MOOCHO Piro Stratimikos Rythmos Zoltan2 Panzer PyTrilinos Kokkos Tpetra Muelu Sacado) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_CXX11=OFF" - "-DCMAKE_CXX_COMPILER:FILEPATH=/home/trilinos/gcc4.6.0/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/home/trilinos/gcc4.6.0/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/home/trilinos/gcc4.6.0/bin/gfortran" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DBoost_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/lib" - "-DGLM_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/glm-0.9.4.6" - "-DTrilinos_ENABLE_MOOCHO:BOOL=OFF" - "-DTrilinos_ENABLE_Piro:BOOL=OFF" - "-DTrilinos_ENABLE_Stratimikos:BOOL=OFF" - "-DTrilinos_ENABLE_Rythmos:BOOL=OFF" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/hdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/hdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.1.2/netcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/netcdf_4.2/include" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_debug_trilinos-test.cmake b/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_debug_trilinos-test.cmake deleted file mode 100644 index 39ab66beee71..000000000000 --- a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_debug_trilinos-test.cmake +++ /dev/null @@ -1,93 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_DEV) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(EXTRA_EXCLUDE_PACKAGES Panzer PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DBoost_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/lib" - "-DGLM_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/glm-0.9.4.6" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/hdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/hdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.1.2/netcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/netcdf_4.2/include" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_opt_gcc_4.5.1_trilinos-test.cmake b/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_opt_gcc_4.5.1_trilinos-test.cmake deleted file mode 100644 index 64e2ff3cfdaf..000000000000 --- a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_opt_gcc_4.5.1_trilinos-test.cmake +++ /dev/null @@ -1,103 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_OPT_DEV) -SET(COMPILER_VERSION "GCC-4.5.1") -SET(ENV{LD_LIBRARY_PATH} "/home/trilinos/install/gmp-4.3.2/lib:/home/trilinos/install/mpfr2.4.2/lib:/home/trilinos/install/mpc-0.8.1/lib:/home/trilinos/gcc4.5.1/lib64:$ENV{LD_LIBRARY_PATH}") -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) -#Stokhos is explicitly disabled below to prevent the package from being -#implicitly enabled. Sundance depends on Stokhos. -SET(EXTRA_EXCLUDE_PACKAGES Phalanx Stokhos Sundance Zoltan2 Panzer PyTrilinos Kokkos Tpetra Muelu Sacado) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_CXX11=OFF" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DBoost_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/lib" - "-DGLM_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/glm-0.9.4.6" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DCMAKE_CXX_COMPILER:FILEPATH=/home/trilinos/gcc4.5.1/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/home/trilinos/gcc4.5.1/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/home/trilinos/gcc4.5.1/bin/gfortran" - "-DTrilinos_ENABLE_Stokhos:BOOL=OFF" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/hdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/hdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.1.2/netcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/netcdf_4.2/include" - "-DTPL_ENABLE_CppUnit:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_opt_pgi_10.9_trilinos-test.cmake b/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_opt_pgi_10.9_trilinos-test.cmake deleted file mode 100644 index 4a3456faae37..000000000000 --- a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_opt_pgi_10.9_trilinos-test.cmake +++ /dev/null @@ -1,82 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.pgi10.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_OPT_DEV2) -SET(CTEST_TEST_TYPE EXPERIMENTAL) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(EXTRA_EXCLUDE_PACKAGES CTrilinos Didasko FEApp Phalanx Piro RBGen Rythmos STK Stokhos Sundance Teko TrilinosCouplings Panzer PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_opt_pgi_11.1_stable_trilinos-test.cmake b/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_opt_pgi_11.1_stable_trilinos-test.cmake deleted file mode 100644 index 2c78b19dfb87..000000000000 --- a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_opt_pgi_11.1_stable_trilinos-test.cmake +++ /dev/null @@ -1,90 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.pgi11.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_OPT_DEV1) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(Trilinos_PACKAGES FEApp Mesquite Didasko MOOCHO Moertel NOX RBGen Stratimikos ML Komplex Ifpack Pamgen Amesos Galeri AztecOO Pliris EpetraExt Triutils Shards Zoltan Kokkos RTOp TriBITS) - -SET( EXTRA_EXCLUDE_PACKAGES Rythmos Piro Panzer PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_CXX11=OFF" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTrilinos_ENABLE_Rythmos:BOOL=OFF" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/hdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/hdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.1.2/netcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/netcdf_4.2/include" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_opt_pgi_11.1_trilinos-test.cmake b/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_opt_pgi_11.1_trilinos-test.cmake deleted file mode 100644 index a754c0697b9a..000000000000 --- a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_opt_pgi_11.1_trilinos-test.cmake +++ /dev/null @@ -1,82 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.pgi11.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_OPT_DEV3) -SET(CTEST_TEST_TYPE EXPERIMENTAL) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(EXTRA_EXCLUDE_PACKAGES Panzer PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_opt_trilinos-test.cmake b/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_opt_trilinos-test.cmake deleted file mode 100644 index c4a8edcc2e71..000000000000 --- a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_development_opt_trilinos-test.cmake +++ /dev/null @@ -1,93 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_OPT_DEV) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(EXTRA_EXCLUDE_PACKAGES Panzer PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DBoost_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/lib" - "-DGLM_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/glm-0.9.4.6" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/hdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/hdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.1.2/netcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/netcdf_4.2/include" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_release_trilinos-test.cmake b/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_release_trilinos-test.cmake deleted file mode 100644 index eb08f0b1a2ec..000000000000 --- a/cmake/ctest/drivers/trilinos-test/ctest_linux_nightly_serial_release_trilinos-test.cmake +++ /dev/null @@ -1,96 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test.gcc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "SERIAL_RELEASE_${Trilinos_VERSION}") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(EXTRA_EXCLUDE_PACKAGES Panzer PyTrilinos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DBoost_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost_1_55_0_compiled/lib" - "-DGLM_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/glm-0.9.4.6" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/hdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/hdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.1.2/netcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/netcdf_4.2/include" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test/valgrind_suppressions_trilinos-test_gcc-4.1.2.txt b/cmake/ctest/drivers/trilinos-test/valgrind_suppressions_trilinos-test_gcc-4.1.2.txt deleted file mode 100644 index b28b04f64312..000000000000 --- a/cmake/ctest/drivers/trilinos-test/valgrind_suppressions_trilinos-test_gcc-4.1.2.txt +++ /dev/null @@ -1,3 +0,0 @@ - - - diff --git a/cmake/ctest/drivers/trilinos-test/valgrind_suppressions_trilinos-test_openmpi_1.2.7.txt b/cmake/ctest/drivers/trilinos-test/valgrind_suppressions_trilinos-test_openmpi_1.2.7.txt deleted file mode 100644 index f035ef524389..000000000000 --- a/cmake/ctest/drivers/trilinos-test/valgrind_suppressions_trilinos-test_openmpi_1.2.7.txt +++ /dev/null @@ -1,133 +0,0 @@ -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send - fun:orte_iof_proxy_svc_publish - fun:orte_iof_proxy_publish - fun:orte_iof_base_setup_parent - fun:orte_odls_default_launch_local_procs - obj:/usr/lib64/openmpi/1.2.7-gcc/bin/orted - fun:orte_gpr_proxy_deliver_notify_msg - fun:orte_gpr_proxy_notify_recv - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 -} - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - fun:_orte_iof_base_frag_ack - fun:orte_iof_base_endpoint_forward - fun:orte_iof_svc_proxy_recv - fun:mca_oob_tcp_msg_recv_complete - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/openmpi/mca_oob_tcp.so - fun:opal_event_base_loop - fun:opal_progress - obj:/usr/lib64/openmpi/1.2.7-gcc/bin/orterun -} - -{ - - Memcheck:Cond - fun:__strcpy_chk - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libmpi.so.0.0.0 - fun:orte_gpr_proxy_deliver_notify_msg - fun:mca_oob_xcast - fun:ompi_mpi_init - fun:PMPI_Init - fun:_ZN7Teuchos16GlobalMPISessionC1EPiPPPcPSo - fun:main -} - -{ - - Memcheck:Cond - fun:__strcpy_chk - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libmpi.so.0.0.0 - fun:orte_gpr_proxy_deliver_notify_msg - fun:mca_oob_xcast - fun:ompi_mpi_init - fun:PMPI_Init - fun:main -} - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - fun:orte_iof_svc_sub_forward - fun:orte_iof_svc_proxy_recv - fun:mca_oob_tcp_msg_recv_complete - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/openmpi/mca_oob_tcp.so - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 - fun:opal_event_base_loop - fun:opal_progress - obj:/usr/lib64/openmpi/1.2.7-gcc/bin/orterun -} - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 - fun:opal_event_base_loop - fun:opal_progress - fun:mca_oob_tcp_msg_wait - fun:mca_oob_tcp_recv - fun:mca_oob_recv_packed - fun:orte_gpr_proxy_exec_compound_cmd - fun:orte_odls_base_report_spawn -} - - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - fun:orte_iof_svc_sub_forward - fun:orte_iof_svc_proxy_recv - fun:mca_oob_tcp_msg_recv_complete - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/openmpi/mca_oob_tcp.so - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 - fun:opal_event_base_loop - fun:opal_progress - obj:/usr/lib64/openmpi/1.2.7-gcc/bin/orterun -} - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 - fun:opal_event_base_loop - fun:opal_progress - fun:mca_oob_tcp_msg_wait - fun:mca_oob_tcp_recv - fun:mca_oob_recv_packed - fun:orte_gpr_proxy_exec_compound_cmd - fun:orte_odls_base_report_spawn -} diff --git a/cmake/ctest/drivers/trilinos-test2/CMakeLists.txt b/cmake/ctest/drivers/trilinos-test2/CMakeLists.txt deleted file mode 100644 index d74739cc4841..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/CMakeLists.txt +++ /dev/null @@ -1,86 +0,0 @@ -TRILINOS_DRIVER_SETUP() - -find_program(PYTHON_EXE python) - -#TRILINOS_DRIVER_ADD_DASHBOARD( -# MPI_OPT_DEV -# ctest_linux_nightly_mpi_development_opt_trilinos-test2.cmake -# CTEST_INSTALLER_TYPE release -# TIMEOUT_MINUTES 300 -#) - -TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_OPT_DEV_NOEI - ctest_linux_nightly_mpi_development_opt_noei_trilinos-test2.cmake - CTEST_INSTALLER_TYPE release - TIMEOUT_MINUTES 330 -) - -#TRILINOS_DRIVER_ADD_DASHBOARD( -# MPI_DEBUG_DEV -# ctest_linux_nightly_mpi_development_debug_trilinos-test2.cmake -# CTEST_INSTALLER_TYPE release -#) - -TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_OPT_DEV_SHARED - ctest_linux_nightly_mpi_development_opt_shared_trilinos-test2.cmake - CTEST_INSTALLER_TYPE release - TIMEOUT_MINUTES 300 -) - -TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG_DEV - ctest_linux_nightly_serial_development_debug_trilinos-test2.cmake - CTEST_INSTALLER_TYPE release - TIMEOUT_MINUTES 240 -) - -SET(INSTALLATION_DIR "${CMAKE_BINARY_DIR}/../installation/installed") -SET(INSTALLATION_WORKING_DIR "${CMAKE_BINARY_DIR}/../installation") -ADD_TEST(Install_Trilinos ${PYTHON_EXE} - "${CMAKE_CURRENT_SOURCE_DIR}/nightly_create_tarball.py" - "--enable-mpi" - "--mpi-base-path=/home/trilinos" - "--no-dashboard" - "--working-dir=${INSTALLATION_WORKING_DIR}" - "--install-dir=${INSTALLATION_DIR}" - "--boost-dir=/home/trilinos/tpl/gcc4.1.2/boost-1.55.0" - "--netcdf-dir=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2" - "--verbose-errors" - "-j ${CTEST_PARALLEL_LEVEL}" - ) - -TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_OPT_DEV_INSTALL - ctest_linux_nightly_mpi_development_opt_install_trilinos-test2.cmake - CTEST_INSTALLER_TYPE release - DEPENDS Install_Trilinos - REQUIRED_FILES ${INSTALLATION_DIR}/lib/cmake/Trilinos/TrilinosConfig.cmake -) - -#TRILINOS_DRIVER_ADD_DASHBOARD( -# MPI_OPT_DEV_BACKWARDS_COMPATIBILITY_11.0 -# ctest_linux_nightly_mpi_development_opt_backwards_11_0_trilinos-test2.cmake -# CTEST_INSTALLER_TYPE release -# DEPENDS Install_Trilinos -# REQUIRED_FILES ${INSTALLATION_DIR}/lib/cmake/Trilinos/TrilinosConfig.cmake -#) - -#TRILINOS_DRIVER_ADD_DASHBOARD( -# MPI_OPT_DEV_BACKWARDS_COMPATIBILITY_11.4 -# ctest_linux_nightly_mpi_development_opt_backwards_11_4_trilinos-test2.cmake -# CTEST_INSTALLER_TYPE release -# DEPENDS Install_Trilinos -# REQUIRED_FILES ${INSTALLATION_DIR}/lib/cmake/Trilinos/TrilinosConfig.cmake -#) - -#TRILINOS_DRIVER_ADD_DASHBOARD( -# MPI_OPT_DEV_BACKWARDS_COMPATIBILITY_11.2 -# ctest_linux_nightly_mpi_development_opt_backwards_11_2_trilinos-test2.cmake -# CTEST_INSTALLER_TYPE release -# DEPENDS Install_Trilinos -# REQUIRED_FILES ${INSTALLATION_DIR}/lib/cmake/Trilinos/TrilinosConfig.cmake -#) - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/trilinos-test2/TrilinosCTestDriverCore.trilinos-test2.gcc.cmake b/cmake/ctest/drivers/trilinos-test2/TrilinosCTestDriverCore.trilinos-test2.gcc.cmake deleted file mode 100644 index 1f453b40930e..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/TrilinosCTestDriverCore.trilinos-test2.gcc.cmake +++ /dev/null @@ -1,150 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for trilinos-test2 using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_BUILD_FLAGS "-j12 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "12" ) - - SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} PyTrilinos TriKota) - - SET(TPLBASEDIR /home/trilinos/tpl/gcc4.1.2) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DCOVERAGE_COMMAND:FILEPATH=/usr/bin/gcov" - "-DMEMORYCHECK_COMMAND:FILEPATH=/usr/bin/valgrind" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DCppUnit_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/cppunit-1.12.1/include" - "-DCppUnit_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.1.2/cppunit-1.12.1/lib" - "-DLAMMPS_INCLUDE_DIRS:FILEPATH=${TPLBASEDIR}" - "-DTPL_LAMMPS_LIBRARIES:STIRNG=${TPLBASEDIR}/lammps/src/liblmp_wsblade.a" - "-Dcouple_INCLUDE_DIRS:FILEPATH=${TPLBASEDIR}/couple" - "-DTPL_couple_LIBRARIES:FILEPATH=${TPLBASEDIR}/couple/libcouple.a" - "-DSPPARKS_INCLUDE_DIRS:FILEPATH=${TPLBASEDIR}/spparks/src" - "-DTPL_SPPARKS_LIBRARIES:FILEPATH=${TPLBASEDIR}/spparks/src/libspk_wsblade.a" - "-DSuperLUDist_INCLUDE_DIRS:PATH=/home/trilinos/tpl/gcc4.1.2/openmpi1.4/SuperLU_DIST_2.5/SRC" - "-DSuperLUDist_LIBRARY_DIRS:PATH=/home/trilinos/tpl/gcc4.1.2/openmpi1.4/SuperLU_DIST_2.5/lib" - "-DSuperLUDist_LIBRARY_NAMES:STRING=superlu_dist_2.5" - "-DSuperLU_INCLUDE_DIRS:PATH=/home/trilinos/tpl/gcc4.1.2/SuperLU_4.3/SRC" - "-DSuperLU_LIBRARY_DIRS:PATH=/home/trilinos/tpl/gcc4.1.2/SuperLU_4.3/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu_4.3" - "-DGLM_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.1.2/glm-0.9.4.6" - "-DBoost_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost-1.55.0" - "-DBoostLib_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost-1.55.0_compiled/include" - "-DBoostLib_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/boost-1.55.0_compiled/lib" - "-DTPL_ENABLE_Matio=OFF" - "-DTPL_ENABLE_SuperLU=ON" - "-DIntrepid_ENABLE_DEBUG_INF_CHECK=OFF" - ) - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - SET_DEFAULT(COMPILER_VERSION "GCC-4.7.2") - - IF (COMM_TYPE STREQUAL MPI) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - ) -# "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" -# ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test2_openmpi_1.2.7.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_CXX_COMPILER:FILEPATH=/home/trilinos/gcc4.7.2/base/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/home/trilinos/gcc4.7.2/base/bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/home/trilinos/gcc4.7.2/base/bin/gfortran" - ) - - SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS - "--trace-children=yes --gen-suppressions=all --suppressions=${CTEST_SCRIPT_DIRECTORY}/valgrind_suppressions_trilinos-test2_gcc-4.1.2.txt ${CTEST_MEMORYCHECK_COMMAND_OPTIONS}" ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/trilinos-test2/cron_driver.sh b/cmake/ctest/drivers/trilinos-test2/cron_driver.sh deleted file mode 100755 index 88c551dee35e..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/cron_driver.sh +++ /dev/null @@ -1,44 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on trilinos-test2: `date`" -echo - -# TrilinosDriver settings: -# -export TDD_GIT_EXE=/home/trilinos/bin/git -export TDD_PARALLEL_LEVEL=2 -export TDD_CTEST_TEST_TYPE=Nightly - -# Trilinos settings: -# -#export CTEST_TEST_TYPE=Experimental -#export Trilinos_PACKAGES=Teuchos - -# Machine specific environment: -# -export PATH=/home/trilinos/tpl/gcc4.1.2/swig-3.0.4/bin:/home/trilinos/python-2.7.9/bin:/home/trilinos/bin:/usr/kerberos/bin:/usr/local/bin:/bin:/usr/bin:/home/jmwille/bin:/home/trilinos/tpl/gcc4.1.2/qt-4.5.2/bin - -# BASEDIR is the parent directory of this script's Trilinos source tree... -BASEDIR=`cd "\`dirname \"$0\"\`/../../../../..";pwd` -echo BASEDIR=$BASEDIR -BASEDATADIR=$BASEDIR - -export CVS_RSH=ssh -export LD_LIBRARY_PATH="/home/trilinos/lib:$BASEDIR/MPI_OPT_DEV_SHARED/BUILD/packages/PyTrilinos/src:/home/trilinos/gcc4.7.2/base/lib64" -export PYTHONPATH="/home/trilinos/tpl/gcc4.1.2/numpy-1.9.1/lib/python2.7/site-packages" -export TRILINOSDATADIRECTORY="$BASEDATADIR/TrilinosData" - -pushd "$BASEDATADIR" -cvs -q -d :ext:software.sandia.gov:/space/CVS co TrilinosData -popd - -# Machine independent cron_driver: -# -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on trilinos-test2: `date`" -echo - diff --git a/cmake/ctest/drivers/trilinos-test2/cron_driver_continuous_trilinos-test2.sh b/cmake/ctest/drivers/trilinos-test2/cron_driver_continuous_trilinos-test2.sh deleted file mode 100755 index 60e3ce459c10..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/cron_driver_continuous_trilinos-test2.sh +++ /dev/null @@ -1,54 +0,0 @@ -#!/bin/bash - -CTEST_EXE=/home/trilinos/bin/ctest -EG_EXE=/home/trilinos/bin/eg -BASEDIR=/home/trilinos/dashboards/cont-dev -DRIVER_SCRIPT_DIR=$BASEDIR/Trilinos/cmake/ctest/drivers/trilinos-test2 -TRILINOS_REPOSITORY_LOCATION="software.sandia.gov:/space/git/Trilinos" - -# Source the -cd $HOME -source .bash_profile - -if [ "$_DAYOFWEEK" == "" ] ; then - _DAYOFWEEK=`date +%A` -fi - -DATE=`date "+%Y%m%d"` - -echo "_DAYOFWEEK=$_DAYOFWEEK" - -echo -echo "Starting Trilinos continuous integration testing on trilinos-test2: `date`" -echo - - -export LD_LIBRARY_PATH="/home/trilinos/gcc4.7.2/base/lib64:$LD_LIBRARY_PATH" - -echo -echo "Checking out just the skeleton cmake/ctest code: `date`" -echo - -cd $BASEDIR -if [ -d Trilinos ]; then - echo Doing an update of existing directory - cd Trilinos - $EG_EXE pull - cd .. -else - echo Cloning the repository because none exists yet - $EG_EXE clone $TRILINOS_REPOSITORY_LOCATION -fi - - -echo -echo "Doing continuous mpi optimized development shared library build: `date`" -echo - -time ${CTEST_EXE} -j 14 -S $DRIVER_SCRIPT_DIR/ctest_linux_continuous_mpi_opt_shared_trilinos-test2.cmake &> "CONTINUOUS_MPI_OPT_DEV_SHARED_$DATE.log" - - -echo -echo "Ending Trilinos continuous integration testing on trilinos-test2. `date`" -echo - diff --git a/cmake/ctest/drivers/trilinos-test2/ctest_linux_continuous_mpi_opt_shared_trilinos-test2.cmake b/cmake/ctest/drivers/trilinos-test2/ctest_linux_continuous_mpi_opt_shared_trilinos-test2.cmake deleted file mode 100644 index 86dfd0dc1f20..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/ctest_linux_continuous_mpi_opt_shared_trilinos-test2.cmake +++ /dev/null @@ -1,129 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test2.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME CONTINUOUS_${COMM_TYPE}_OPT_DEV_SHARED) -#SET(CTEST_TEST_TIMEOUT 900) - -#override the default number of processors to run on. -SET( CTEST_BUILD_FLAGS "-j12 -i" ) -SET( CTEST_PARALLEL_LEVEL "12" ) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - "-DBUILD_SHARED_LIBS:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/include" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/lib" - "-DTPL_ENABLE_Expat:BOOL=ON" - "-DTPL_ENABLE_LAMMPS:BOOL=ON" - "-DTPL_ENABLE_couple:BOOL=ON" - "-DTPL_ENABLE_SPPARKS:BOOL=ON" - "-DTPL_ENABLE_SuperLU:BOOL=ON" - ) - -# 2009/11/26: rabartl: Do we really want to be pointing to Trilinos_DATA_DIR? -# Unless the CI sever is going to be updatting this every iteration this is -# likely to cause an inconsistency and a test failure. For example, if -# someone adds a new test and then adds new test data, the CI server will only -# get the new test but not the new test data. Therefore, I am removing this. -# # "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -SET(CTEST_TEST_TYPE Continuous) - -SET(CTEST_START_WITH_EMPTY_BINARY_DIRECTORY ON) -SET(CTEST_ENABLE_MODIFIED_PACKAGES_ONLY OFF) -SET(done 0) - -WHILE(NOT done) - SET(START_TIME ${CTEST_ELAPSED_TIME}) - - TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() - - SET(CTEST_START_WITH_EMPTY_BINARY_DIRECTORY OFF) - SET(CTEST_ENABLE_MODIFIED_PACKAGES_ONLY ON) - - MESSAGE("Before CTEST_SLEEP: CTEST_ELAPSED_TIME='${CTEST_ELAPSED_TIME}'") - - # Loop at most once every 3 minutes (180 seconds) - CTEST_SLEEP(${START_TIME} 180 ${CTEST_ELAPSED_TIME}) - - # Stop after 14 hours: - IF(${CTEST_ELAPSED_TIME} GREATER 50400) - SET(done 1) - ENDIF() - - MESSAGE("Bottom of continuous while loop: CTEST_ELAPSED_TIME='${CTEST_ELAPSED_TIME}'") -ENDWHILE() diff --git a/cmake/ctest/drivers/trilinos-test2/ctest_linux_continuous_mpi_opt_shared_trilinos-test2_jenkins.cmake b/cmake/ctest/drivers/trilinos-test2/ctest_linux_continuous_mpi_opt_shared_trilinos-test2_jenkins.cmake deleted file mode 100644 index 12ebe147fecf..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/ctest_linux_continuous_mpi_opt_shared_trilinos-test2_jenkins.cmake +++ /dev/null @@ -1,150 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test2.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME CONTINUOUS_${COMM_TYPE}_OPT_DEV_SHARED) -#SET(CTEST_TEST_TIMEOUT 900) - -#override the default number of processors to run on. -SET( CTEST_BUILD_FLAGS "-j12 -i" ) -SET( CTEST_PARALLEL_LEVEL "12" ) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(EXTRA_EXCLUDE_PACKAGES Optika TrilinosCouplings) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - "-DBUILD_SHARED_LIBS:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/include" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/lib" - "-DTPL_ENABLE_Expat:BOOL=ON" - "-DTPL_ENABLE_LAMMPS:BOOL=ON" - "-DTPL_ENABLE_couple:BOOL=ON" - "-DTPL_ENABLE_SPPARKS:BOOL=ON" - "-DTPL_ENABLE_SuperLU:BOOL=ON" - "-DTPL_ENABLE_CppUnit:BOOL=ON" - "-DSTK_stk_mesh_unit_tests_MPI_4_DISABLE=ON" - "-DSTK_util_parallel_UnitTest_MPI_4_DISABLE=ON" - "-DTrilinos_TRACE_ADD_TEST=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -SET(CTEST_TEST_TYPE Continuous) - -# Set the following variables to reasonable values so the Jenkins job -# provides useful feedback, rather then always returning an error -# because they aren't defined. - -# The Jenkins checkout of the scripts repository. -SET(CTEST_SOURCE_DIRECTORY "$ENV{WORKSPACE}/Trilinos") -# The location where the Jenkins script gets run. -SET(CTEST_BINARY_DIRECTORY "$ENV{WORKSPACE}/continuous-development") -# The CTest command being used by Jenkins. -SET(CTEST_COMMAND "/home/trilinos/bin/ctest") - -function(VISIBLE_MESSAGE message) - message("\n***") - message("*** ${message}") - message("***\n") -endfunction() - -# Check to see if we need to start with an empty binary directory or enabling -# modified packages only. First, get the current time in seconds past the -# epoch. -execute_process( - COMMAND date +%s - OUTPUT_VARIABLE _current_time -) -set(_timestamp_file timestamp.txt) -if(NOT EXISTS ${_timestamp_file}) - VISIBLE_MESSAGE("No timestamp file exists, performing a clean build.") - SET(CTEST_START_WITH_EMPTY_BINARY_DIRECTORY ON) - SET(CTEST_ENABLE_MODIFIED_PACKAGES_ONLY OFF) - file(WRITE ${_timestamp_file} ${_current_time}) -else() - file(READ ${_timestamp_file} _last_time) - math(EXPR _difference "${_current_time} - ${_last_time}") - if(${_difference} GREATER 57600) # 16 hours - VISIBLE_MESSAGE("Timestamp is more than 16 hours old, performing a clean build.") - SET(CTEST_START_WITH_EMPTY_BINARY_DIRECTORY ON) - SET(CTEST_ENABLE_MODIFIED_PACKAGES_ONLY OFF) - file(WRITE ${_timestamp_file} ${_current_time}) - else() - VISIBLE_MESSAGE("Timestamp is less than 16 hours old, performing an incremental build.") - SET(CTEST_START_WITH_EMPTY_BINARY_DIRECTORY OFF) - SET(CTEST_ENABLE_MODIFIED_PACKAGES_ONLY ON) - endif() -endif() - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() - diff --git a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_debug_coverage_trilinos-test2.cmake b/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_debug_coverage_trilinos-test2.cmake deleted file mode 100644 index ce3614913574..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_debug_coverage_trilinos-test2.cmake +++ /dev/null @@ -1,94 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test2.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG_DEV_COVERAGE) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(CTEST_DO_COVERAGE_TESTING TRUE) -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DTPL_ENABLE_ParMETIS:BOOL=ON" - "-DParMETIS_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.7.2/ParMETIS-4.0.3_32bit/lib" - "-DParMETIS_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.7.2/ParMETIS-4.0.3_32bit/include" - "-DTPL_ENABLE_Scotch:BOOL=ON" - "-DScotch_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.7.2/scotch_6.0.3_32bit/lib" - "-DScotch_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.7.2/scotch_6.0.3_32bit/include" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/include" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_debug_trilinos-test2.cmake b/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_debug_trilinos-test2.cmake deleted file mode 100644 index e4de43603654..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_debug_trilinos-test2.cmake +++ /dev/null @@ -1,93 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test2.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG_DEV) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DTPL_ENABLE_ParMETIS:BOOL=ON" - "-DParMETIS_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.7.2/ParMETIS-4.0.3_32bit/lib" - "-DParMETIS_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.7.2/ParMETIS-4.0.3_32bit/include" - "-DTPL_ENABLE_Scotch:BOOL=ON" - "-DScotch_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.7.2/scotch_6.0.3_32bit/lib" - "-DScotch_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.7.2/scotch_6.0.3_32bit/include" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/include" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_backwards_10_8_trilinos-test2.cmake b/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_backwards_10_8_trilinos-test2.cmake deleted file mode 100644 index 38b29126f82c..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_backwards_10_8_trilinos-test2.cmake +++ /dev/null @@ -1,105 +0,0 @@ -# @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 - -#run command to create a tarball and install from that so we can test against that installation - -#hard coding where the installation dir is for now. -#Ideally this should be pulled in from the same variable that is used to set the installation -#dir for the script. -SET(INSTALLATION_DIR "${CMAKE_CURRENT_BINARY_DIR}/../../installation/installed") - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test2.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV_BACKWARDS_COMPATIBILITY_10.8) -#SET(CTEST_TEST_TIMEOUT 900) -SET(CTEST_TEST_TYPE EXPERIMENTAL) - -#setting this temporarily while this is an experimental test -#the default repository for experimental is /space/git/Trilinos -#but the branch in question only exists on /space/git/nightly/Trilinos -SET(Trilinos_REPOSITORY_LOCATION "software.sandia.gov:/space/git/nightly/Trilinos") - -SET(Trilinos_BRANCH "trilinos-release-10-8-branch-dummy") - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - -SET(EXTRA_EXCLUDE_PACKAGES Mesquite RBGen) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_INSTALLATION_DIR=${INSTALLATION_DIR}" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" - "-DTrilinos_ENABLE_DEVELOPMENT_MODE:BOOL=OFF" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/include" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/lib" - "-DTrilinos_ENABLE_RBGen=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_backwards_11_0_trilinos-test2.cmake b/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_backwards_11_0_trilinos-test2.cmake deleted file mode 100644 index 3f75e22422cf..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_backwards_11_0_trilinos-test2.cmake +++ /dev/null @@ -1,106 +0,0 @@ -# @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 - -#run command to create a tarball and install from that so we can test against that installation - -#hard coding where the installation dir is for now. -#Ideally this should be pulled in from the same variable that is used to set the installation -#dir for the script. -SET(INSTALLATION_DIR "${CMAKE_CURRENT_BINARY_DIR}/../../installation/installed") - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test2.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV_BACKWARDS_COMPATIBILITY_11.0) -#SET(CTEST_TEST_TIMEOUT 900) -SET(CTEST_TEST_TYPE EXPERIMENTAL) - -#setting this temporarily while this is an experimental test -#the default repository for experimental is /space/git/Trilinos -#but the branch in question only exists on /space/git/nightly/Trilinos -SET(Trilinos_REPOSITORY_LOCATION "software.sandia.gov:/space/git/nightly/Trilinos") - -SET(Trilinos_BRANCH "trilinos-release-11-0-branch") - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - -SET(EXTRA_EXCLUDE_PACKAGES Mesquite RBGen) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_INSTALLATION_DIR=${INSTALLATION_DIR}" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" - "-DTrilinos_ENABLE_DEVELOPMENT_MODE:BOOL=OFF" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/include" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/lib" - "-DTrilinos_ENABLE_RBGen=OFF" - "-DTPL_ENABLE_SuperLU=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_backwards_11_2_trilinos-test2.cmake b/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_backwards_11_2_trilinos-test2.cmake deleted file mode 100644 index ccc811518402..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_backwards_11_2_trilinos-test2.cmake +++ /dev/null @@ -1,106 +0,0 @@ -# @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 - -#run command to create a tarball and install from that so we can test against that installation - -#hard coding where the installation dir is for now. -#Ideally this should be pulled in from the same variable that is used to set the installation -#dir for the script. -SET(INSTALLATION_DIR "${CMAKE_CURRENT_BINARY_DIR}/../../installation/installed") - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test2.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV_BACKWARDS_COMPATIBILITY_11.2) -#SET(CTEST_TEST_TIMEOUT 900) -SET(CTEST_TEST_TYPE EXPERIMENTAL) - -#setting this temporarily while this is an experimental test -#the default repository for experimental is /space/git/Trilinos -#but the branch in question only exists on /space/git/nightly/Trilinos -SET(Trilinos_REPOSITORY_LOCATION "software.sandia.gov:/space/git/nightly/Trilinos") - -SET(Trilinos_BRANCH "trilinos-release-11-2-branch") - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - -SET(EXTRA_EXCLUDE_PACKAGES Mesquite RBGen) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_INSTALLATION_DIR=${INSTALLATION_DIR}" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" - "-DTrilinos_ENABLE_DEVELOPMENT_MODE:BOOL=OFF" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/include" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/lib" - "-DTrilinos_ENABLE_RBGen=OFF" - "-DTPL_ENABLE_SuperLU=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_backwards_11_4_trilinos-test2.cmake b/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_backwards_11_4_trilinos-test2.cmake deleted file mode 100644 index 1e3a0e8d850c..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_backwards_11_4_trilinos-test2.cmake +++ /dev/null @@ -1,108 +0,0 @@ -# @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 - -#run command to create a tarball and install from that so we can test against that installation - -#hard coding where the installation dir is for now. -#Ideally this should be pulled in from the same variable that is used to set the installation -#dir for the script. -SET(INSTALLATION_DIR "${CMAKE_CURRENT_BINARY_DIR}/../../installation/installed") - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test2.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV_BACKWARDS_COMPATIBILITY_11.4) -#SET(CTEST_TEST_TIMEOUT 900) -SET(CTEST_TEST_TYPE Nightly) - -#setting this temporarily while this is an experimental test -#the default repository for experimental is /space/git/Trilinos -#but the branch in question only exists on /space/git/nightly/Trilinos -SET(Trilinos_REPOSITORY_LOCATION "software.sandia.gov:/space/git/nightly/Trilinos") - -SET(Trilinos_BRANCH "trilinos-release-11-4-branch") - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE OFF) - -SET(EXTRA_EXCLUDE_PACKAGES Mesquite RBGen TriBITS) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_INSTALLATION_DIR=${INSTALLATION_DIR}" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" - "-DTrilinos_ENABLE_DEVELOPMENT_MODE:BOOL=OFF" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/include" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/lib" - "-DTrilinos_ENABLE_Mesquite=OFF" - "-DTrilinos_ENABLE_RBGen=OFF" - "-DTrilinos_ENABLE_TriBITS=OFF" - "-DTPL_ENABLE_SuperLU=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_install_trilinos-test2.cmake b/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_install_trilinos-test2.cmake deleted file mode 100644 index 82c99ece42f8..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_install_trilinos-test2.cmake +++ /dev/null @@ -1,102 +0,0 @@ -# @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 - -#run command to create a tarball and install from that so we can test against that installation - -#hard coding where the installation dir is for now. -#Ideally this should be pulled in from the same variable that is used to set the installation -#dir for the script. -SET(INSTALLATION_DIR "${CMAKE_CURRENT_BINARY_DIR}/../../installation/installed") - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test2.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV_INSTALL) -#SET(CTEST_TEST_TIMEOUT 900) -SET(CTEST_TEST_TYPE Nightly) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(EXTRA_EXCLUDE_PACKAGES Didasko FEApp ForTrilinos MueLu Panzer Optika PyTrilinos RBGen SEACAS STK TriKota TriBITS) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_INSTALLATION_DIR=${INSTALLATION_DIR}" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" - "-DTrilinos_ENABLE_DEVELOPMENT_MODE:BOOL=OFF" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/include" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/lib" - "-DTrilinos_ENABLE_RBGen=OFF" - "-DTrilinos_ENABLE_MueLu=OFF" - "-DTrilinos_ENABLE_SEACAS=OFF" - "-DTrilinos_ENABLE_STK=OFF" - "-DTPL_ENABLE_SuperLU:BOOL=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_noei_trilinos-test2.cmake b/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_noei_trilinos-test2.cmake deleted file mode 100644 index a539af00bbd9..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_noei_trilinos-test2.cmake +++ /dev/null @@ -1,98 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test2.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV_NOEI) -#SET(CTEST_TEST_TIMEOUT 900) -SET(CTEST_TEST_TYPE Nightly) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -#SET( EXTRA_EXCLUDE_PACKAGES Sundance) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=OFF" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DTPL_ENABLE_ParMETIS:BOOL=ON" - "-DParMETIS_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.7.2/ParMETIS-4.0.3_32bit/lib" - "-DParMETIS_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.7.2/ParMETIS-4.0.3_32bit/include" - "-DTPL_ENABLE_Scotch:BOOL=ON" - "-DScotch_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.7.2/scotch_6.0.3_32bit/lib" - "-DScotch_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.7.2/scotch_6.0.3_32bit/include" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/include" - "-DZoltan2_ENABLE_Experimental=ON" - "-DTPL_ENABLE_CppUnit:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_shared_trilinos-test2.cmake b/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_shared_trilinos-test2.cmake deleted file mode 100644 index ab553c8169fb..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_shared_trilinos-test2.cmake +++ /dev/null @@ -1,102 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test2.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV_SHARED) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(EXTRA_EXCLUDE_PACKAGES STK ) -#can't use default Trilinos_EXCLUDE_PACKAGES because it includes PyTrilinos -SET( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} TriKota) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DBUILD_SHARED_LIBS:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DSWIG_EXECUTABLE:FILEPATH=/home/trilinos/tpl/gcc4.1.2/swig-3.0.4/bin/swig" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DTPL_ENABLE_Expat:BOOL=ON" - "-DTPL_ENABLE_LAMMPS:BOOL=ON" - "-DTPL_ENABLE_couple:BOOL=ON" - "-DTPL_ENABLE_SPPARKS:BOOL=ON" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/include" - "-DPyTrilinos_ENABLE_STK=OFF" - "-DPyTrilinos_ENABLE_Tpetra=OFF" - "-DTPL_ENABLE_CppUnit:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_trilinos-test2.cmake b/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_trilinos-test2.cmake deleted file mode 100644 index 527766390cd5..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_mpi_development_opt_trilinos-test2.cmake +++ /dev/null @@ -1,97 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test2.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -#SET(EXTRA_EXCLUDE_PACKAGES Zoltan2) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DMPI_BASE_DIR:PATH=/home/trilinos/gcc4.7.2/openmpi-1.6.5" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DTPL_ENABLE_ParMETIS:BOOL=ON" - "-DParMETIS_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.7.2/ParMETIS-4.0.3_32bit/lib" - "-DParMETIS_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.7.2/ParMETIS-4.0.3_32bit/include" - "-DTPL_ENABLE_Scotch:BOOL=ON" - "-DScotch_LIBRARY_DIRS=/home/trilinos/tpl/gcc4.7.2/scotch_6.0.3_32bit/lib" - "-DScotch_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.7.2/scotch_6.0.3_32bit/include" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/phdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/pnetcdf_4.2/include" - "-DTPL_ENABLE_CppUnit:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_serial_development_debug_trilinos-test2.cmake b/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_serial_development_debug_trilinos-test2.cmake deleted file mode 100644 index 8395ed1da66a..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/ctest_linux_nightly_serial_development_debug_trilinos-test2.cmake +++ /dev/null @@ -1,91 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.trilinos-test2.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_DEV) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - -SET(EXTRA_EXCLUDE_PACKAGES Zoltan2 Panzer) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DTPL_ENABLE_HDF5:BOOL=ON" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/hdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/hdf5-1.8.6/lib" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/netcdf_4.2/lib" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.1.2/netcdf_4.2/include" - "-DTPL_ENABLE_CppUnit:BOOL=ON" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/trilinos-test2/nightly_create_tarball.py b/cmake/ctest/drivers/trilinos-test2/nightly_create_tarball.py deleted file mode 100755 index f4cc381f0b5a..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/nightly_create_tarball.py +++ /dev/null @@ -1,406 +0,0 @@ -#! /usr/bin/env python - -# @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 - -from optparse import OptionParser -import os -import sys -import shutil -import re -import subprocess - -# Default list of package enables and disables. Trikota, STK, and -# Optika are disabled due to explicit dependencies which can't always -# be met. -DEFAULT_ENABLE_DISABLE_LIST = [ - ("Amesos", True), - ("Amesos2", True), - ("Anasazi", True), - ("Aristos", False), - ("AztecOO", True), - ("Belos", True), - ("CTrilinos", True), - ("Didasko", False), - ("Epetra", True), - ("EpetraExt", True), - ("FEApp", False), - ("FEI", True), - ("Galeri", True), - ("Ifpack", True), - ("Ifpack2", True), - ("Intrepid", True), - ("Isorropia", True), - ("Kokkos", True), - ("Komplex", True), - ("ML", True), - ("Moertel", True), - ("MOOCHO", True), - ("MueLu", False), - ("NOX", True), - ("NewPackage", False), - ("Optika", False), - ("Pamgen", True), - ("Panzer", False), - ("Phalanx", True), - ("Phdmesh", False), - ("Piro", True), - ("Pliris", True), - ("PyTrilinos", False), - ("RBGen", False), - ("RTOp", True), - ("Rythmos", True), - ("Sacado", True), - ("SEACAS", False), - ("Shards", True), - ("ShyLU", True), - ("STK", False), - ("Stokhos", True), - ("Stratimikos", True), - ("Sundance", True), - ("Teko", True), - ("Teuchos", True), - ("Thyra", True), - ("Tpetra", True), - ("TriKota", False), - ("TrilinosCouplings", True), - ("TrilinosFramework", False), - ("Triutils", True), - ("WebTrilinos", False), - ("Xpetra", True), - ("Zoltan", True), - ("Zoltan2", True), - ("Gtest", True), -] - -#Make reporting errors easier to make consistent between all system calls -def reportError(errorCode, errorMessage, errorFileName="", verboseError=False): - if errorCode != 0: - print errorMessage - if verboseError and errorFileName != "": - errorFile = open(errorFileName) - for line in errorFile: - print line.strip() - errorFile.close() - sys.exit(1) - -def run_command(command, working_directory, outputfile): - """ - Run a shell command, redirecting output to the given output file. - """ - return subprocess.call(command, shell=True, - stdout=outputfile, stderr=outputfile, - cwd=working_directory) - -def configure_cmake_build(build_dir, source_dir, cmake_options, outputfile=None): - """ - Run the configure step for a CMake build in the given build - directory using the specified source directory. The cmake_options - argument should be an associative list (a list of pairs) specifying - variable name and value. The pairs will be turned into - '-Dname=value' arguments to the CMake command. Output will be - directed to the file-like object specified by the outputfile - argument. This function will perform a clean CMake build, that is - any existing cache will be deleted. The exit code of the CMake - process is returned. - """ - print "config dir exists? " + str(os.path.exists(build_dir)) - print "cwd is " + os.getcwd() - if not os.path.exists(build_dir): - print "Creating CMake build directory %s" % build_dir - os.mkdir(build_dir) - - cachepath = os.path.join(build_dir, "CMakeCache.txt") - if os.path.exists(cachepath): - os.remove(cachepath) - - to_cmake = lambda pair: "-D%s=%s" % pair - configureCmd = "cmake " + " ".join(map(to_cmake, cmake_options)) + " " + source_dir - print configureCmd - return run_command(configureCmd, build_dir, outputfile) - -def get_options(workingDir): - parser = OptionParser() - - repositoryDefault="software.sandia.gov:/space/git/nightly/Trilinos" - - parser.add_option("-r", "--repository", dest="repository", action="store", - default=repositoryDefault, - help="Sets the repository to pull Trilinos from. Default=%default") - parser.add_option("--cxx-compiler", dest="cxx", action="store", default="/home/trilinos/gcc4.7.2/openmpi-1.6.5/bin/g++", - help="Sets the C++ compiler to use. Default=%default") - parser.add_option("--c-compiler", dest="cc", action="store", default="/home/trilinos/gcc4.7.2/openmpi-1.6.5/bin/gcc", - help="Sets the C compiler to use. Default=%default") - parser.add_option("--fortran-compiler", dest="fortran", action="store", default="/home/trilinos/gcc4.7.2/openmpi-1.6.5/bin/gfortran", - help="Sets the Fortran compiler to use. Default=%default") - parser.add_option("--enable-mpi", dest="enableMpi", action="store_true", default=False, - help="Enable an MPI build of Trilinos. Default=%default") - parser.add_option("--mpi-base-path", dest="mpiBaseDir", action="store", default="", - help="Sets the base path where we can find the mpi compiler wrappers, run environmnet and headers libraries. Default=%default") - parser.add_option("--disable-boost", dest="disableBoost", action="store_true", default=False, - help="Disable the Boost TPL. Default=%default") - parser.add_option("--boost-dir", dest="boostDir", action="store", default="/usr/lib", - help="Sets the location of the boost library. Default=%default") - parser.add_option("--disable-netcdf", dest="disableNetcdf", action="store_true", default=False, - help="Disable the NetCDF TPL. Default=%default") - parser.add_option("--netcdf-dir", dest="netcdfDir", action="store", default="/usr/lib", - help="Sets the location of the netcdf library. Default=%default") - parser.add_option("--no-dashboard", dest="doDashboardBuild", action="store_false", default=True, - help="Disables the dashboard submission build. The default is to do the dashboard build") - parser.add_option("--install-dir", dest="installDir", action="store", default=workingDir+"/install", - help="Sets the location of where Trilinos will be installed to. Default=%default") - parser.add_option("--working-dir", dest="workingDir", action="store", default=workingDir, - help="Sets the directory that this script will run from. Default=%default") - parser.add_option("--branch", dest="branch", action="store", default="master", - help="Sets the branch that should be used to build the tarball and installation from. Default=%default") - parser.add_option("--shared", dest="shared", action="store_true", default=False, - help="Build shared libraries instead of static. Default=%default") - parser.add_option("--enable-secondary-stable", dest="secondaryStable", action="store_true", default=False, - help="Enable secondary stable code. Default=master") - parser.add_option("--verbose-errors", dest="verboseErrors", action="store_true", default=False, - help="Enable verbose error reporting. This will cause the output of the command that failed to be sent to stdout. Default=master") - parser.add_option("-j", dest="buildProcs", action="store", default=1, - help="Specify the number of processes to run make with. Default=%default") - parser.add_option("--build-type", dest="buildType", action="store", default="RELEASE", - help="Specify the build type to build for the install(eg. RELEASE or DEBUG). Default=%default") - - return parser.parse_args() - -def main(package_enable_disable_list, options): - workingDir = os.getcwd() - - options.configurePath = "configure" - options.tarballBuildPath = "tarball_build" - #strip any relative bits out of the path - options.workingDir = os.path.abspath(options.workingDir) - - #create the working dir if it doesn't exist - if not os.path.exists(options.workingDir): - os.mkdir(options.workingDir) - - #switch to working dir. This is essentially a noop if the working dir = current dir. - os.chdir(options.workingDir) - - print "Running nightly_create_tarball.py" - print "Installing to " + options.installDir - - # - # Build the CMake configure options - # - cmake_configure_options = [] - #choosing which compilers to use, mpi vs standard - compilerPathString = "" - if options.enableMpi: - cmake_configure_options.append(("TPL_ENABLE_MPI", "ON")) - if options.mpiBaseDir != "": - cmake_configure_options.append(("MPI_BASE_DIR", options.mpiBaseDir)) - else: - cmake_configure_options.append(("CMAKE_CXX_COMPILER", options.cxx)) - cmake_configure_options.append(("CMAKE_C_COMPILER", options.cc)) - cmake_configure_options.append(("CMAKE_Fortran_COMPILER", options.fortran)) - - if options.shared: - cmake_configure_options.append(("BUILD_SHARED_LIBS:BOOL", "ON")) - - if options.secondaryStable: - # have to manually disable the teuchos float and complex options - # since they are enabled by default when not in development mode. - cmake_configure_options.append(("Trilinos_ENABLE_SECONDARY_STABLE_CODE", "ON")) - - cmake_configure_options.append(("HAVE_GCC_ABI_DEMANGLE", "ON")) - cmake_configure_options.append(("Trilinos_WARNINGS_AS_ERRORS_FLAGS", "")) - cmake_configure_options.append(("CMAKE_VERBOSE_MAKEFILE", "TRUE")) - cmake_configure_options.append(("Trilinos_ENABLE_CPACK_PACKAGING", "ON")) - for package, is_enabled in package_enable_disable_list: - if is_enabled: - on_or_off = "ON" - else: - on_or_off = "OFF" - cmake_configure_options.append(("Trilinos_ENABLE_%s" % package, on_or_off)) - - cmake_configure_options.append(("Trilinos_ENABLE_EXPLICIT_INSTANTIATION", "ON")) - if not options.disableBoost: - cmake_configure_options.append(("TPL_ENABLE_Boost", "ON")) - cmake_configure_options.append(("Boost_INCLUDE_DIRS", options.boostDir)) - if not options.disableNetcdf: - cmake_configure_options.append(("TPL_ENABLE_Netcdf", "ON")) - cmake_configure_options.append(("Netcdf_LIBRARY_DIRS", - os.path.join(options.netcdfDir, "lib"))) - cmake_configure_options.append(("Netcdf_INCLUDE_DIRS", - os.path.join(options.netcdfDir, "include"))) - cmake_configure_options.append(("CMAKE_INSTALL_PREFIX", options.installDir)) - cmake_configure_options.append(("CMAKE_BUILD_TYPE", options.buildType)) - - #removing install directory first so that subsequent installs aren't polluted by old installs - print "attempting to remove the old install dir" - try: - shutil.rmtree(options.installDir, True) - except: - print "execption while removing " + options.installDir - print sys.exc_info()[1] - - #removing configure directory first so that subsequent installs aren't polluted by old tarballs or configuration issues - print "attempting to remove the old configure dir" - try: - shutil.rmtree(options.configurePath, True) - except: - print "execption while removing " + options.configurePath - print sys.exc_info()[1] - - print "done trying to remove old install and configure directories" - - gitBranchError = 0 - #clone repo - if os.path.exists("Trilinos"): - print "Repository already exists so updating instead of cloning." - os.chdir("Trilinos") - if options.branch != "master": - gitBranchCmd = "git checkout " + options.branch - gitBranchError = os.system(gitBranchCmd) - gitPullCmd = "git pull" - gitError = os.system(gitPullCmd) - os.chdir(options.workingDir) - else: - print "Repository doesn't exist so cloning." - gitCloneCmd = "git clone " + options.repository + " Trilinos" - gitError = os.system(gitCloneCmd) - os.chdir("Trilinos") - if options.branch != "master": - gitBranchCmd = "git checkout --track origin/" + options.branch - gitBranchError = os.system(gitBranchCmd) - os.chdir(options.workingDir) - - - reportError(gitError, "Could not retrieve repository " + options.repository) - reportError(gitBranchError, "Could not checkout branch " + options.branch) - - #configure and create tarball - print "Configuring to create a tarball." - configure_dir = os.path.join(options.workingDir, options.configurePath) - source_dir = os.path.join(options.workingDir, "Trilinos") - reportError( - configure_cmake_build( - configure_dir, - source_dir, - cmake_configure_options, - file("configure.out", "w")), - "Failure while configuring for tarball creation. See configure.out for details.", - options.verboseErrors) - - print "Creating a tarball." - reportError(run_command("make package_source", - configure_dir, - file("make_tarball.out", "w")), - "Failure while creating tarball, see make_tarball.out for details.", - "make_tarball.out", - options.verboseErrors) - - tarball_build_path = os.path.join(options.workingDir, options.tarballBuildPath) - if os.path.exists(tarball_build_path): - print "Deleting directory " + tarball_build_path - shutil.rmtree(tarball_build_path) - - os.mkdir(tarball_build_path) - fileList = os.listdir(configure_dir) - - #find the tarball we need to copy - for entry in fileList: - if re.match("trilinos-.*-Source\.tar\.gz", entry): - tarballFileName = entry - print "found tarball: '" + tarballFileName + "'" - break - - print "Expanding the tarball." - shutil.copy(os.path.join(configure_dir, tarballFileName), tarball_build_path) - tarball_path = os.path.join(tarball_build_path, tarballFileName) - # Use command line tar because of broken tarfile module in python 2.4. - reportError(run_command("tar -xzvf " + tarball_path, tarball_build_path, file("tar.out", "w")), - "Could not expand tarball, see tar.out for details.", "tar.out", options.verboseErrors) - - #Make install - print "Building and installing from the tarball." - trilinosDir = tarballFileName[:-7] - tarball_cmake_path = os.path.join(tarball_build_path, "build") - cmake_configure_options.append(("Trilinos_ENABLE_DEVELOPMENT_MODE", "OFF")) - error = configure_cmake_build(tarball_cmake_path, - os.path.join(tarball_build_path, trilinosDir), - cmake_configure_options, file("tarball_configure.out", "w")) - - reportError(error, "Configuring from tarball failed, see tarball_configure.out for details.", - "tarball_configure.out", options.verboseErrors) - - tarballMakeInstallCmd = "make install -j " + options.buildProcs - tarballMakeInstallError = run_command(tarballMakeInstallCmd, tarball_cmake_path, - file("tarball_make_install.out", "w")) - - reportError(tarballMakeInstallError, - "Make install from the tarball failed, see tarball_make_install.out for details.", - "tarball_make_install.out", options.verboseErrors) - - if options.doDashboardBuild: - makeExperimentalBuildCmd = "make dashboard -j " + options.buildProcs - makeExperimentalBuildError = run_command(makeExperimentalBuildCmd, tarball_cmake_path, - file("tarball_make_experimental.out", "w")) - - reportError(makeExperimentalBuildError, - "Make experimental from the tarball failed, " + - "see tarball_make_experimental.out for details.", - "tarball_make_experimental.out", options.verboseErrors) - - print "Installation from a tarball completed successfully." - -if __name__ == '__main__': - options, args = get_options(os.getcwd()) - main(DEFAULT_ENABLE_DISABLE_LIST, options) diff --git a/cmake/ctest/drivers/trilinos-test2/valgrind_suppressions_trilinos-test2_gcc-4.1.2.txt b/cmake/ctest/drivers/trilinos-test2/valgrind_suppressions_trilinos-test2_gcc-4.1.2.txt deleted file mode 100644 index b28b04f64312..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/valgrind_suppressions_trilinos-test2_gcc-4.1.2.txt +++ /dev/null @@ -1,3 +0,0 @@ - - - diff --git a/cmake/ctest/drivers/trilinos-test2/valgrind_suppressions_trilinos-test2_openmpi_1.2.7.txt b/cmake/ctest/drivers/trilinos-test2/valgrind_suppressions_trilinos-test2_openmpi_1.2.7.txt deleted file mode 100644 index f035ef524389..000000000000 --- a/cmake/ctest/drivers/trilinos-test2/valgrind_suppressions_trilinos-test2_openmpi_1.2.7.txt +++ /dev/null @@ -1,133 +0,0 @@ -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send - fun:orte_iof_proxy_svc_publish - fun:orte_iof_proxy_publish - fun:orte_iof_base_setup_parent - fun:orte_odls_default_launch_local_procs - obj:/usr/lib64/openmpi/1.2.7-gcc/bin/orted - fun:orte_gpr_proxy_deliver_notify_msg - fun:orte_gpr_proxy_notify_recv - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 -} - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - fun:_orte_iof_base_frag_ack - fun:orte_iof_base_endpoint_forward - fun:orte_iof_svc_proxy_recv - fun:mca_oob_tcp_msg_recv_complete - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/openmpi/mca_oob_tcp.so - fun:opal_event_base_loop - fun:opal_progress - obj:/usr/lib64/openmpi/1.2.7-gcc/bin/orterun -} - -{ - - Memcheck:Cond - fun:__strcpy_chk - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libmpi.so.0.0.0 - fun:orte_gpr_proxy_deliver_notify_msg - fun:mca_oob_xcast - fun:ompi_mpi_init - fun:PMPI_Init - fun:_ZN7Teuchos16GlobalMPISessionC1EPiPPPcPSo - fun:main -} - -{ - - Memcheck:Cond - fun:__strcpy_chk - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libmpi.so.0.0.0 - fun:orte_gpr_proxy_deliver_notify_msg - fun:mca_oob_xcast - fun:ompi_mpi_init - fun:PMPI_Init - fun:main -} - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - fun:orte_iof_svc_sub_forward - fun:orte_iof_svc_proxy_recv - fun:mca_oob_tcp_msg_recv_complete - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/openmpi/mca_oob_tcp.so - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 - fun:opal_event_base_loop - fun:opal_progress - obj:/usr/lib64/openmpi/1.2.7-gcc/bin/orterun -} - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 - fun:opal_event_base_loop - fun:opal_progress - fun:mca_oob_tcp_msg_wait - fun:mca_oob_tcp_recv - fun:mca_oob_recv_packed - fun:orte_gpr_proxy_exec_compound_cmd - fun:orte_odls_base_report_spawn -} - - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - fun:orte_iof_svc_sub_forward - fun:orte_iof_svc_proxy_recv - fun:mca_oob_tcp_msg_recv_complete - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/openmpi/mca_oob_tcp.so - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 - fun:opal_event_base_loop - fun:opal_progress - obj:/usr/lib64/openmpi/1.2.7-gcc/bin/orterun -} - -{ - - Memcheck:Param - writev(vector[...]) - fun:writev - fun:mca_oob_tcp_msg_send_handler - fun:mca_oob_tcp_peer_send - fun:mca_oob_tcp_send_nb - obj:/usr/lib64/openmpi/1.2.7-gcc/lib/libopen-rte.so.0.0.0 - fun:opal_event_base_loop - fun:opal_progress - fun:mca_oob_tcp_msg_wait - fun:mca_oob_tcp_recv - fun:mca_oob_recv_packed - fun:orte_gpr_proxy_exec_compound_cmd - fun:orte_odls_base_report_spawn -} diff --git a/cmake/ctest/drivers/windows/README.md b/cmake/ctest/drivers/windows/README.md deleted file mode 100644 index 01ba0283dfb6..000000000000 --- a/cmake/ctest/drivers/windows/README.md +++ /dev/null @@ -1,126 +0,0 @@ -# Required Software -The following list of software is required by the Windows build scripts. The build scripts -assume this software will be installed in specific locations, so before installing it would -be worthwhile to browse the scripts for these locations. Alternatively, you could download -and install the software wherever you want - just be sure to copy and update the build scripts -with the correct locations. - -**[CMake][1]** - required to setup the build configuration. (Tested using version 3.8.1, later upgraded to 3.12.0) - -**[Ninja][2]** - required to parallelize the build on Windows. (Tested using version 1.7.2) - -**[Visual Studio 2015][3]** - required to build packages. - -**[Microsoft MPI][4]** - required to create MPI builds of packages. (Tested using version 8.1.12438.1084) - -**Perl** - required by some packages for testing. (Tested using [Strawberry Perl][5] version 5.24.1.1) - -**[Git][6]** - required for the scripts to update source code. - -**CLAPACK** - required TPL dependency for some packages (Tested using version 3.2.1). Note that if a -pre-built version is not available, you must [build it from source code][7]. - -[1]: https://cmake.org/download/ -[2]: https://ninja-build.org/ -[3]: https://www.visualstudio.com/ -[4]: https://msdn.microsoft.com/en-us/library/bb524831(v=vs.85).aspx -[5]: http://strawberryperl.com/ -[6]: https://git-scm.com/ -[7]: http://icl.cs.utk.edu/lapack-for-windows/clapack/ - - -# Script Usage -There are two scripts intended for the typical user - *task_driver_windows.bat* and -*create_windows_package.bat*. For details about additional scripts, please refer to the -[Script File Summary](#Script-File-Summary) section below. - -##### task_driver_windows.bat -This script builds and tests Trilinos packages for both Debug and Release configurations, -following the Trilinos package-by-package testing paradigm. The packages are built as static -libraries, and the results are submitted to [CDash][8]. This script may be launched from -the command-line as is, without any additional arguments. - -##### create_windows_package.bat -This script creates a ZIP package of static libraries and header files from the set of Trilinos -packages specified in the script. The expected syntax to use the script is: - -`create_windows_package.bat ` - -where `` specifies the build configuration (Release or Debug) and -`` specifies a root working directory where the script will clone/update -the Trilinos repository as a sub-directory, create a build sub-directory to do the actual build, -and place resulting output files and ZIP package. For example, - -``` -create_windows_package.bat Debug C:\path\to\DebugPackageDir -``` - -would create a Debug build of static libraries, and at the end of the script the base directory -would have the following contents: - -``` -C:\path\to\DebugPackageDir - - build (Build directory) - - Trilinos (Source code directory) - - update_output.txt (Output from the Git update step) - - configure_output.txt (Output from the Configure step) - - build_output.txt (Output from the build step) - - package_output.txt (Output from the package step) - - trilinos-setup-12.3.zip (Resulting ZIP package) -``` - -[8]: https://testing.sandia.gov/cdash - - -# Script File Summary -##### TrilinosCTestDriverCore.windows.msvc.cmake -CMake script that sets the options common to both the Debug and Release configurations of a -Trilinos build on Windows using Visual Studio, including the specific Trilinos packages to be -built. This script follows the Trilinos package-by-package testing paradigm. This script -assumes specific build tools exist (e.g., Ninja, MSVC14, MPI, etc.) and assumes where -they will be located on Windows. - -##### create_windows_package.bat -Windows batch script that creates a ZIP package of static libraries and header files. It -updates or clones the latest version of Trilinos as necessary, sets up a build environment -for MSVC14, configures and runs CMake, then builds the specified Trilinos packages using Ninja -and MSVC. After the build is complete, it creates the ZIP package using CPack. The output -for each step of the process is recorded in individual files (e.g., configure_output.txt, -build_output.txt, etc.) within the specified working directory. - -##### ctest_windows_mpi_debug.cmake -CMake file that sets the build configuration for a Debug build before calling -*TrilinosCTestDriverCore.windows.msvc.cmake*. - -##### ctest_windows_mpi_release.cmake -CMake file that sets the build configuration for a Release build before calling -*TrilinosCTestDriverCore.windows.msvc.cmake* - -##### task_driver_windows.bat -Windows batch script that sets important environment variables before running -*ctest_windows_mpi_debug.cmake* and *ctest_windows_mpi_release.cmake* using CTest. - - -# Notes and Issues -- The scripts assume they are starting from a clean environment. All necessary environment - variables are set by the scripts. - -- When installing Perl on Windows, it likes to insert itself into the system or user PATH - environment variable. This can have unintended consequences when running CMake, the most - notable of which is that CMake will (wrongly) assume certain executables in Perl are part - of the compiler. As a result, CMake won't find the correct MSVC compiler and linker, and - the configure step will fail. If possible, try to keep Perl out of the PATH when using - these scripts, or else modify the PATH before running the scripts to remove Perl. - -- As noted in Trilinos Pull Request [#1197][i1], the /bigobj compiler flag is necessary for - debug builds, and is included in the build scripts. - -- At the time of writing, the Zoltan tests fail on Windows as noted in Trilinos Issue [#1440][i2]. - -- The packages are currently built as static libraries. If shared libraries are desired, an - effort would need to be made to resolve certain build issues. Also, care would need to be - taken to ensure PATHs are setup correctly for the libraries to find each other during the - build and testing. - -[i1]: https://github.com/trilinos/Trilinos/pull/1197 -[i2]: https://github.com/trilinos/Trilinos/issues/1440 diff --git a/cmake/ctest/drivers/windows/TrilinosCTestDriverCore.windows.msvc.cmake b/cmake/ctest/drivers/windows/TrilinosCTestDriverCore.windows.msvc.cmake deleted file mode 100644 index 29fd59858af6..000000000000 --- a/cmake/ctest/drivers/windows/TrilinosCTestDriverCore.windows.msvc.cmake +++ /dev/null @@ -1,55 +0,0 @@ -# Get some variables from the environment. -FILE(TO_CMAKE_PATH "$ENV{GIT_EXE}" GIT_EXE) - -IF(DEFINED ENV{SEMS_DIR}) - FILE(TO_CMAKE_PATH "$ENV{SEMS_DIR}" SEMS_DIR) -ELSE() - SET(SEMS_DIR "C:/projects/sems/install/win-x86_64") -ENDIF() - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET( CTEST_CMAKE_GENERATOR "Ninja" ) - SET( COMPILER_VERSION "MSVC14") - - SET(Trilinos_PACKAGES AztecOO Epetra ML MueLu Pamgen ROL Xpetra Zoltan - Triutils Teuchos Belos EpetraExt Amesos Ifpack TrilinosSS) - - # Blacklist packages - SET(Trilinos_EXCLUDE_PACKAGES Galeri Kokkos Sacado Intrepid Thyra) - FOREACH(PKG ${Trilinos_EXCLUDE_PACKAGES}) - LIST(APPEND EXTRA_SYSTEM_CONFIGURE_OPTIONS "-DTrilinos_ENABLE_${PKG}:BOOL=OFF") - ENDFOREACH() - - # Setup other configure options - LIST(APPEND EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DBUILD_SHARED_LIBS:BOOL=OFF" - "-DTrilinos_ENABLE_TESTS:BOOL=ON" - "-DTrilinos_ENABLE_EXAMPLES:BOOL=OFF" - "-DTrilinos_ENABLE_FORTRAN:BOOL=OFF" - "-DTrilinos_ENABLE_DEBUG:BOOL=OFF" - "-DTrilinos_ENABLE_CXX11:BOOL=ON" - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_GENERATE_REPO_VERSION_FILE:BOOL=OFF" - "-DCMAKE_OBJECT_PATH_MAX=500" - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR:PATH=${SEMS_DIR}/compiler/Microsoft MPI/8.1.12438.1084" - "-DBLAS_LIBRARY_NAMES:STRING=blas\\\;libf2c" - "-DBLAS_LIBRARY_DIRS:STRING=${SEMS_DIR}/tpl/clapack/3.2.1/VisualStudio/14.0/base/lib" - "-DLAPACK_LIBRARY_NAMES:STRING=lapack" - "-DLAPACK_LIBRARY_DIRS:STRING=${SEMS_DIR}/tpl/clapack/3.2.1/VisualStudio/14.0/base/lib" - "-DPERL_EXECUTABLE:FILEPATH=${SEMS_DIR}/compiler/strawberry_perl/5.24.1.1/perl/bin/perl.exe" - "-DTPL_ENABLE_DLlib:BOOL=OFF" - "-DTPL_ENABLE_Pthread:BOOL=OFF") - - TRILINOS_CTEST_DRIVER() -ENDMACRO() diff --git a/cmake/ctest/drivers/windows/create_windows_package.bat b/cmake/ctest/drivers/windows/create_windows_package.bat deleted file mode 100644 index d84b03c2e880..000000000000 --- a/cmake/ctest/drivers/windows/create_windows_package.bat +++ /dev/null @@ -1,128 +0,0 @@ -@rem Script to generate a Trilinos static-library package on Windows. -@rem Expected syntax to use the script is: - -@rem create_windows_package.bat - -@rem is either Debug or Release. -@rem is the root directory where the script will clone -@rem Trilinos, create a build directory, do the build, create a package, etc. - -setlocal - -rem Set the location of Git, Ninja, etc. -set SEMS_DIR=C:\projects\sems\install\win-x86_64 -set NINJA_DIR=%SEMS_DIR%\utility\ninja\1.7.2 -set CMAKE_DIR=%SEMS_DIR%\utility\cmake\3.12.0\bin -set GIT_EXE=%SEMS_DIR%\utility\git\2.13.0\cmd\git.exe -set PATH=%NINJA_DIR%;%PATH% - -rem Get the script arguments -set BUILD_TYPE=%~1 -set BASE_DIR=%~2 - -rem Setup directories -set BUILD_DIR="%BASE_DIR%\build" -set INSTALL_DIR="%BASE_DIR%\install" -set TRILINOS_DIR="%BASE_DIR%\Trilinos" - -rem Cleanup old files in the base directory -if not exist "%BASE_DIR%" mkdir "%BASE_DIR%" -del /q "%BASE_DIR%" - -rem Cleanup the old build directory -if exist %BUILD_DIR% rmdir /s /q %BUILD_DIR% -mkdir %BUILD_DIR% - -rem Cleanup the old install directory. -@rem Note: The install directory seems to be a necessary part of the -@rem cpack process for Trilinos, which is why we clean it up here and -@rem specify CMAKE_INSTALL_PREFIX in the configure step below. -if exist %INSTALL_DIR% rmdir /s /q %INSTALL_DIR% - -rem Clone or update Trilinos -> "%BASE_DIR%\update_output.txt" 2>&1 ( - - if exist %TRILINOS_DIR% ( - cd %TRILINOS_DIR% - %GIT_EXE% pull - ) else ( - %GIT_EXE% clone git@github.com:trilinos/Trilinos.git %TRILINOS_DIR% - cd %TRILINOS_DIR% - %GIT_EXE% checkout develop - ) - -) - -rem Add the /bigobj compiler flag to get the debug build to work properly. -rem As this flag doesn't hurt the release build, we don't bother checking the build type. -set CL=/bigobj - -rem Setup the build environment before running CMake (this will help CMake find the right compilers) -cd %BUILD_DIR% -call "%SEMS_DIR%\compiler\VisualStudio\14.0\VC\vcvarsall.bat" amd64 - -rem Configure using CMake -> "%BASE_DIR%\configure_output.txt" 2>&1 ( - - %CMAKE_DIR%\cmake.exe -G "Ninja" ^ - -D CMAKE_BUILD_TYPE:STRING=%BUILD_TYPE% ^ - -D CMAKE_INSTALL_PREFIX:PATH=%INSTALL_DIR% ^ - -D BUILD_SHARED_LIBS:BOOL=OFF ^ - -D Trilinos_ENABLE_CXX11:BOOL=ON ^ - -D Trilinos_ENABLE_TESTS:BOOL=OFF ^ - -D Trilinos_ENABLE_EXAMPLES:BOOL=OFF ^ - -D Trilinos_ENABLE_FORTRAN:BOOL=OFF ^ - -D Trilinos_ENABLE_DEBUG:BOOL=OFF ^ - -D Trilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON ^ - -D Trilinos_GENERATE_REPO_VERSION_FILE:BOOL=OFF ^ - -D CMAKE_OBJECT_PATH_MAX=500 ^ - -D BLAS_LIBRARY_NAMES:STRING="blas;libf2c" ^ - -D BLAS_LIBRARY_DIRS:STRING="%SEMS_DIR%\tpl\clapack\3.2.1\VisualStudio\14.0\base\lib" ^ - -D LAPACK_LIBRARY_NAMES:STRING="lapack" ^ - -D LAPACK_LIBRARY_DIRS:STRING="%SEMS_DIR%\tpl\clapack\3.2.1\VisualStudio\14.0\base\lib" ^ - -D TPL_ENABLE_MPI:BOOL=ON ^ - -D MPI_BASE_DIR:PATH="%SEMS_DIR%\compiler\Microsoft MPI\8.1.12438.1084" ^ - -D PERL_EXECUTABLE:FILEPATH="%SEMS_DIR%\compiler\strawberry_perl\5.24.1.1\perl\bin\perl.exe" ^ - -D TPL_ENABLE_DLlib:BOOL=OFF ^ - -D TPL_ENABLE_Pthread:BOOL=OFF ^ - -D Trilinos_ENABLE_AztecOO:BOOL=ON ^ - -D Trilinos_ENABLE_Epetra:BOOL=ON ^ - -D Trilinos_ENABLE_ML:BOOL=ON ^ - -D Trilinos_ENABLE_MueLu:BOOL=ON ^ - -D Trilinos_ENABLE_Pamgen:BOOL=ON ^ - -D Trilinos_ENABLE_ROL:BOOL=ON ^ - -D Trilinos_ENABLE_Xpetra:BOOL=ON ^ - -D Trilinos_ENABLE_Zoltan:BOOL=ON ^ - -D Trilinos_ENABLE_Triutils:BOOL=ON ^ - -D Trilinos_ENABLE_Teuchos:BOOL=ON ^ - -D Trilinos_ENABLE_Belos:BOOL=ON ^ - -D Trilinos_ENABLE_EpetraExt:BOOL=ON ^ - -D Trilinos_ENABLE_Amesos:BOOL=ON ^ - -D Trilinos_ENABLE_Ifpack:BOOL=ON ^ - -D Trilinos_ENABLE_TrilinosSS:BOOL=ON ^ - -D Trilinos_ENABLE_Galeri:BOOL=OFF ^ - -D Trilinos_ENABLE_Kokkos:BOOL=OFF ^ - -D Trilinos_ENABLE_Sacado:BOOL=OFF ^ - -D Trilinos_ENABLE_Intrepid:BOOL=OFF ^ - -D Trilinos_ENABLE_Thyra:BOOL=OFF ^ - %TRILINOS_DIR% - -) - -rem Build using Ninja -> "%BASE_DIR%\build_output.txt" 2>&1 ( - - ninja.exe - -) - -rem Package it all up -> "%BASE_DIR%\package_output.txt" 2>&1 ( - - %CMAKE_DIR%\cpack.exe -G ZIP - - rem Copy the generated zip file elsewhere - copy *.zip "%BASE_DIR%" -) - -endlocal diff --git a/cmake/ctest/drivers/windows/ctest_windows_mpi_debug.cmake b/cmake/ctest/drivers/windows/ctest_windows_mpi_debug.cmake deleted file mode 100644 index 3d1d0f050e67..000000000000 --- a/cmake/ctest/drivers/windows/ctest_windows_mpi_debug.cmake +++ /dev/null @@ -1,9 +0,0 @@ - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.windows.msvc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE Debug) -SET(BUILD_DIR_NAME "${COMM_TYPE}_${BUILD_TYPE}_${Trilinos_VERSION}") - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/windows/ctest_windows_mpi_release.cmake b/cmake/ctest/drivers/windows/ctest_windows_mpi_release.cmake deleted file mode 100644 index 3c6ed31675a6..000000000000 --- a/cmake/ctest/drivers/windows/ctest_windows_mpi_release.cmake +++ /dev/null @@ -1,9 +0,0 @@ - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.windows.msvc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE Release) -SET(BUILD_DIR_NAME "${COMM_TYPE}_${BUILD_TYPE}_${Trilinos_VERSION}") - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/windows/task_driver_windows.bat b/cmake/ctest/drivers/windows/task_driver_windows.bat deleted file mode 100644 index 6f1e2c5b4b6c..000000000000 --- a/cmake/ctest/drivers/windows/task_driver_windows.bat +++ /dev/null @@ -1,27 +0,0 @@ -rem Driver script for dashboards on trilinos-win1 - -setlocal - -rem Set the location of Git, Ninja, etc. -set SEMS_DIR=C:\projects\sems\install\win-x86_64 -set NINJA_DIR=%SEMS_DIR%\utility\ninja\1.7.2 -set CTEST_EXE=%SEMS_DIR%\utility\cmake\3.12.0\bin\ctest.exe -set GIT_EXE=%SEMS_DIR%\utility\git\2.13.0\cmd\git.exe -set PATH=%NINJA_DIR%;%PATH% -set TRILINOS_REPOSITORY_LOCATION=https://gitlab-ex.sandia.gov/trilinos-project/Trilinos.git - -set BASEDIR=%~1 -cd %BASEDIR% - -set SCRIPT_DIR=%BASEDIR%\Trilinos\cmake\ctest\drivers\windows - -call %SEMS_DIR%\compiler\VisualStudio\14.0\VC\vcvarsall.bat amd64 - -rem Run the release build and tests -call %CTEST_EXE% -S "%SCRIPT_DIR%\ctest_windows_mpi_release.cmake" -VV > "%BASEDIR%\ctest_msvc_mpi_windows_release.out" 2>&1 - -rem Add the /bigobj compiler flag to get the debug build to work properly. Then run the debug build and tests. -set CL=/bigobj -call %CTEST_EXE% -S "%SCRIPT_DIR%\ctest_windows_mpi_debug.cmake" -VV > "%BASEDIR%\ctest_msvc_mpi_windows_debug.out" 2>&1 - -endlocal diff --git a/cmake/ctest/drivers/zan/CMakeLists.txt b/cmake/ctest/drivers/zan/CMakeLists.txt deleted file mode 100644 index 2de56f49120f..000000000000 --- a/cmake/ctest/drivers/zan/CMakeLists.txt +++ /dev/null @@ -1,71 +0,0 @@ -INCLUDE("../../../../Version.cmake") - -TRILINOS_DRIVER_SETUP() - -set(CTEST_EXE "${CMAKE_CTEST_COMMAND}") -set(workingdir "${TrilinosDriver_BINARY_DIR}") - -# Get the day of the week -execute_process(COMMAND date +%A OUTPUT_VARIABLE DAYOFWEEK) - -IF(${Trilinos_REPOSITORY_BRANCH} STREQUAL "master") - - -TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_OPT_DEV - ctest_linux_nightly_mpi_development_opt_zan.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 300 -) - -TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_DEBUG_DEV - ctest_linux_nightly_serial_development_debug_zan.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 360 -) - -#TRILINOS_DRIVER_ADD_DASHBOARD( -# SERIAL_DEBUG_ICPC -# ctest_linux_nightly_serial_debug_icpc_zan.cmake -# CTEST_INSTALLER_TYPE release -# RUN_SERIAL -# TIMEOUT_MINUTES 540 -#) - -#Only run these builds once a week -if(${DAYOFWEEK} MATCHES "Saturday") -TRILINOS_DRIVER_ADD_DASHBOARD( - MPI_DEBUG_ICPC - ctest_linux_nightly_mpi_debug_icpc_zan.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 300 -) -endif() - -if(${DAYOFWEEK} MATCHES "Sunday") -TRILINOS_DRIVER_ADD_DASHBOARD( - SERIAL_OPT_ICPC - ctest_linux_nightly_serial_opt_icpc_zan.cmake - CTEST_INSTALLER_TYPE release - RUN_SERIAL - TIMEOUT_MINUTES 240 -) -endif() - -ELSE() - -#TRILINOS_DRIVER_ADD_DASHBOARD( -# SERIAL_OPT_RELEASE_ICPC -# ctest_linux_nightly_serial_opt_release_icpc_zan.cmake -# CTEST_INSTALLER_TYPE release -# RUN_SERIAL -# TIMEOUT_MINUTES 240 -#) - -ENDIF() - -TRILINOS_ADD_REQUIRED_CMAKE_INSTALLS() diff --git a/cmake/ctest/drivers/zan/TrilinosCTestDriverCore.zan.gcc.cmake b/cmake/ctest/drivers/zan/TrilinosCTestDriverCore.zan.gcc.cmake deleted file mode 100644 index 6379bfee00cd..000000000000 --- a/cmake/ctest/drivers/zan/TrilinosCTestDriverCore.zan.gcc.cmake +++ /dev/null @@ -1,126 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for zan using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_BUILD_FLAGS "-j6 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "6" ) - - SET( CTEST_COVERAGE_COMMAND /usr/bin/gcov ) - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} PyTrilinos TriKota Optika Panzer Kokkos Tpetra Muelu) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_VERBOSE_MAKEFILE:BOOL=TRUE" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DSuperLU_INCLUDE_DIRS:PATH=/home/trilinos/tpl/gcc4.4.4/SuperLU_4.3/SRC" - "-DSuperLU_LIBRARY_DIRS:PATH=/home/trilinos/tpl/gcc4.4.4/SuperLU_4.3/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu_4.3" - "-DTPL_ENABLE_Matio=OFF" - "-DTPL_ENABLE_SuperLU=ON" - "-DTPL_ENABLE_BinUtils=ON" - "-DTPL_ENABLE_GLM=OFF" - "-DIntrepid_ENABLE_DEBUG_INF_CHECK=OFF" - ) - - IF (BUILD_TYPE STREQUAL "DEBUG") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTrilinos_ENABLE_DEBUG:BOOL=ON" - ) - ENDIF() - - SET_DEFAULT(COMPILER_VERSION "GCC-4.4.4") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - ) - -# ELSE() - - # 2009/09/02: rabartl: Let CMake pick its own compilers (fixes Intrepid problem) ... - #SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - # ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - # "-DCMAKE_CXX_COMPILER:FILEPATH=/usr/bin/g++" - # "-DCMAKE_C_COMPILER:FILEPATH=/usr/bin/gcc" - # "-DCMAKE_Fortran_COMPILER:FILEPATH=/usr/bin/f77" - # ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/zan/TrilinosCTestDriverCore.zan.icpc.cmake b/cmake/ctest/drivers/zan/TrilinosCTestDriverCore.zan.icpc.cmake deleted file mode 100644 index 4bf992319ccc..000000000000 --- a/cmake/ctest/drivers/zan/TrilinosCTestDriverCore.zan.icpc.cmake +++ /dev/null @@ -1,124 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../TrilinosCTestDriverCore.cmake") - -# -# Platform/compiler specific options for godel using gcc -# - -MACRO(TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER) - - # Base of Trilinos/cmake/ctest then BUILD_DIR_NAME - SET( CTEST_DASHBOARD_ROOT "${TRILINOS_CMAKE_DIR}/../../${BUILD_DIR_NAME}" ) - - SET( CTEST_NOTES_FILES "${CTEST_SCRIPT_DIRECTORY}/${CTEST_SCRIPT_NAME}" ) - - SET_DEFAULT( CTEST_BUILD_FLAGS "-j6 -i" ) - - SET_DEFAULT( CTEST_PARALLEL_LEVEL "6" ) - - SET( CTEST_MEMORYCHECK_COMMAND /usr/bin/valgrind ) - #SET( CTEST_MEMORYCHECK_COMMAND_OPTIONS ) - - SET_DEFAULT( Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) - - # Only turn on PyTrilinos for shared libraries - SET_DEFAULT( Trilinos_EXCLUDE_PACKAGES ${EXTRA_EXCLUDE_PACKAGES} PyTrilinos TriKota Optika Ifpack2 Panzer) - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - "-DCMAKE_BUILD_TYPE:STRING=${BUILD_TYPE}" - "-DMEMORYCHECK_COMMAND:FILEPATH=/usr/bin/valgrind" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DCMAKE_LIBRARY_PATH:PATH=/usr/lib64" - "-DTPL_LAPACK_LIBRARIES:STRING=-L/opt/intel/Compiler/11.1/064/mkl/lib/em64t -lmkl_lapack" - "-DTPL_BLAS_LIBRARIES:STRING=-L/opt/intel/Compiler/11.1/064/mkl/lib/em64t/ -L/opt/intel/Compiler/11.1/064/lib/intel64 -lmkl_intel_lp64 -lmkl_intel_thread -lmkl_core -liomp5 -lpthread" - "-DSuperLU_INCLUDE_DIRS:PATH=/home/trilinos/tpl/intel/SuperLU_4.3/SRC" - "-DSuperLU_LIBRARY_DIRS:PATH=/home/trilinos/tpl/intel/SuperLU_4.3/lib" - "-DSuperLU_LIBRARY_NAMES:STRING=superlu_4.3" - "-DTPL_ENABLE_Matio=OFF" - "-DTPL_ENABLE_SuperLU=ON" - "-DTPL_ENABLE_GLM=OFF" - "-DIntrepid_ENABLE_DEBUG_INF_CHECK=OFF" - ) - - SET_DEFAULT(COMPILER_VERSION "ICPC-11.1.064") - - IF (COMM_TYPE STREQUAL MPI) - SET(TPL_ENABLE_MPI ON) - - #MESSAGE(FATAL_ERROR "Error, Intel build does not support MPI yet!") - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DTPL_ENABLE_MPI:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/home/jmwille/install/openmpi-icc11" - ) - - ELSE() - - SET( EXTRA_SYSTEM_CONFIGURE_OPTIONS - ${EXTRA_SYSTEM_CONFIGURE_OPTIONS} - "-DCMAKE_C_COMPILER:FILEPATH=/opt/intel/Compiler/11.1/064/bin/intel64/icc" - "-DCMAKE_CXX_COMPILER:FILEPATH=/opt/intel/Compiler/11.1/064/bin/intel64/icpc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/opt/intel/Compiler/11.1/064/bin/intel64/ifort" - "-DCMAKE_CXX_FLAGS:STRING=-diag-disable 597" - ) - - ENDIF() - - TRILINOS_CTEST_DRIVER() - -ENDMACRO() diff --git a/cmake/ctest/drivers/zan/cron_driver.sh b/cmake/ctest/drivers/zan/cron_driver.sh deleted file mode 100755 index 505dec5c4d9a..000000000000 --- a/cmake/ctest/drivers/zan/cron_driver.sh +++ /dev/null @@ -1,41 +0,0 @@ -#!/bin/bash - -echo -echo "Starting nightly Trilinos development testing on zan: `date`" -echo - -# TrilinosDriver settings: -# - -export TDD_PARALLEL_LEVEL=1 -export TDD_CTEST_TEST_TYPE=Nightly - -# Trilinos settings: -# - -#export CTEST_TEST_TYPE=Experimental - -#export CTEST_DO_SUBMIT=FALSE - -#export CTEST_START_WITH_EMPTY_BINARY_DIRECTORY=FALSE - -#export Trilinos_PACKAGES=Teuchos - -# Machine specific environment: -# - -export PATH=/usr/kerberos/bin:/opt/intel/11.0.074/bin/intel64:/opt/intel/11.0.074/bin/intel64:/usr/local/bin:/bin:/usr/bin:/usr/local/cuda/bin:/home/jmwille/bin:$PATH - -export LD_LIBRARY_PATH=$LD_LIBRARY_PATH:/opt/intel/11.0.074/ipp/em64t/sharedlib:/opt/intel/11.0.074/mkl/lib/em64t:/opt/intel/11.0.074/tbb/em64t/cc4.1.0_libc2.4_kernel2.6.16.21/lib:/opt/intel/11.0.074/lib/intel64:/opt/intel/11.0.074/ipp/em64t/sharedlib:/opt/intel/11.0.074/mkl/lib/em64t:/opt/intel/11.0.074/tbb/em64t/cc4.1.0_libc2.4_kernel2.6.16.21/lib:/opt/intel/11.0.074/lib/intel64:/home/trilinos/tpl/gcc4.4.4/netcdf-4.2/lib - -#export PYTHONPATH=/Users/jmwille/install/lib/python2.5/site-packages - -# Machine independent cron_driver: -# - -SCRIPT_DIR=`cd "\`dirname \"$0\"\`";pwd` -$SCRIPT_DIR/../cron_driver.py - -echo -echo "Ending nightly Trilinos development testing on zan: `date`" -echo diff --git a/cmake/ctest/drivers/zan/ctest_linux_nightly_cuda_debug_zan.cmake b/cmake/ctest/drivers/zan/ctest_linux_nightly_cuda_debug_zan.cmake deleted file mode 100644 index 5a9fa1f6ce6e..000000000000 --- a/cmake/ctest/drivers/zan/ctest_linux_nightly_cuda_debug_zan.cmake +++ /dev/null @@ -1,91 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.zan.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME CUDA_DEBUG_GCC) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) -SET( CTEST_PARALLEL_LEVEL "1" ) - -SET(Trilinos_PACKAGES Tpetra Kokkos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_ENABLE_DEVELOPMENT_MODE:BOOL=OFF" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_CUDA:BOOL=ON" - "-DTpetraClassic_ENABLE_CUDA_DOUBLE:BOOL=OFF" - "-DTPL_ENABLE_CUSPARSE:BOOL=ON" - "-DTPL_ENABLE_Thrust:BOOL=ON" - "-DTPL_ENABLE_TBB:BOOL=ON" - "-DTBB_LIBRARY_DIRS=/usr/local/tbb30_174oss/lib/intel64/cc4.1.0_libc2.4_kernel2.6.16.21" - "-DTBB_INCLUDE_DIRS=/usr/local/tbb30_174oss/include" - "-DTrilinos_ENABLE_PERFORMANCE_TESTS:BOOL=ON" - "-DTeuchos_ENABLE_COMPLEX:BOOL=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/zan/ctest_linux_nightly_cuda_opt_release_zan.cmake b/cmake/ctest/drivers/zan/ctest_linux_nightly_cuda_opt_release_zan.cmake deleted file mode 100644 index be114df5843f..000000000000 --- a/cmake/ctest/drivers/zan/ctest_linux_nightly_cuda_opt_release_zan.cmake +++ /dev/null @@ -1,94 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.zan.gcc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE OPT) -SET(BUILD_DIR_NAME "CUDA_OPT_RELEASE_GCC_${Trilinos_VERSION}") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) -SET(CTEST_TEST_TYPE Nightly) -SET( CTEST_PARALLEL_LEVEL "1" ) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_PACKAGES Tpetra Kokkos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_ENABLE_DEVELOPMENT_MODE:BOOL=OFF" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_CUDA:BOOL=ON" - "-DTpetraClassic_ENABLE_CUDA_DOUBLE:BOOL=OFF" - "-DTPL_ENABLE_CUSPARSE:BOOL=ON" - "-DTPL_ENABLE_Thrust:BOOL=ON" - "-DTPL_ENABLE_TBB:BOOL=ON" - "-DTBB_LIBRARY_DIRS=/usr/local/tbb30_174oss/lib/intel64/cc4.1.0_libc2.4_kernel2.6.16.21" - "-DTBB_INCLUDE_DIRS=/usr/local/tbb30_174oss/include" - "-DTrilinos_ENABLE_PERFORMANCE_TESTS:BOOL=ON" - "-DTeuchos_ENABLE_COMPLEX:BOOL=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/zan/ctest_linux_nightly_cuda_opt_zan.cmake b/cmake/ctest/drivers/zan/ctest_linux_nightly_cuda_opt_zan.cmake deleted file mode 100644 index 248a36e9020d..000000000000 --- a/cmake/ctest/drivers/zan/ctest_linux_nightly_cuda_opt_zan.cmake +++ /dev/null @@ -1,92 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.zan.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE OPT) -SET(BUILD_DIR_NAME CUDA_OPT_GCC) -SET(CTEST_TEST_TYPE Nightly) -SET( CTEST_BUILD_FLAGS "-j3 -i" ) -SET( CTEST_PARALLEL_LEVEL "1" ) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_PACKAGES Tpetra Kokkos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_ENABLE_DEVELOPMENT_MODE:BOOL=OFF" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTPL_ENABLE_CUDA:BOOL=ON" - "-DTpetraClassic_ENABLE_CUDA_DOUBLE:BOOL=OFF" - "-DTPL_ENABLE_CUSPARSE:BOOL=ON" - "-DTPL_ENABLE_Thrust:BOOL=ON" - "-DTPL_ENABLE_TBB:BOOL=ON" - "-DTBB_LIBRARY_DIRS=/usr/local/tbb30_174oss/lib/intel64/cc4.1.0_libc2.4_kernel2.6.16.21" - "-DTBB_INCLUDE_DIRS=/usr/local/tbb30_174oss/include" - "-DTrilinos_ENABLE_PERFORMANCE_TESTS:BOOL=ON" - "-DTeuchos_ENABLE_COMPLEX:BOOL=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/zan/ctest_linux_nightly_mpi_debug_icpc_zan.cmake b/cmake/ctest/drivers/zan/ctest_linux_nightly_mpi_debug_icpc_zan.cmake deleted file mode 100644 index de26159522c0..000000000000 --- a/cmake/ctest/drivers/zan/ctest_linux_nightly_mpi_debug_icpc_zan.cmake +++ /dev/null @@ -1,84 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.zan.icpc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME MPI_DEBUG_ICPC) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) -SET(ENV{LD_LIBRARY_PATH} "$ENV{LD_LIBRARY_PATH}:/opt/intel/Compiler/11.1/064/lib/intel64:/opt/intel/Compiler/11.1/064/mkl/lib/em64t") - -#SET(Trilinos_PACKAGES Teuchos RTOp Thyra Stratimikos Phalanx Rythmos) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_Fortran:BOOL=ON" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/pnetcdf-4.2/include" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/pnetcdf-4.2/lib" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/phdf5-1.8.6/lib" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/zan/ctest_linux_nightly_mpi_development_opt_zan.cmake b/cmake/ctest/drivers/zan/ctest_linux_nightly_mpi_development_opt_zan.cmake deleted file mode 100644 index 94220eff5817..000000000000 --- a/cmake/ctest/drivers/zan/ctest_linux_nightly_mpi_development_opt_zan.cmake +++ /dev/null @@ -1,89 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.zan.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE MPI) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME MPI_OPT_DEV) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) -SET(EXTRA_EXCLUDE_PACKAGES TriKota) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DMPI_BASE_DIR:PATH=/home/jmwille/install" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DBoost_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.4.4/boost_1_49_0" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/pnetcdf-4.2/include" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/pnetcdf-4.2/lib" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/phdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/phdf5-1.8.6/lib" - "-DTrilinos_ENABLE_CXX11=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/zan/ctest_linux_nightly_serial_debug_icpc_zan.cmake b/cmake/ctest/drivers/zan/ctest_linux_nightly_serial_debug_icpc_zan.cmake deleted file mode 100644 index d01057f4f158..000000000000 --- a/cmake/ctest/drivers/zan/ctest_linux_nightly_serial_debug_icpc_zan.cmake +++ /dev/null @@ -1,93 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.zan.icpc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_ICPC) -SET(CTEST_TEST_TYPE Nightly) -# Intel 11.1 is compatible with GCC 4.2. Make sure that is the one on the PATH. -SET(ENV{PATH} "$ENV{HOME}/compilers/gcc/4.2/bin:$ENV{PATH}") -SET(ENV{LD_LIBRARY_PATH} "$ENV{LD_LIBRARY_PATH}:/opt/intel/Compiler/11.1/064/lib/intel64:/opt/intel/Compiler/11.1/064/mkl/lib/em64t") -#SET(CTEST_TEST_TIMEOUT 900) - -#SET(Trilinos_PACKAGES Teuchos RTOp Thyra Stratimikos Phalanx Rythmos) -SET(EXTRA_EXCLUDE_PACKAGES Sundance Rythmos STK Phalanx Thyra Panzer MueLu) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_Fortran:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DBoost_INCLUDE_DIRS=$ENV{HOME}/tpls/intel/11.1/boost/1.46.1/include" - "-DTrilinos_ENABLE_STK:BOOL=OFF" - "-DTrilinos_ENABLE_MueLu:BOOL=OFF" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/netcdf-4.2/include" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/netcdf-4.2/lib" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/hdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/hdf5-1.8.6/lib" - "-DZoltan2_ENABLE_Experimental=ON" - "-DAmesos2_ENABLE_TESTS=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/zan/ctest_linux_nightly_serial_development_debug_zan.cmake b/cmake/ctest/drivers/zan/ctest_linux_nightly_serial_development_debug_zan.cmake deleted file mode 100644 index 31d21d2eee8c..000000000000 --- a/cmake/ctest/drivers/zan/ctest_linux_nightly_serial_development_debug_zan.cmake +++ /dev/null @@ -1,90 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.zan.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE DEBUG) -SET(BUILD_DIR_NAME SERIAL_DEBUG_DEV) -SET(CTEST_TEST_TYPE Nightly) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) -SET(EXTRA_EXCLUDE_PACKAGES TriKota Zoltan2 Panzer) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DTrilinos_ENABLE_TriKota:BOOL=OFF" - "-DBoost_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.4.4/boost_1_49_0" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/netcdf-4.2/include" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/netcdf-4.2/lib" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/hdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/hdf5-1.8.6/lib" - "-DTrilinos_ENABLE_CXX11=OFF" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/zan/ctest_linux_nightly_serial_development_opt_gcc_4.6.1_zan.cmake b/cmake/ctest/drivers/zan/ctest_linux_nightly_serial_development_opt_gcc_4.6.1_zan.cmake deleted file mode 100644 index 9f7352bbfa60..000000000000 --- a/cmake/ctest/drivers/zan/ctest_linux_nightly_serial_development_opt_gcc_4.6.1_zan.cmake +++ /dev/null @@ -1,95 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.zan.gcc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_OPT_DEV2) -SET(COMPILER_VERSION "GCC-4.6.1") -SET(ENV{LD_LIBRARY_PATH} "/home/jmwille/install/mpc-0.9/lib:/home/jmwille/install/mpfr-2.4.2/lib:/home/jmwille/install/gmp-4.3.2/lib:/home/jmwille/install/gcc-4.6.1/lib64:$ENV{LD_LIBRARY_PATH}") -SET(CTEST_TEST_TYPE EXPERIMENTAL) -#SET(CTEST_TEST_TIMEOUT 900) - -SET(Trilinos_ENABLE_SECONDARY_TESTED_CODE ON) -#Stokhos is explicitly disabled below to prevent the package from being -#implicitly enabled. Sundance depends on Stokhos. -#SET(EXTRA_EXCLUDE_PACKAGES Phalanx Stokhos Sundance Panzer) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_EXPLICIT_INSTANTIATION:BOOL=ON" - "-DTrilinos_DATA_DIR:STRING=$ENV{TRILINOSDATADIRECTORY}" - "-DTPL_ENABLE_Pthread:BOOL=ON" - "-DNOX_ENABLE_ABSTRACT_IMPLEMENTATION_LAPACK=ON" - "-DCMAKE_CXX_COMPILER:FILEPATH=/home/jmwille/install/gcc-4.6.1/bin/g++" - "-DCMAKE_C_COMPILER:FILEPATH=/home/jmwille/install/gcc-4.6./bin/gcc" - "-DCMAKE_Fortran_COMPILER:FILEPATH=/home/jmwille/install/gcc-4.6.1/bin/gfortran" - "-DBoost_INCLUDE_DIRS=/home/trilinos/tpl/gcc4.4.4/boost_1_49_0" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/netcdf-4.2/include" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/netcdf-4.2/lib" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/hdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/hdf5-1.8.6/lib" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/zan/ctest_linux_nightly_serial_opt_icpc_zan.cmake b/cmake/ctest/drivers/zan/ctest_linux_nightly_serial_opt_icpc_zan.cmake deleted file mode 100644 index 26c6536c5b91..000000000000 --- a/cmake/ctest/drivers/zan/ctest_linux_nightly_serial_opt_icpc_zan.cmake +++ /dev/null @@ -1,86 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.zan.icpc.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME SERIAL_RELEASE_ICPC) -SET(CTEST_TEST_TYPE Experimental) -SET(ENV{LD_LIBRARY_PATH} "$ENV{LD_LIBRARY_PATH}:/opt/intel/Compiler/11.1/064/lib/intel64:/opt/intel/Compiler/11.1/064/mkl/lib/em64t") -#SET(CTEST_TEST_TIMEOUT 900) - -#SET(Trilinos_PACKAGES Teuchos RTOp Thyra Stratimikos Phalanx Rythmos) - -SET(EXTRA_EXCLUDE_PACKAGES Panzer) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_Fortran:BOOL=ON" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/netcdf-4.2/include" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/netcdf-4.2/lib" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/hdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/hdf5-1.8.6/lib" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER() diff --git a/cmake/ctest/drivers/zan/ctest_linux_nightly_serial_opt_release_icpc_zan.cmake b/cmake/ctest/drivers/zan/ctest_linux_nightly_serial_opt_release_icpc_zan.cmake deleted file mode 100644 index 8e84c7dee1a3..000000000000 --- a/cmake/ctest/drivers/zan/ctest_linux_nightly_serial_opt_release_icpc_zan.cmake +++ /dev/null @@ -1,88 +0,0 @@ -# @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 - - -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/TrilinosCTestDriverCore.zan.icpc.cmake") -INCLUDE("${CTEST_SCRIPT_DIRECTORY}/../../../../Version.cmake") - -# -# Set the options specific to this build case -# - -SET(COMM_TYPE SERIAL) -SET(BUILD_TYPE RELEASE) -SET(BUILD_DIR_NAME "SERIAL_OPT_RELEASE_ICPC_${Trilinos_VERSION}") -SET(Trilinos_TRACK ${Trilinos_TESTING_TRACK}) -SET(Trilinos_BRANCH ${Trilinos_REPOSITORY_BRANCH}) -SET(CTEST_TEST_TYPE Experimental) -#SET(CTEST_TEST_TIMEOUT 900) - -#SET(Trilinos_PACKAGES Teuchos RTOp Thyra Stratimikos Phalanx Rythmos) -SET(EXTRA_EXCLUDE_PACKAGES Didasko Sundance Piro Rythmos TrilinosCouplings NOX STK Pamgen Thyra Tpetra Zoltan Stokhos FEApp Panzer) - -SET( EXTRA_CONFIGURE_OPTIONS - "-DTrilinos_ENABLE_Fortran:BOOL=ON" - "-DTPL_ENABLE_Boost:BOOL=ON" - "-DNetcdf_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/netcdf-4.2/include" - "-DNetcdf_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/netcdf-4.2/lib" - "-DHDF5_INCLUDE_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/hdf5-1.8.6/include" - "-DHDF5_LIBRARY_DIRS:FILEPATH=/home/trilinos/tpl/gcc4.4.4/hdf5-1.8.6/lib" - ) - -# -# Set the rest of the system-specific options and run the dashboard build/test -# - -TRILINOS_SYSTEM_SPECIFIC_CTEST_DRIVER()