From b00a4ceda5799b7c9809a5eef70b5bd506118de1 Mon Sep 17 00:00:00 2001 From: maier Date: Wed, 27 Feb 2013 23:30:34 +0000 Subject: [PATCH] Big configuration cleanup part1 Rename all variables that are isomorphic to DEAL_II_WITH_. git-svn-id: https://svn.dealii.org/branches/branch_cmake@28626 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/bundled/CMakeLists.txt | 2 +- deal.II/cmake/configure/configure_1_mpi.cmake | 2 - .../cmake/configure/configure_1_threads.cmake | 5 - .../cmake/configure/configure_arpack.cmake | 2 - .../configure/configure_functionparser.cmake | 1 - deal.II/cmake/configure/configure_hdf5.cmake | 2 - .../cmake/configure/configure_lapack.cmake | 1 - deal.II/cmake/configure/configure_metis.cmake | 2 - deal.II/cmake/configure/configure_mumps.cmake | 2 - .../cmake/configure/configure_netcdf.cmake | 2 - deal.II/cmake/configure/configure_p4est.cmake | 2 - deal.II/cmake/configure/configure_petsc.cmake | 6 +- deal.II/cmake/configure/configure_slepc.cmake | 2 - .../cmake/configure/configure_trilinos.cmake | 6 +- .../cmake/configure/configure_umfpack.cmake | 4 - deal.II/cmake/configure/configure_zlib.cmake | 2 - deal.II/cmake/scripts/report_features.cc | 36 ++-- deal.II/doc/doxygen/options.dox.in | 14 +- deal.II/doc/news/3.4.0-vs-4.0.0.html | 8 +- deal.II/doc/news/6.1.0-vs-6.2.0.h | 2 +- deal.II/examples/step-48/step-48.cc | 6 +- deal.II/include/deal.II/base/config.h.in | 163 ++++-------------- deal.II/include/deal.II/base/exceptions.h | 4 +- deal.II/include/deal.II/base/index_set.h | 6 +- deal.II/include/deal.II/base/mpi.h | 16 +- deal.II/include/deal.II/base/parallel.h | 20 +-- .../deal.II/base/thread_local_storage.h | 6 +- .../include/deal.II/base/thread_management.h | 10 +- deal.II/include/deal.II/base/timer.h | 10 +- deal.II/include/deal.II/base/utilities.h | 6 +- deal.II/include/deal.II/base/work_stream.h | 8 +- deal.II/include/deal.II/distributed/tria.h | 10 +- deal.II/include/deal.II/fe/fe_values.h | 2 +- .../deal.II/grid/tria_accessor.templates.h | 6 +- .../deal.II/lac/block_sparsity_pattern.h | 4 +- deal.II/include/deal.II/lac/block_vector.h | 6 +- .../deal.II/lac/block_vector.templates.h | 4 +- deal.II/include/deal.II/lac/parallel_vector.h | 2 +- .../deal.II/lac/parallel_vector.templates.h | 16 +- .../deal.II/lac/petsc_block_sparse_matrix.h | 4 +- .../include/deal.II/lac/petsc_block_vector.h | 4 +- .../include/deal.II/lac/petsc_full_matrix.h | 4 +- .../include/deal.II/lac/petsc_matrix_base.h | 4 +- .../include/deal.II/lac/petsc_matrix_free.h | 4 +- .../lac/petsc_parallel_block_sparse_matrix.h | 4 +- .../deal.II/lac/petsc_parallel_block_vector.h | 4 +- .../lac/petsc_parallel_sparse_matrix.h | 4 +- .../deal.II/lac/petsc_parallel_vector.h | 4 +- .../include/deal.II/lac/petsc_precondition.h | 4 +- deal.II/include/deal.II/lac/petsc_solver.h | 4 +- .../include/deal.II/lac/petsc_sparse_matrix.h | 4 +- deal.II/include/deal.II/lac/petsc_vector.h | 4 +- .../include/deal.II/lac/petsc_vector_base.h | 4 +- deal.II/include/deal.II/lac/slepc_solver.h | 4 +- .../lac/slepc_spectral_transformation.h | 4 +- deal.II/include/deal.II/lac/sparse_direct.h | 6 +- .../deal.II/lac/sparse_vanka.templates.h | 4 +- deal.II/include/deal.II/lac/sparsity_tools.h | 4 +- .../deal.II/lac/swappable_vector.templates.h | 4 +- .../lac/trilinos_block_sparse_matrix.h | 4 +- .../deal.II/lac/trilinos_block_vector.h | 4 +- .../lac/trilinos_parallel_block_vector.h | 4 +- .../deal.II/lac/trilinos_precondition.h | 8 +- deal.II/include/deal.II/lac/trilinos_solver.h | 4 +- .../deal.II/lac/trilinos_sparse_matrix.h | 6 +- .../deal.II/lac/trilinos_sparsity_pattern.h | 6 +- deal.II/include/deal.II/lac/trilinos_vector.h | 6 +- .../deal.II/lac/trilinos_vector_base.h | 8 +- deal.II/include/deal.II/lac/vector.h | 12 +- .../include/deal.II/lac/vector.templates.h | 14 +- .../matrix_free/mapping_info.templates.h | 4 +- .../include/deal.II/matrix_free/matrix_free.h | 8 +- .../matrix_free/matrix_free.templates.h | 8 +- .../include/deal.II/multigrid/mg_transfer.h | 2 +- .../deal.II/multigrid/mg_transfer.templates.h | 4 +- .../include/deal.II/numerics/matrix_tools.h | 8 +- .../deal.II/numerics/vector_tools.templates.h | 2 +- deal.II/source/base/data_out_base.cc | 62 +++---- deal.II/source/base/function_parser.cc | 4 +- deal.II/source/base/index_set.cc | 10 +- deal.II/source/base/logstream.cc | 2 +- deal.II/source/base/mpi.cc | 28 +-- deal.II/source/base/multithread_info.cc | 2 +- deal.II/source/base/partitioner.cc | 2 +- deal.II/source/base/subscriptor.cc | 6 +- deal.II/source/base/thread_management.cc | 2 +- deal.II/source/base/timer.cc | 14 +- deal.II/source/base/utilities.cc | 16 +- deal.II/source/distributed/grid_refinement.cc | 2 +- .../source/distributed/solution_transfer.cc | 2 +- .../distributed/solution_transfer.inst.in | 4 +- deal.II/source/distributed/tria.cc | 10 +- deal.II/source/distributed/tria.inst.in | 4 +- deal.II/source/dofs/dof_handler_policy.cc | 18 +- deal.II/source/dofs/dof_renumbering.cc | 6 +- deal.II/source/dofs/dof_tools.cc | 10 +- deal.II/source/fe/fe_tools.cc | 10 +- deal.II/source/fe/fe_tools.inst.in | 6 +- deal.II/source/fe/mapping_q1_eulerian.inst.in | 2 +- deal.II/source/fe/mapping_q_eulerian.inst.in | 2 +- deal.II/source/grid/grid_in.cc | 6 +- deal.II/source/grid/grid_refinement.cc | 4 +- deal.II/source/grid/grid_tools.cc | 4 +- deal.II/source/lac/block_sparsity_pattern.cc | 4 +- deal.II/source/lac/constraint_matrix.cc | 22 +-- .../source/lac/petsc_block_sparse_matrix.cc | 2 +- deal.II/source/lac/petsc_full_matrix.cc | 4 +- deal.II/source/lac/petsc_matrix_base.cc | 4 +- deal.II/source/lac/petsc_matrix_free.cc | 4 +- .../lac/petsc_parallel_block_sparse_matrix.cc | 2 +- .../source/lac/petsc_parallel_block_vector.cc | 4 +- .../lac/petsc_parallel_sparse_matrix.cc | 4 +- deal.II/source/lac/petsc_parallel_vector.cc | 4 +- deal.II/source/lac/petsc_precondition.cc | 4 +- deal.II/source/lac/petsc_solver.cc | 4 +- deal.II/source/lac/petsc_sparse_matrix.cc | 4 +- deal.II/source/lac/petsc_vector.cc | 4 +- deal.II/source/lac/petsc_vector_base.cc | 4 +- deal.II/source/lac/slepc_solver.cc | 4 +- .../lac/slepc_spectral_transformation.cc | 4 +- deal.II/source/lac/solver.cc | 2 +- deal.II/source/lac/sparse_direct.cc | 10 +- deal.II/source/lac/sparsity_tools.cc | 10 +- deal.II/source/lac/tridiagonal_matrix.cc | 2 +- .../lac/trilinos_block_sparse_matrix.cc | 4 +- deal.II/source/lac/trilinos_block_vector.cc | 2 +- deal.II/source/lac/trilinos_precondition.cc | 10 +- deal.II/source/lac/trilinos_solver.cc | 4 +- deal.II/source/lac/trilinos_sparse_matrix.cc | 4 +- .../source/lac/trilinos_sparsity_pattern.cc | 4 +- deal.II/source/lac/trilinos_vector.cc | 8 +- deal.II/source/lac/trilinos_vector_base.cc | 12 +- .../multigrid/mg_transfer_prebuilt.inst.in | 2 +- .../numerics/derivative_approximation.inst.in | 4 +- deal.II/source/numerics/error_estimator.cc | 4 +- .../source/numerics/error_estimator.inst.in | 4 +- deal.II/source/numerics/matrix_tools.cc | 8 +- deal.II/source/numerics/time_dependent.cc | 2 +- 138 files changed, 444 insertions(+), 574 deletions(-) diff --git a/deal.II/bundled/CMakeLists.txt b/deal.II/bundled/CMakeLists.txt index d5b039c48e..6d57658807 100644 --- a/deal.II/bundled/CMakeLists.txt +++ b/deal.II/bundled/CMakeLists.txt @@ -36,7 +36,7 @@ IF(FEATURE_BOOST_BUNDLED_CONFIGURED) ADD_SUBDIRECTORY(${BOOST_FOLDER}/libs/serialization/src) - IF( DEAL_II_USE_MT AND NOT DEAL_II_CAN_USE_CXX11) + IF( DEAL_II_WITH_THREADS AND NOT DEAL_II_CAN_USE_CXX11) # # If the C++ compiler doesn't completely support the C++11 standard # (and consequently we can't use std::thread, std::mutex, etc), then diff --git a/deal.II/cmake/configure/configure_1_mpi.cmake b/deal.II/cmake/configure/configure_1_mpi.cmake index 1859962f69..75def06523 100644 --- a/deal.II/cmake/configure/configure_1_mpi.cmake +++ b/deal.II/cmake/configure/configure_1_mpi.cmake @@ -52,8 +52,6 @@ MACRO(FEATURE_MPI_CONFIGURE_EXTERNAL var) SET(CMAKE_CXX_COMPILER ${MPI_CXX_COMPILER}) ENDIF() - SET(DEAL_II_COMPILER_SUPPORTS_MPI TRUE) - SET(${var} TRUE) ENDMACRO() diff --git a/deal.II/cmake/configure/configure_1_threads.cmake b/deal.II/cmake/configure/configure_1_threads.cmake index 9aad0ffdaa..a2f26aee98 100644 --- a/deal.II/cmake/configure/configure_1_threads.cmake +++ b/deal.II/cmake/configure/configure_1_threads.cmake @@ -32,11 +32,6 @@ MACRO(SETUP_THREADING var) ) SET(${var} TRUE) - # - # We support threading. Go on and configure the rest: - # - SET(DEAL_II_USE_MT TRUE) - # # Change -lphtread to -pthread for better compatibility on non linux # platforms: diff --git a/deal.II/cmake/configure/configure_arpack.cmake b/deal.II/cmake/configure/configure_arpack.cmake index 70a427f778..f7d3226077 100644 --- a/deal.II/cmake/configure/configure_arpack.cmake +++ b/deal.II/cmake/configure/configure_arpack.cmake @@ -21,8 +21,6 @@ MACRO(FEATURE_ARPACK_CONFIGURE_EXTERNAL var) LIST(APPEND DEAL_II_EXTERNAL_LIBRARIES ${ARPACK_LIBRARIES}) ADD_FLAGS(CMAKE_SHARED_LINKER_FLAGS "${ARPACK_LINKER_FLAGS}") - SET(DEAL_II_USE_ARPACK TRUE) - SET(${var} TRUE) ENDMACRO() diff --git a/deal.II/cmake/configure/configure_functionparser.cmake b/deal.II/cmake/configure/configure_functionparser.cmake index 3276db0b30..7facec4607 100644 --- a/deal.II/cmake/configure/configure_functionparser.cmake +++ b/deal.II/cmake/configure/configure_functionparser.cmake @@ -29,7 +29,6 @@ ENDMACRO() MACRO(FEATURE_FUNCTIONPARSER_CONFIGURE_BUNDLED var) INCLUDE_DIRECTORIES(${FUNCTIONPARSER_FOLDER}) - SET(HAVE_FUNCTIONPARSER TRUE) SET(${var} TRUE) ENDMACRO() diff --git a/deal.II/cmake/configure/configure_hdf5.cmake b/deal.II/cmake/configure/configure_hdf5.cmake index 2f0ff3e937..daa85919f9 100644 --- a/deal.II/cmake/configure/configure_hdf5.cmake +++ b/deal.II/cmake/configure/configure_hdf5.cmake @@ -21,8 +21,6 @@ MACRO(FEATURE_HDF5_CONFIGURE_EXTERNAL var) INCLUDE_DIRECTORIES(${HDF5_INCLUDE_DIRS}) LIST(APPEND DEAL_II_EXTERNAL_LIBRARIES ${HDF5_LIBRARIES}) - SET(DEAL_II_HAVE_HDF5 TRUE) - SET(${var} TRUE) ENDMACRO() diff --git a/deal.II/cmake/configure/configure_lapack.cmake b/deal.II/cmake/configure/configure_lapack.cmake index a75ae016e1..8e68a41b59 100644 --- a/deal.II/cmake/configure/configure_lapack.cmake +++ b/deal.II/cmake/configure/configure_lapack.cmake @@ -78,7 +78,6 @@ MACRO(FEATURE_LAPACK_CONFIGURE_EXTERNAL var) CHECK_FOR_LAPACK_FUNCTIONS() - SET(HAVE_LIBLAPACK TRUE) SET(${var} TRUE) ENDMACRO() diff --git a/deal.II/cmake/configure/configure_metis.cmake b/deal.II/cmake/configure/configure_metis.cmake index b051ee2120..37a7fefcf2 100644 --- a/deal.II/cmake/configure/configure_metis.cmake +++ b/deal.II/cmake/configure/configure_metis.cmake @@ -41,8 +41,6 @@ MACRO(FEATURE_METIS_CONFIGURE_EXTERNAL var) INCLUDE_DIRECTORIES(${METIS_INCLUDE_DIRS}) LIST(APPEND DEAL_II_EXTERNAL_LIBRARIES ${METIS_LIBRARIES}) - SET(DEAL_II_USE_METIS TRUE) - SET(${var} TRUE) ENDMACRO() diff --git a/deal.II/cmake/configure/configure_mumps.cmake b/deal.II/cmake/configure/configure_mumps.cmake index b45381ba38..462779fcb0 100644 --- a/deal.II/cmake/configure/configure_mumps.cmake +++ b/deal.II/cmake/configure/configure_mumps.cmake @@ -28,8 +28,6 @@ MACRO(FEATURE_MUMPS_CONFIGURE_EXTERNAL var) ) ADD_FLAGS(CMAKE_SHARED_LINKER_FLAGS "${MUMPS_LINKER_FLAGS}") - SET(DEAL_II_USE_MUMPS TRUE) - SET(${var} TRUE) ENDMACRO() diff --git a/deal.II/cmake/configure/configure_netcdf.cmake b/deal.II/cmake/configure/configure_netcdf.cmake index 9a9344b262..b8a555a146 100644 --- a/deal.II/cmake/configure/configure_netcdf.cmake +++ b/deal.II/cmake/configure/configure_netcdf.cmake @@ -20,8 +20,6 @@ MACRO(FEATURE_NETCDF_CONFIGURE_EXTERNAL var) INCLUDE_DIRECTORIES(${NETCDF_INCLUDE_DIRS}) LIST(APPEND DEAL_II_EXTERNAL_LIBRARIES ${NETCDF_LIBRARIES}) - SET(HAVE_LIBNETCDF TRUE) - SET(${var} TRUE) ENDMACRO() diff --git a/deal.II/cmake/configure/configure_p4est.cmake b/deal.II/cmake/configure/configure_p4est.cmake index b26cfdbb8d..458b271c3e 100644 --- a/deal.II/cmake/configure/configure_p4est.cmake +++ b/deal.II/cmake/configure/configure_p4est.cmake @@ -48,8 +48,6 @@ MACRO(FEATURE_P4EST_CONFIGURE_EXTERNAL var) LIST(APPEND DEAL_II_EXTERNAL_LIBRARIES ${P4EST_LIBRARIES}) - SET(DEAL_II_USE_P4EST TRUE) - SET(${var} TRUE) ENDMACRO() diff --git a/deal.II/cmake/configure/configure_petsc.cmake b/deal.II/cmake/configure/configure_petsc.cmake index 92d7440614..95e216be4c 100644 --- a/deal.II/cmake/configure/configure_petsc.cmake +++ b/deal.II/cmake/configure/configure_petsc.cmake @@ -46,9 +46,9 @@ MACRO(FEATURE_PETSC_FIND_EXTERNAL var) # _NOT_ enabled. # So we check for this: # - IF( (PETSC_WITH_MPIUNI AND DEAL_II_COMPILER_SUPPORTS_MPI) + IF( (PETSC_WITH_MPIUNI AND DEAL_II_WITH_MPI) OR - (NOT PETSC_WITH_MPIUNI AND NOT DEAL_II_COMPILER_SUPPORTS_MPI)) + (NOT PETSC_WITH_MPIUNI AND NOT DEAL_II_WITH_MPI)) MESSAGE(WARNING "\n" "Could not find a sufficient petsc installation: " "Petsc has to be configured with the same MPI configuration as deal.II.\n\n" @@ -76,8 +76,6 @@ MACRO(FEATURE_PETSC_CONFIGURE_EXTERNAL var) ${PETSC_LIBRARIES} ) - SET(DEAL_II_USE_PETSC TRUE) - # # Disable a bunch of warnings when compiling with petsc: # diff --git a/deal.II/cmake/configure/configure_slepc.cmake b/deal.II/cmake/configure/configure_slepc.cmake index 8f4fe2d0d4..df29d78cd6 100644 --- a/deal.II/cmake/configure/configure_slepc.cmake +++ b/deal.II/cmake/configure/configure_slepc.cmake @@ -57,8 +57,6 @@ MACRO(FEATURE_SLEPC_CONFIGURE_EXTERNAL var) ${SLEPC_LIBRARIES} ) - SET(DEAL_II_USE_SLEPC TRUE) - SET(${var} TRUE) ENDMACRO() diff --git a/deal.II/cmake/configure/configure_trilinos.cmake b/deal.II/cmake/configure/configure_trilinos.cmake index ee1f523f0e..9fc42c061a 100644 --- a/deal.II/cmake/configure/configure_trilinos.cmake +++ b/deal.II/cmake/configure/configure_trilinos.cmake @@ -90,9 +90,9 @@ MACRO(FEATURE_TRILINOS_FIND_EXTERNAL var) # Trilinos has to be configured with the same MPI configuration as # deal.II. # - IF( (TRILINOS_WITH_MPI AND NOT DEAL_II_COMPILER_SUPPORTS_MPI) + IF( (TRILINOS_WITH_MPI AND NOT DEAL_II_WITH_MPI) OR - (NOT TRILINOS_WITH_MPI AND DEAL_II_COMPILER_SUPPORTS_MPI)) + (NOT TRILINOS_WITH_MPI AND DEAL_II_WITH_MPI)) MESSAGE(WARNING "\n" "Trilinos has to be configured with the same MPI configuration as deal.II.\n\n" ) @@ -172,8 +172,6 @@ MACRO(FEATURE_TRILINOS_CONFIGURE_EXTERNAL var) ${Trilinos_TPL_LIBRARIES} ) - SET(DEAL_II_USE_TRILINOS TRUE) - SET(DEAL_II_EXPAND_TRILINOS_VECTOR "TrilinosWrappers::Vector") SET(DEAL_II_EXPAND_TRILINOS_BLOCKVECTOR "TrilinosWrappers::BlockVector") SET(DEAL_II_EXPAND_TRILINOS_SPARSITY_PATTERN "TrilinosWrappers::SparsityPattern") diff --git a/deal.II/cmake/configure/configure_umfpack.cmake b/deal.II/cmake/configure/configure_umfpack.cmake index 529be4d846..466cc628d6 100644 --- a/deal.II/cmake/configure/configure_umfpack.cmake +++ b/deal.II/cmake/configure/configure_umfpack.cmake @@ -29,8 +29,6 @@ MACRO(FEATURE_UMFPACK_CONFIGURE_EXTERNAL var) LIST(APPEND DEAL_II_EXTERNAL_LIBRARIES ${UMFPACK_LIBRARIES}) ADD_FLAGS(CMAKE_SHARED_LINKER_FLAGS "${UMFPACK_LINKER_FLAGS}") - SET(HAVE_LIBUMFPACK TRUE) - SET(${var} TRUE) ENDMACRO() @@ -45,8 +43,6 @@ MACRO(FEATURE_UMFPACK_CONFIGURE_BUNDLED var) ${UMFPACK_FOLDER}/AMD/Include ) - SET(HAVE_LIBUMFPACK TRUE) - SET(${var} TRUE) ENDMACRO() diff --git a/deal.II/cmake/configure/configure_zlib.cmake b/deal.II/cmake/configure/configure_zlib.cmake index fc835e8e33..41fc235167 100644 --- a/deal.II/cmake/configure/configure_zlib.cmake +++ b/deal.II/cmake/configure/configure_zlib.cmake @@ -20,8 +20,6 @@ MACRO(FEATURE_ZLIB_CONFIGURE_EXTERNAL var) INCLUDE_DIRECTORIES(${ZLIB_INCLUDE_DIRS}) LIST(APPEND DEAL_II_EXTERNAL_LIBRARIES ${ZLIB_LIBRARIES}) - SET(HAVE_LIBZ TRUE) - SET(${var} TRUE) ENDMACRO() diff --git a/deal.II/cmake/scripts/report_features.cc b/deal.II/cmake/scripts/report_features.cc index a1f9fac40e..fcaa0b4226 100644 --- a/deal.II/cmake/scripts/report_features.cc +++ b/deal.II/cmake/scripts/report_features.cc @@ -15,30 +15,30 @@ #include -#ifdef HAVE_LIBUMFPACK +#ifdef DEAL_II_WITH_UMFPACK extern "C" { #include } #endif -#if defined(DEAL_II_COMPILER_SUPPORTS_MPI) +#if defined(DEAL_II_WITH_MPI) #include #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include #endif -#ifdef DEAL_II_USE_MUMPS +#ifdef DEAL_II_WITH_MUMPS # include # include #endif -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include #endif -#ifdef DEAL_II_USE_SLEPC +#ifdef DEAL_II_WITH_SLEPC # include #endif @@ -55,18 +55,18 @@ int main() std::cout << "dealii-feature: BLAS=yes" << std::endl; #endif -#ifdef HAVE_LIBLAPACK +#ifdef DEAL_II_WITH_LAPACK std::cout << "dealii-feature: LAPACK=yes" << std::endl; #endif -#ifdef HAVE_LIBUMFPACK +#ifdef DEAL_II_WITH_UMFPACK std::cout << "dealii-feature: UMFPACK=" << UMFPACK_MAIN_VERSION << '.' << UMFPACK_SUB_VERSION << '.' << UMFPACK_SUBSUB_VERSION << std::endl; #endif -#if defined(DEAL_II_COMPILER_SUPPORTS_MPI) +#if defined(DEAL_II_WITH_MPI) # ifdef OMPI_MAJOR_VERSION std::cout << "dealii-feature: MPI=OpenMPI-" << OMPI_MAJOR_VERSION << '.' @@ -79,7 +79,7 @@ int main() # endif #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # ifdef TRILINOS_VERSION_STRING std::cout << "dealii-feature: Trilinos=" << TRILINOS_VERSION_STRING << std::endl; # else @@ -92,11 +92,11 @@ int main() # endif #endif -#ifdef DEAL_II_USE_MUMPS +#ifdef DEAL_II_WITH_MUMPS std::cout << "dealii-feature: MUMPS=yes" << std::endl; #endif -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC std::cout << "dealii-feature: PETSc=" << PETSC_VERSION_MAJOR << '.' << PETSC_VERSION_MINOR << '.' @@ -104,7 +104,7 @@ int main() << PETSC_VERSION_PATCH << std::endl; #endif -#ifdef DEAL_II_USE_SLEPC +#ifdef DEAL_II_WITH_SLEPC std::cout << "dealii-feature: SLEPc=" << SLEPC_VERSION_MAJOR << '.' << SLEPC_VERSION_MINOR << '.' @@ -123,11 +123,11 @@ int main() std::cout << std::endl; #endif -#ifdef DEAL_II_USE_P4EST +#ifdef DEAL_II_WITH_P4EST std::cout << "dealii-feature: P4est=yes" << std::endl; #endif -#ifdef DEAL_II_HAVE_HDF5 +#ifdef DEAL_II_WITH_HDF5 std::cout << "dealii-feature: HDF5=yes" << std::endl; #endif @@ -135,15 +135,15 @@ int main() std::cout << "dealii-feature: Tecplot=yes" << std::endl; #endif -#ifdef HAVE_LIBNETCDF +#ifdef DEAL_II_WITH_NETCDF std::cout << "dealii-feature: NetCDF=yes" << std::endl; #endif -#ifdef HAVE_LIBZ +#ifdef DEAL_II_WITH_ZLIB std::cout << "dealii-feature: LibZ=yes" << std::endl; #endif -#ifdef HAVE_FUNCTIONPARSER +#ifdef DEAL_II_WITH_FUNCTIONPARSER std::cout << "dealii-feature: parser=yes" << std::endl; #else std::cout << "dealii-feature: parser=no" << std::endl; diff --git a/deal.II/doc/doxygen/options.dox.in b/deal.II/doc/doxygen/options.dox.in index a5cf8929b1..7d3adb5367 100644 --- a/deal.II/doc/doxygen/options.dox.in +++ b/deal.II/doc/doxygen/options.dox.in @@ -992,15 +992,15 @@ INCLUDE_FILE_PATTERNS = PREDEFINED = DOXYGEN=1 \ DEBUG=1 \ - DEAL_II_USE_PETSC=1 \ - DEAL_II_USE_SLEPC=1 \ - DEAL_II_USE_TRILINOS=1 \ - DEAL_II_USE_MT=1 \ + DEAL_II_WITH_PETSC=1 \ + DEAL_II_WITH_SLEPC=1 \ + DEAL_II_WITH_TRILINOS=1 \ + DEAL_II_WITH_THREADS=1 \ DEAL_II_USE_MT_POSIX=1 \ DEAL_II_USE_ARPACK=1 \ - DEAL_II_USE_METIS=1 \ - DEAL_II_USE_MUMPS=1 \ - DEAL_II_USE_P4EST=1 + DEAL_II_WITH_METIS=1 \ + DEAL_II_WITH_MUMPS=1 \ + DEAL_II_WITH_P4EST=1 # If the MACRO_EXPANSION and EXPAND_ONLY_PREDEF tags are set to YES then # this tag can be used to specify a list of macro names that should be expanded. diff --git a/deal.II/doc/news/3.4.0-vs-4.0.0.html b/deal.II/doc/news/3.4.0-vs-4.0.0.html index 23fde020fa..b208e71bf7 100644 --- a/deal.II/doc/news/3.4.0-vs-4.0.0.html +++ b/deal.II/doc/news/3.4.0-vs-4.0.0.html @@ -162,18 +162,18 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
  • Changed: Previously, we just set the preprocessor variable - DEAL_II_USE_MT, when --with-multithreading was + DEAL_II_WITH_THREADS, when --with-multithreading was given as argument to ./configure. Tests in the code - therefore looked like #ifdef DEAL_II_USE_MT. This has been + therefore looked like #ifdef DEAL_II_WITH_THREADS. This has been changed so that the variable is always defined, but its value is now equal to 1 when multithreading was requested, and zero otherwise. The reason for - this is that you can now write if (DEAL_II_USE_MT && ...) + this is that you can now write if (DEAL_II_WITH_THREADS && ...) conditions, and need not interleave if-else clauses from regular code and the preprocessor, if conditions involve both the state of this preprocessor variable and the run-time state of your program. However, this change requires that all appearances of #ifdef - DEAL_II_USE_MT be changed to #if DEAL_II_USE_MT == + DEAL_II_WITH_THREADS be changed to #if DEAL_II_WITH_THREADS == 1, since the variable is now defined unconditionally.
    (WB 2002/11/14) diff --git a/deal.II/doc/news/6.1.0-vs-6.2.0.h b/deal.II/doc/news/6.1.0-vs-6.2.0.h index 6de0c2aaa6..844a442565 100644 --- a/deal.II/doc/news/6.1.0-vs-6.2.0.h +++ b/deal.II/doc/news/6.1.0-vs-6.2.0.h @@ -536,7 +536,7 @@ inconvenience this causes.

  • New: If the compiler allows to do \#include @, then - the preprocessor flag DEAL_II_COMPILER_SUPPORTS_MPI is now set in + the preprocessor flag DEAL_II_WITH_MPI is now set in base/include/base/config.h. This also fixes a problem in base/include/base/utilities.h if a compiler capable of including mpi.h was used but not PETSc. diff --git a/deal.II/examples/step-48/step-48.cc b/deal.II/examples/step-48/step-48.cc index 24e88f32d0..2c0c9f2a58 100644 --- a/deal.II/examples/step-48/step-48.cc +++ b/deal.II/examples/step-48/step-48.cc @@ -286,7 +286,7 @@ namespace Step48 void assemble_system (); void output_results (const unsigned int timestep_number) const; -#ifdef DEAL_II_USE_P4EST +#ifdef DEAL_II_WITH_P4EST parallel::distributed::Triangulation triangulation; #else Triangulation triangulation; @@ -323,7 +323,7 @@ namespace Step48 : pcout (std::cout, Utilities::System::get_this_mpi_process(MPI_COMM_WORLD)==0), -#ifdef DEAL_II_USE_P4EST +#ifdef DEAL_II_WITH_P4EST triangulation (MPI_COMM_WORLD), #endif fe (QGaussLobatto<1>(fe_degree+1)), @@ -371,7 +371,7 @@ namespace Step48 } pcout << " Number of global active cells: " -#ifdef DEAL_II_USE_P4EST +#ifdef DEAL_II_WITH_P4EST << triangulation.n_global_active_cells() #else << triangulation.n_active_cells() diff --git a/deal.II/include/deal.II/base/config.h.in b/deal.II/include/deal.II/base/config.h.in index cc90898938..88339eb5ab 100644 --- a/deal.II/include/deal.II/base/config.h.in +++ b/deal.II/include/deal.II/base/config.h.in @@ -158,6 +158,22 @@ /* Defined if deal.II was configured on a native Windows platform. */ #cmakedefine DEAL_II_MSVC +/* Disable a bunch of warnings for Microsoft Visual C++. */ +//#ifdef DEAL_II_MSVC +//# pragma warning( disable : 4244 ) /* implied downcasting from double to float */ +//# pragma warning( disable : 4267 ) /* implied downcasting from size_t to unsigned int */ +//# pragma warning( disable : 4996 ) /* unsafe functions, such as strcat and sprintf */ +//# pragma warning( disable : 4355 ) /* 'this' : used in base member initializer list */ +//# pragma warning( disable : 4661 ) /* no suitable definition provided for explicit template instantiation request */ +//# pragma warning( disable : 4800 ) /* forcing value to bool 'true' or 'false' (performance warning) */ +//# pragma warning( disable : 4146 ) /* unary minus operator applied to unsigned type, result still unsigned */ +//# pragma warning( disable : 4667 ) /* no function template defined that matches forced instantiation */ +//# pragma warning( disable : 4520 ) /* multiple default constructors specified */ +//# pragma warning( disable : 4700 ) /* uninitialized local variable */ +//# pragma warning( disable : 4789 ) /* destination of memory copy is too small */ +//# pragma warning( disable : 4808 ) /* case 'value' is not a valid value for switch condition of type 'bool */ +//#endif // DEAL_II_MSVC + /**************************************** * Configured in check_2_compiler_bugs: * @@ -203,150 +219,68 @@ #cmakedefine DEAL_II_BOOST_BIND_COMPILER_BUG - /***************************************** * Configured in configure_arpack.cmake: * *****************************************/ -/* Defined if an ARPACK installation was found and is going to be used */ #cmakedefine DEAL_II_USE_ARPACK - /************************************************* * Configured in configure_functionparser.cmake: * *************************************************/ -/* Defined if you have the `functionparser' library */ -#cmakedefine HAVE_FUNCTIONPARSER - +#cmakedefine DEAL_II_WITH_FUNCTIONPARSER /*************************************** * Configured in configure_hdf5.cmake: * ***************************************/ -/* Defined if deal.II was configured with hdf5 support */ -#cmakedefine DEAL_II_HAVE_HDF5 - +#cmakedefine DEAL_II_WITH_HDF5 /***************************************** * Configured in configure_lapack.cmake: * *****************************************/ -/* Defined if deal.II was configured with LAPACK support */ -#cmakedefine HAVE_LIBLAPACK +#cmakedefine DEAL_II_WITH_LAPACK -/* Defined if you have the `daxpy_' function. */ +/* Defined if the corresponding BLAS or LAPACK function is available */ #cmakedefine HAVE_DAXPY_ - -/* Defined if you have the `dgeevx_' function. */ #cmakedefine HAVE_DGEEVX_ - -/* Defined if you have the `dgeev_' function. */ #cmakedefine HAVE_DGEEV_ - -/* Defined if you have the `dgelsd_' function. */ #cmakedefine HAVE_DGELSD_ - -/* Defined if you have the `dgemm_' function. */ #cmakedefine HAVE_DGEMM_ - -/* Defined if you have the `dgemv_' function. */ #cmakedefine HAVE_DGEMV_ - -/* Defined if you have the `dgeqrf_' function. */ #cmakedefine HAVE_DGEQRF_ - -/* Defined if you have the `dgesdd_' function. */ #cmakedefine HAVE_DGESDD_ - -/* Defined if you have the `dgesvd_' function. */ #cmakedefine HAVE_DGESVD_ - -/* Defined if you have the `dgetrf_' function. */ #cmakedefine HAVE_DGETRF_ - -/* Defined if you have the `dgetri_' function. */ #cmakedefine HAVE_DGETRI_ - -/* Defined if you have the `dgetrs_' function. */ #cmakedefine HAVE_DGETRS_ - -/* Defined if you have the `dorgqr_' function. */ #cmakedefine HAVE_DORGQR_ - -/* Defined if you have the `dormqr_' function. */ #cmakedefine HAVE_DORMQR_ - -/* Defined if you have the `dstev_' function. */ #cmakedefine HAVE_DSTEV_ - -/* Defined if you have the `dsyevx_' function. */ #cmakedefine HAVE_DSYEVX_ - -/* Defined if you have the `dsygv_' function. */ #cmakedefine HAVE_DSYGV_ - -/* Defined if you have the `dsygvx_' function. */ #cmakedefine HAVE_DSYGVX_ - -/* Defined if you have the `dtrtrs_' function. */ #cmakedefine HAVE_DTRTRS_ - -/* Defined if you have the `saxpy_' function. */ #cmakedefine HAVE_SAXPY_ - -/* Defined if you have the `sgeevx_' function. */ #cmakedefine HAVE_SGEEVX_ - -/* Defined if you have the `sgeev_' function. */ #cmakedefine HAVE_SGEEV_ - -/* Defined if you have the `sgelsd_' function. */ #cmakedefine HAVE_SGELSD_ - -/* Defined if you have the `sgemm_' function. */ #cmakedefine HAVE_SGEMM_ - -/* Defined if you have the `sgemv_' function. */ #cmakedefine HAVE_SGEMV_ - -/* Defined if you have the `sgeqrf_' function. */ #cmakedefine HAVE_SGEQRF_ - -/* Defined if you have the `sgesdd_' function. */ #cmakedefine HAVE_SGESDD_ - -/* Defined if you have the `sgesvd_' function. */ #cmakedefine HAVE_SGESVD_ - -/* Defined if you have the `sgetrf_' function. */ #cmakedefine HAVE_SGETRF_ - -/* Defined if you have the `sgetri_' function. */ #cmakedefine HAVE_SGETRI_ - -/* Defined if you have the `sgetrs_' function. */ #cmakedefine HAVE_SGETRS_ - -/* Defined if you have the `sorgqr_' function. */ #cmakedefine HAVE_SORGQR_ - -/* Defined if you have the `sormqr_' function. */ #cmakedefine HAVE_SORMQR_ - -/* Defined if you have the `sstev_' function. */ #cmakedefine HAVE_SSTEV_ - -/* Defined if you have the `ssyevx_' function. */ #cmakedefine HAVE_SSYEVX_ - -/* Defined if you have the `ssygv_' function. */ #cmakedefine HAVE_SSYGV_ - -/* Defined if you have the `ssygvx_' function. */ #cmakedefine HAVE_SSYGVX_ - -/* Defined if you have the `strtrs_' function. */ #cmakedefine HAVE_STRTRS_ @@ -354,49 +288,43 @@ * Configured in configure_metis.cmake: * ****************************************/ -/* Defined if a Metis installation was found and is going to be used */ -#cmakedefine DEAL_II_USE_METIS +#cmakedefine DEAL_II_WITH_METIS /************************************** * Configured in configure_mpi.cmake: * **************************************/ -/* Defined if the compiler supports mpi */ -#cmakedefine DEAL_II_COMPILER_SUPPORTS_MPI +#cmakedefine DEAL_II_WITH_MPI /***************************************** * Configured in configure_mumps.cmake: * *****************************************/ -/* Defined if an MUMPS installation was found and is going to be used */ -#cmakedefine DEAL_II_USE_MUMPS +#cmakedefine DEAL_II_WITH_MUMPS /***************************************** * Configured in configure_netcdf.cmake: * *****************************************/ -/* Defined if you have the `NetCDF' library */ -#cmakedefine HAVE_LIBNETCDF +#cmakedefine DEAL_II_WITH_NETCDF /**************************************** * Configured in configure_p4est.cmake: * ****************************************/ -/* Defined if we are to use the p4est library to distribute meshes on a - cluster computer. */ -#cmakedefine DEAL_II_USE_P4EST +#cmakedefine DEAL_II_WITH_P4EST /**************************************** * Configured in configure_petsc.cmake: * ****************************************/ -/* Defined if a PETSc installation was found and is going to be used */ -#cmakedefine DEAL_II_USE_PETSC +#cmakedefine DEAL_II_WITH_PETSC + /* * Note: The following definitions will be set in petscconf.h and @@ -436,23 +364,18 @@ >= \ (major)*10000 + (minor)*100 + (subminor)) - /**************************************** * Configured in configure_slepc.cmake: * ****************************************/ -/* Defined if a SLEPc installation was found and is going to be used */ -#cmakedefine DEAL_II_USE_SLEPC +#cmakedefine DEAL_II_WITH_SLEPC /******************************************** * Configured in configure_1_threads.cmake: * ********************************************/ -/* Flag indicating whether the library shall be compiled for multithreaded - * applications. If so, then it is set to one, otherwise to zero. - */ -#cmakedefine DEAL_II_USE_MT +#cmakedefine DEAL_II_WITH_THREADS /* Defined if multi-threading is to be achieved by using the POSIX functions */ @@ -469,7 +392,7 @@ * volatile. We do this here in a very old-fashioned C-style, but still * convenient way. */ -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS # define DEAL_VOLATILE volatile #else # define DEAL_VOLATILE @@ -480,41 +403,21 @@ * Configured in configure_trilinos.cmake: * *******************************************/ -/* Defined if a Trilinos installation was found and is going to be used */ -#cmakedefine DEAL_II_USE_TRILINOS +#cmakedefine DEAL_II_WITH_TRILINOS /****************************************** * Configured in configure_umfpack.cmake: * ******************************************/ -/* Defined if deal.II was configured with UMFPACK support */ -#cmakedefine HAVE_LIBUMFPACK +#cmakedefine DEAL_II_WITH_UMFPACK /*************************************** * Configured in configure_zlib.cmake: * ***************************************/ -/* Defined if deal.II was configure with zlib support */ -#cmakedefine HAVE_LIBZ - - -/* Disable a bunch of warnings for Microsoft Visual C++. */ -#ifdef DEAL_II_MSVC -//# pragma warning( disable : 4244 ) /* implied downcasting from double to float */ -//# pragma warning( disable : 4267 ) /* implied downcasting from size_t to unsigned int */ -//# pragma warning( disable : 4996 ) /* unsafe functions, such as strcat and sprintf */ -//# pragma warning( disable : 4355 ) /* 'this' : used in base member initializer list */ -//# pragma warning( disable : 4661 ) /* no suitable definition provided for explicit template instantiation request */ -//# pragma warning( disable : 4800 ) /* forcing value to bool 'true' or 'false' (performance warning) */ -//# pragma warning( disable : 4146 ) /* unary minus operator applied to unsigned type, result still unsigned */ -//# pragma warning( disable : 4667 ) /* no function template defined that matches forced instantiation */ -//# pragma warning( disable : 4520 ) /* multiple default constructors specified */ -//# pragma warning( disable : 4700 ) /* uninitialized local variable */ -//# pragma warning( disable : 4789 ) /* destination of memory copy is too small */ -//# pragma warning( disable : 4808 ) /* case 'value' is not a valid value for switch condition of type 'bool */ -#endif // DEAL_II_MSVC +#cmakedefine DEAL_II_WITH_ZLIB #include diff --git a/deal.II/include/deal.II/base/exceptions.h b/deal.II/include/deal.II/base/exceptions.h index caca74ffa0..b7dba69576 100644 --- a/deal.II/include/deal.II/base/exceptions.h +++ b/deal.II/include/deal.II/base/exceptions.h @@ -905,7 +905,7 @@ namespace StandardExceptions /** * Assert support for the LAPACK library */ -#ifdef HAVE_LIBLAPACK +#ifdef DEAL_II_WITH_LAPACK # define AssertLAPACK {} #else # define AssertLAPACK Assert(false, ExcNeedsLAPACK()) @@ -914,7 +914,7 @@ namespace StandardExceptions /** * Assert support for the UMFPACK library */ -#ifdef HAVE_LIBUMFPACK +#ifdef DEAL_II_WITH_UMFPACK # define AssertUMFPACK {} #else # define AssertUMFPACK Assert(false, ExcNeedsUMFPACK()) diff --git a/deal.II/include/deal.II/base/index_set.h b/deal.II/include/deal.II/base/index_set.h index f8666206b6..0b2baecf3e 100644 --- a/deal.II/include/deal.II/base/index_set.h +++ b/deal.II/include/deal.II/base/index_set.h @@ -19,11 +19,11 @@ #include #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include #endif -#if defined(DEAL_II_COMPILER_SUPPORTS_MPI) || defined(DEAL_II_USE_PETSC) +#if defined(DEAL_II_WITH_MPI) || defined(DEAL_II_WITH_PETSC) #include #else typedef int MPI_Comm; @@ -328,7 +328,7 @@ public: */ void block_read(std::istream &in); -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS /** * Given an MPI communicator, * create a Trilinos map object diff --git a/deal.II/include/deal.II/base/mpi.h b/deal.II/include/deal.II/base/mpi.h index 912cbbf512..1b1098f12d 100644 --- a/deal.II/include/deal.II/base/mpi.h +++ b/deal.II/include/deal.II/base/mpi.h @@ -16,7 +16,7 @@ #include #include -#if defined(DEAL_II_COMPILER_SUPPORTS_MPI) || defined(DEAL_II_USE_PETSC) +#if defined(DEAL_II_WITH_MPI) || defined(DEAL_II_WITH_PETSC) # include // Check whether is a suitable // include for us (if MPI_SEEK_SET is not @@ -336,7 +336,7 @@ namespace Utilities namespace internal { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI /** * Return the corresponding MPI data * type id for the argument given. @@ -390,7 +390,7 @@ namespace Utilities T sum (const T &t, const MPI_Comm &mpi_communicator) { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI T sum; MPI_Allreduce (const_cast(static_cast(&t)), &sum, 1, internal::mpi_type_id(&t), MPI_SUM, @@ -409,7 +409,7 @@ namespace Utilities const MPI_Comm &mpi_communicator, T (&sums)[N]) { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI MPI_Allreduce (const_cast(static_cast(&values[0])), &sums[0], N, internal::mpi_type_id(values), MPI_SUM, mpi_communicator); @@ -427,7 +427,7 @@ namespace Utilities const MPI_Comm &mpi_communicator, std::vector &sums) { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI sums.resize (values.size()); MPI_Allreduce (const_cast(static_cast(&values[0])), &sums[0], values.size(), internal::mpi_type_id((T *)0), MPI_SUM, @@ -444,7 +444,7 @@ namespace Utilities T max (const T &t, const MPI_Comm &mpi_communicator) { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI T sum; MPI_Allreduce (const_cast(static_cast(&t)), &sum, 1, internal::mpi_type_id(&t), MPI_MAX, @@ -463,7 +463,7 @@ namespace Utilities const MPI_Comm &mpi_communicator, T (&maxima)[N]) { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI MPI_Allreduce (const_cast(static_cast(&values[0])), &maxima[0], N, internal::mpi_type_id(values), MPI_MAX, mpi_communicator); @@ -481,7 +481,7 @@ namespace Utilities const MPI_Comm &mpi_communicator, std::vector &maxima) { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI maxima.resize (values.size()); MPI_Allreduce (const_cast(static_cast(&values[0])), &maxima[0], values.size(), internal::mpi_type_id((T *)0), MPI_MAX, diff --git a/deal.II/include/deal.II/base/parallel.h b/deal.II/include/deal.II/base/parallel.h index 88cf788462..3ffdda181b 100644 --- a/deal.II/include/deal.II/base/parallel.h +++ b/deal.II/include/deal.II/base/parallel.h @@ -24,7 +24,7 @@ #include -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS # include # include # include @@ -176,7 +176,7 @@ namespace parallel Predicate &predicate, const unsigned int grainsize) { -#ifndef DEAL_II_USE_MT +#ifndef DEAL_II_WITH_THREADS // make sure we don't get compiler // warnings about unused arguments (void) grainsize; @@ -244,7 +244,7 @@ namespace parallel Predicate &predicate, const unsigned int grainsize) { -#ifndef DEAL_II_USE_MT +#ifndef DEAL_II_WITH_THREADS // make sure we don't get compiler // warnings about unused arguments (void) grainsize; @@ -314,7 +314,7 @@ namespace parallel Predicate &predicate, const unsigned int grainsize) { -#ifndef DEAL_II_USE_MT +#ifndef DEAL_II_WITH_THREADS // make sure we don't get compiler // warnings about unused arguments (void) grainsize; @@ -340,7 +340,7 @@ namespace parallel namespace internal { -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS /** * Take a range argument and call the * given function with its begin and end. @@ -461,7 +461,7 @@ namespace parallel const Function &f, const unsigned int grainsize) { -#ifndef DEAL_II_USE_MT +#ifndef DEAL_II_WITH_THREADS // make sure we don't get compiler // warnings about unused arguments (void) grainsize; @@ -546,7 +546,7 @@ namespace parallel namespace internal { -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS /** * A class that conforms to the Body * requirements of the TBB @@ -741,7 +741,7 @@ namespace parallel const typename identity::type &end, const unsigned int grainsize) { -#ifndef DEAL_II_USE_MT +#ifndef DEAL_II_WITH_THREADS // make sure we don't get compiler // warnings about unused arguments (void) grainsize; @@ -813,7 +813,7 @@ namespace internal namespace parallel { -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS namespace internal { @@ -851,7 +851,7 @@ namespace parallel const std::size_t end, const std::size_t minimum_parallel_grain_size) const { -#ifndef DEAL_II_USE_MT +#ifndef DEAL_II_WITH_THREADS // make sure we don't get compiler // warnings about unused arguments (void) minimum_parallel_grain_size; diff --git a/deal.II/include/deal.II/base/thread_local_storage.h b/deal.II/include/deal.II/base/thread_local_storage.h index 33aef09fcd..078266824a 100644 --- a/deal.II/include/deal.II/base/thread_local_storage.h +++ b/deal.II/include/deal.II/base/thread_local_storage.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS # include #endif @@ -121,7 +121,7 @@ namespace Threads ThreadLocalStorage &operator = (const T &t); private: -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS /** * The data element we store. If we support threads, then this * object will be of a type that provides a separate object @@ -163,7 +163,7 @@ namespace Threads T & ThreadLocalStorage::get () { -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS return data.local(); #else return data; diff --git a/deal.II/include/deal.II/base/thread_management.h b/deal.II/include/deal.II/base/thread_management.h index a8690dce35..316ba303b3 100644 --- a/deal.II/include/deal.II/base/thread_management.h +++ b/deal.II/include/deal.II/base/thread_management.h @@ -21,7 +21,7 @@ #include #include -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS # include # include # include @@ -33,7 +33,7 @@ #include -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS # ifdef DEAL_II_USE_MT_POSIX # include # endif @@ -276,7 +276,7 @@ namespace Threads }; -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS /** * Class implementing a @@ -1262,7 +1262,7 @@ namespace Threads namespace internal { -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS /** * A class that represents threads. For @@ -4037,7 +4037,7 @@ namespace Threads namespace internal { -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS template struct TaskDescriptor; diff --git a/deal.II/include/deal.II/base/timer.h b/deal.II/include/deal.II/base/timer.h index fed57a32bd..fa2bf8a145 100644 --- a/deal.II/include/deal.II/base/timer.h +++ b/deal.II/include/deal.II/base/timer.h @@ -17,7 +17,7 @@ #include #include -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI # include #endif @@ -76,7 +76,7 @@ public: */ Timer (); -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI /** * Constructor that takes an MPI * communicator as input. A timer @@ -233,7 +233,7 @@ private: */ MPI_Comm mpi_communicator; -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI /** * Store whether the wall time is * synchronized between machines. @@ -351,7 +351,7 @@ public: const enum OutputFrequency output_frequency, const enum OutputType output_type); -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI /** * Constructor that takes an MPI * communicator as input. A timer @@ -533,7 +533,7 @@ void Timer::restart () -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI inline const Utilities::System::MinMaxAvg & diff --git a/deal.II/include/deal.II/base/utilities.h b/deal.II/include/deal.II/base/utilities.h index b5ac602277..a4924d1800 100644 --- a/deal.II/include/deal.II/base/utilities.h +++ b/deal.II/include/deal.II/base/utilities.h @@ -21,10 +21,10 @@ #include #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include # include -# ifdef DEAL_II_COMPILER_SUPPORTS_MPI +# ifdef DEAL_II_WITH_MPI # include # else # include @@ -485,7 +485,7 @@ namespace Utilities } -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS /** * This namespace provides some of the basic structures used in the * initialization of the Trilinos objects (e.g., matrices, vectors, and diff --git a/deal.II/include/deal.II/base/work_stream.h b/deal.II/include/deal.II/base/work_stream.h index f1891d0936..b44ed33f2c 100644 --- a/deal.II/include/deal.II/base/work_stream.h +++ b/deal.II/include/deal.II/base/work_stream.h @@ -19,7 +19,7 @@ #include #include -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS # include # include #endif @@ -125,7 +125,7 @@ DEAL_II_NAMESPACE_OPEN namespace WorkStream { -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS namespace internal @@ -439,7 +439,7 @@ namespace WorkStream } -#endif // DEAL_II_USE_MT +#endif // DEAL_II_WITH_THREADS @@ -527,7 +527,7 @@ namespace WorkStream if (!(begin != end)) return; -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS // create the three stages of the // pipeline internal::IteratorRangeToItemStream diff --git a/deal.II/include/deal.II/distributed/tria.h b/deal.II/include/deal.II/distributed/tria.h index 91fc256ede..a9963c5439 100644 --- a/deal.II/include/deal.II/distributed/tria.h +++ b/deal.II/include/deal.II/distributed/tria.h @@ -25,11 +25,11 @@ #include #include -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI # include #endif -#ifdef DEAL_II_USE_P4EST +#ifdef DEAL_II_WITH_P4EST #include #include #include @@ -44,7 +44,7 @@ DEAL_II_NAMESPACE_OPEN template class Triangulation; -#ifdef DEAL_II_USE_P4EST +#ifdef DEAL_II_WITH_P4EST namespace internal { @@ -894,7 +894,7 @@ namespace parallel } -#else // DEAL_II_USE_P4EST +#else // DEAL_II_WITH_P4EST namespace parallel { @@ -950,7 +950,7 @@ namespace parallel * communicator used by this * triangulation. */ -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI MPI_Comm get_communicator () const; #endif }; diff --git a/deal.II/include/deal.II/fe/fe_values.h b/deal.II/include/deal.II/fe/fe_values.h index 1211ac37de..4758c761c0 100644 --- a/deal.II/include/deal.II/fe/fe_values.h +++ b/deal.II/include/deal.II/fe/fe_values.h @@ -39,7 +39,7 @@ // dummy include in order to have the // definition of PetscScalar available // without including other PETSc stuff -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include #endif diff --git a/deal.II/include/deal.II/grid/tria_accessor.templates.h b/deal.II/include/deal.II/grid/tria_accessor.templates.h index b34c505fcb..87eec9623a 100644 --- a/deal.II/include/deal.II/grid/tria_accessor.templates.h +++ b/deal.II/include/deal.II/grid/tria_accessor.templates.h @@ -2883,7 +2883,7 @@ inline bool CellAccessor::is_locally_owned () const { -#ifndef DEAL_II_USE_P4EST +#ifndef DEAL_II_WITH_P4EST return true; #else const types::subdomain_id subdomain = this->subdomain_id(); @@ -2906,7 +2906,7 @@ inline bool CellAccessor::is_ghost () const { -#ifndef DEAL_II_USE_P4EST +#ifndef DEAL_II_WITH_P4EST return false; #else const types::subdomain_id subdomain = this->subdomain_id(); @@ -2930,7 +2930,7 @@ inline bool CellAccessor::is_artificial () const { -#ifndef DEAL_II_USE_P4EST +#ifndef DEAL_II_WITH_P4EST return false; #else return (this->subdomain_id() == numbers::artificial_subdomain_id); diff --git a/deal.II/include/deal.II/lac/block_sparsity_pattern.h b/deal.II/include/deal.II/lac/block_sparsity_pattern.h index 9b412967b0..21ee9f7a5b 100644 --- a/deal.II/include/deal.II/lac/block_sparsity_pattern.h +++ b/deal.II/include/deal.II/lac/block_sparsity_pattern.h @@ -33,7 +33,7 @@ class BlockSparsityPattern; class BlockCompressedSparsityPattern; class BlockCompressedSimpleSparsityPattern; class BlockCompressedSetSparsityPattern; -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS namespace TrilinosWrappers { class BlockSparsityPattern; @@ -976,7 +976,7 @@ public: -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS /** diff --git a/deal.II/include/deal.II/lac/block_vector.h b/deal.II/include/deal.II/lac/block_vector.h index 5502e1ba78..9d71854108 100644 --- a/deal.II/include/deal.II/lac/block_vector.h +++ b/deal.II/include/deal.II/lac/block_vector.h @@ -24,7 +24,7 @@ DEAL_II_NAMESPACE_OPEN -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS namespace TrilinosWrappers { class Vector; @@ -139,7 +139,7 @@ public: #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS /** * A copy constructor taking a * (parallel) Trilinos block @@ -241,7 +241,7 @@ public: BlockVector & operator= (const Vector &V); -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS /** * A copy constructor from a * Trilinos block vector to a diff --git a/deal.II/include/deal.II/lac/block_vector.templates.h b/deal.II/include/deal.II/lac/block_vector.templates.h index 5203de26fb..0e000748e4 100644 --- a/deal.II/include/deal.II/lac/block_vector.templates.h +++ b/deal.II/include/deal.II/lac/block_vector.templates.h @@ -70,7 +70,7 @@ BlockVector::BlockVector (const BlockVector &v) #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS template BlockVector::BlockVector (const TrilinosWrappers::BlockVector &v) @@ -143,7 +143,7 @@ BlockVector::~BlockVector () {} -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS template inline BlockVector & diff --git a/deal.II/include/deal.II/lac/parallel_vector.h b/deal.II/include/deal.II/lac/parallel_vector.h index db910b11bd..088d0528e0 100644 --- a/deal.II/include/deal.II/lac/parallel_vector.h +++ b/deal.II/include/deal.II/lac/parallel_vector.h @@ -919,7 +919,7 @@ namespace parallel */ VectorView vector_view; -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI /** * A vector that collects all requests from @p * compress() operations. This class uses diff --git a/deal.II/include/deal.II/lac/parallel_vector.templates.h b/deal.II/include/deal.II/lac/parallel_vector.templates.h index 10b601f0cd..5622d55ba2 100644 --- a/deal.II/include/deal.II/lac/parallel_vector.templates.h +++ b/deal.II/include/deal.II/lac/parallel_vector.templates.h @@ -28,7 +28,7 @@ namespace parallel void Vector::clear_mpi_requests () { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI for (unsigned int j=0; j::compress_start (const unsigned int counter) { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI const Utilities::MPI::Partitioner &part = *partitioner; // nothing to do when we neither have import @@ -283,7 +283,7 @@ namespace parallel void Vector::compress_finish (const bool add_ghost_data) { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI const Utilities::MPI::Partitioner &part = *partitioner; // nothing to do when we neither have import @@ -348,7 +348,7 @@ namespace parallel void Vector::update_ghost_values_start (const unsigned int counter) const { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI const Utilities::MPI::Partitioner &part = *partitioner; // nothing to do when we neither have import @@ -441,7 +441,7 @@ namespace parallel void Vector::update_ghost_values_finish () const { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI // wait for both sends and receives to // complete, even though only receives are // really necessary. this gives (much) better @@ -469,7 +469,7 @@ namespace parallel void Vector::swap (Vector &v) { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI // introduce a Barrier over all MPI processes // to make sure that the compress request are // no longer used before changing the owner @@ -541,7 +541,7 @@ namespace parallel // information in order, use as many barriers // as there are processors and start writing // when it's our turn -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI for (unsigned int i=0; ithis_mpi_process(); i++) MPI_Barrier (partitioner->get_communicator()); #endif @@ -570,7 +570,7 @@ namespace parallel << std::endl; out << std::endl << std::flush; -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI MPI_Barrier (partitioner->get_communicator()); for (unsigned int i=partitioner->this_mpi_process()+1; diff --git a/deal.II/include/deal.II/lac/petsc_block_sparse_matrix.h b/deal.II/include/deal.II/lac/petsc_block_sparse_matrix.h index c703fcd1cf..22e19d22c4 100644 --- a/deal.II/include/deal.II/lac/petsc_block_sparse_matrix.h +++ b/deal.II/include/deal.II/lac/petsc_block_sparse_matrix.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -392,6 +392,6 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC #endif // __deal2__petsc_block_sparse_matrix_h diff --git a/deal.II/include/deal.II/lac/petsc_block_vector.h b/deal.II/include/deal.II/lac/petsc_block_vector.h index 8847069092..788d8872b2 100644 --- a/deal.II/include/deal.II/lac/petsc_block_vector.h +++ b/deal.II/include/deal.II/lac/petsc_block_vector.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -512,6 +512,6 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC #endif diff --git a/deal.II/include/deal.II/lac/petsc_full_matrix.h b/deal.II/include/deal.II/lac/petsc_full_matrix.h index b9575a75dc..d9752523d0 100644 --- a/deal.II/include/deal.II/lac/petsc_full_matrix.h +++ b/deal.II/include/deal.II/lac/petsc_full_matrix.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -68,7 +68,7 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC /*---------------------------- petsc_full_matrix.h ---------------------------*/ diff --git a/deal.II/include/deal.II/lac/petsc_matrix_base.h b/deal.II/include/deal.II/lac/petsc_matrix_base.h index 16ca5aec2b..7715d722dd 100644 --- a/deal.II/include/deal.II/lac/petsc_matrix_base.h +++ b/deal.II/include/deal.II/lac/petsc_matrix_base.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -1870,7 +1870,7 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC /*---------------------------- petsc_matrix_base.h ---------------------------*/ diff --git a/deal.II/include/deal.II/lac/petsc_matrix_free.h b/deal.II/include/deal.II/lac/petsc_matrix_free.h index 2eec3536b7..c7217178d3 100644 --- a/deal.II/include/deal.II/lac/petsc_matrix_free.h +++ b/deal.II/include/deal.II/lac/petsc_matrix_free.h @@ -18,7 +18,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -368,7 +368,7 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC /*---------------------------- petsc_matrix_free.h ---------------------------*/ diff --git a/deal.II/include/deal.II/lac/petsc_parallel_block_sparse_matrix.h b/deal.II/include/deal.II/lac/petsc_parallel_block_sparse_matrix.h index 0274dd372b..ac317b1fc0 100644 --- a/deal.II/include/deal.II/lac/petsc_parallel_block_sparse_matrix.h +++ b/deal.II/include/deal.II/lac/petsc_parallel_block_sparse_matrix.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -386,6 +386,6 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC #endif // __deal2__petsc_parallel_block_sparse_matrix_h diff --git a/deal.II/include/deal.II/lac/petsc_parallel_block_vector.h b/deal.II/include/deal.II/lac/petsc_parallel_block_vector.h index d507f3947e..33482381d2 100644 --- a/deal.II/include/deal.II/lac/petsc_parallel_block_vector.h +++ b/deal.II/include/deal.II/lac/petsc_parallel_block_vector.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -539,6 +539,6 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC #endif diff --git a/deal.II/include/deal.II/lac/petsc_parallel_sparse_matrix.h b/deal.II/include/deal.II/lac/petsc_parallel_sparse_matrix.h index d3eb3a5780..29dded8591 100644 --- a/deal.II/include/deal.II/lac/petsc_parallel_sparse_matrix.h +++ b/deal.II/include/deal.II/lac/petsc_parallel_sparse_matrix.h @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -495,7 +495,7 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC /*---------------------------- petsc_parallel_sparse_matrix.h ---------------------------*/ diff --git a/deal.II/include/deal.II/lac/petsc_parallel_vector.h b/deal.II/include/deal.II/lac/petsc_parallel_vector.h index c779eeaec4..f2a3203eca 100644 --- a/deal.II/include/deal.II/lac/petsc_parallel_vector.h +++ b/deal.II/include/deal.II/lac/petsc_parallel_vector.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -615,7 +615,7 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC /*---------------------------- petsc_parallel_vector.h ---------------------------*/ diff --git a/deal.II/include/deal.II/lac/petsc_precondition.h b/deal.II/include/deal.II/lac/petsc_precondition.h index 402608ee22..2c2a51dc28 100644 --- a/deal.II/include/deal.II/lac/petsc_precondition.h +++ b/deal.II/include/deal.II/lac/petsc_precondition.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -1064,7 +1064,7 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC /*---------------------------- petsc_precondition.h ---------------------------*/ diff --git a/deal.II/include/deal.II/lac/petsc_solver.h b/deal.II/include/deal.II/lac/petsc_solver.h index f2806970f3..5c4a10a0f4 100644 --- a/deal.II/include/deal.II/lac/petsc_solver.h +++ b/deal.II/include/deal.II/lac/petsc_solver.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -1269,7 +1269,7 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC /*---------------------------- petsc_solver.h ---------------------------*/ diff --git a/deal.II/include/deal.II/lac/petsc_sparse_matrix.h b/deal.II/include/deal.II/lac/petsc_sparse_matrix.h index 03bab185e3..bd5e41fcae 100644 --- a/deal.II/include/deal.II/lac/petsc_sparse_matrix.h +++ b/deal.II/include/deal.II/lac/petsc_sparse_matrix.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -359,7 +359,7 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC /*---------------------------- petsc_sparse_matrix.h ---------------------------*/ diff --git a/deal.II/include/deal.II/lac/petsc_vector.h b/deal.II/include/deal.II/lac/petsc_vector.h index 3d1f9984a7..c7909f1f0c 100644 --- a/deal.II/include/deal.II/lac/petsc_vector.h +++ b/deal.II/include/deal.II/lac/petsc_vector.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -409,7 +409,7 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC /*---------------------------- petsc_vector.h ---------------------------*/ diff --git a/deal.II/include/deal.II/lac/petsc_vector_base.h b/deal.II/include/deal.II/lac/petsc_vector_base.h index f96b53d85c..3d22318d1a 100644 --- a/deal.II/include/deal.II/lac/petsc_vector_base.h +++ b/deal.II/include/deal.II/lac/petsc_vector_base.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -1218,7 +1218,7 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC /*---------------------------- petsc_vector_base.h ---------------------------*/ diff --git a/deal.II/include/deal.II/lac/slepc_solver.h b/deal.II/include/deal.II/lac/slepc_solver.h index 7c7a38f923..865296a36b 100644 --- a/deal.II/include/deal.II/lac/slepc_solver.h +++ b/deal.II/include/deal.II/lac/slepc_solver.h @@ -16,7 +16,7 @@ #include -#ifdef DEAL_II_USE_SLEPC +#ifdef DEAL_II_WITH_SLEPC # include # include @@ -693,7 +693,7 @@ namespace SLEPcWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_SLEPC +#endif // DEAL_II_WITH_SLEPC /*---------------------------- slepc_solver.h ---------------------------*/ diff --git a/deal.II/include/deal.II/lac/slepc_spectral_transformation.h b/deal.II/include/deal.II/lac/slepc_spectral_transformation.h index d890274aff..4b8683408b 100644 --- a/deal.II/include/deal.II/lac/slepc_spectral_transformation.h +++ b/deal.II/include/deal.II/lac/slepc_spectral_transformation.h @@ -17,7 +17,7 @@ #include -#ifdef DEAL_II_USE_SLEPC +#ifdef DEAL_II_WITH_SLEPC # include # include @@ -320,7 +320,7 @@ namespace SLEPcWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_SLEPC +#endif // DEAL_II_WITH_SLEPC /*-------------------- slepc_spectral_transformation.h ------------------*/ diff --git a/deal.II/include/deal.II/lac/sparse_direct.h b/deal.II/include/deal.II/lac/sparse_direct.h index d236fbd6c9..5a5d9d673e 100644 --- a/deal.II/include/deal.II/lac/sparse_direct.h +++ b/deal.II/include/deal.II/lac/sparse_direct.h @@ -23,7 +23,7 @@ #include #include -#ifdef DEAL_II_USE_MUMPS +#ifdef DEAL_II_WITH_MUMPS # include # include #endif @@ -1300,9 +1300,9 @@ class SparseDirectMUMPS { private: -#ifdef DEAL_II_USE_MUMPS +#ifdef DEAL_II_WITH_MUMPS DMUMPS_STRUC_C id; -#endif // DEAL_II_USE_MUMPS +#endif // DEAL_II_WITH_MUMPS double *a; double *rhs; diff --git a/deal.II/include/deal.II/lac/sparse_vanka.templates.h b/deal.II/include/deal.II/lac/sparse_vanka.templates.h index dd3d029329..6ae96146b4 100644 --- a/deal.II/include/deal.II/lac/sparse_vanka.templates.h +++ b/deal.II/include/deal.II/lac/sparse_vanka.templates.h @@ -62,7 +62,7 @@ template void SparseVanka::compute_inverses () { -#ifndef DEAL_II_USE_MT +#ifndef DEAL_II_WITH_THREADS compute_inverses (0, matrix->m()); #else const unsigned int n_inverses = std::count (selected.begin(), @@ -556,7 +556,7 @@ void SparseBlockVanka::vmult (Vector &dst, else // otherwise: blocking requested { -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS // spawn threads. since // some compilers have // trouble finding out diff --git a/deal.II/include/deal.II/lac/sparsity_tools.h b/deal.II/include/deal.II/lac/sparsity_tools.h index e65cd32405..38567d3702 100644 --- a/deal.II/include/deal.II/lac/sparsity_tools.h +++ b/deal.II/include/deal.II/lac/sparsity_tools.h @@ -18,7 +18,7 @@ #include -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI #include #include #endif @@ -195,7 +195,7 @@ namespace SparsityTools const std::vector &starting_indices = std::vector()); -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI /** * Communciate rows in a compressed * sparsity pattern over MPI. diff --git a/deal.II/include/deal.II/lac/swappable_vector.templates.h b/deal.II/include/deal.II/lac/swappable_vector.templates.h index 215cd5a28a..8be2192a61 100644 --- a/deal.II/include/deal.II/lac/swappable_vector.templates.h +++ b/deal.II/include/deal.II/lac/swappable_vector.templates.h @@ -145,7 +145,7 @@ void SwappableVector::reload () template void SwappableVector::alert () { -#ifndef DEAL_II_USE_MT +#ifndef DEAL_II_WITH_THREADS // note: this function does nothing // in non-MT mode return; @@ -186,7 +186,7 @@ void SwappableVector::reload_vector (const bool set_flag) this->block_read (tmp_in); tmp_in.close (); -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS // release the lock that was // acquired by the calling // functions diff --git a/deal.II/include/deal.II/lac/trilinos_block_sparse_matrix.h b/deal.II/include/deal.II/lac/trilinos_block_sparse_matrix.h index b49b57eb6c..f298dad0cc 100644 --- a/deal.II/include/deal.II/lac/trilinos_block_sparse_matrix.h +++ b/deal.II/include/deal.II/lac/trilinos_block_sparse_matrix.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include # include @@ -808,6 +808,6 @@ namespace TrilinosWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_TRILINOS +#endif // DEAL_II_WITH_TRILINOS #endif // __deal2__trilinos_block_sparse_matrix_h diff --git a/deal.II/include/deal.II/lac/trilinos_block_vector.h b/deal.II/include/deal.II/lac/trilinos_block_vector.h index 9583ff3d1b..378a4a0d71 100644 --- a/deal.II/include/deal.II/lac/trilinos_block_vector.h +++ b/deal.II/include/deal.II/lac/trilinos_block_vector.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include # include @@ -586,6 +586,6 @@ namespace TrilinosWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_TRILINOS +#endif // DEAL_II_WITH_TRILINOS #endif diff --git a/deal.II/include/deal.II/lac/trilinos_parallel_block_vector.h b/deal.II/include/deal.II/lac/trilinos_parallel_block_vector.h index b255f5aff2..937640f672 100644 --- a/deal.II/include/deal.II/lac/trilinos_parallel_block_vector.h +++ b/deal.II/include/deal.II/lac/trilinos_parallel_block_vector.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include # include @@ -533,6 +533,6 @@ namespace TrilinosWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_TRILINOS +#endif // DEAL_II_WITH_TRILINOS #endif diff --git a/deal.II/include/deal.II/lac/trilinos_precondition.h b/deal.II/include/deal.II/lac/trilinos_precondition.h index 4c349b1531..e958fc8e5e 100644 --- a/deal.II/include/deal.II/lac/trilinos_precondition.h +++ b/deal.II/include/deal.II/lac/trilinos_precondition.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include # include @@ -23,7 +23,7 @@ # include # include -# ifdef DEAL_II_COMPILER_SUPPORTS_MPI +# ifdef DEAL_II_WITH_MPI # include # else # include @@ -187,7 +187,7 @@ namespace TrilinosWrappers * needs to be copied from * deal.II format. */ -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI Epetra_MpiComm communicator; #else Epetra_SerialComm communicator; @@ -1642,7 +1642,7 @@ namespace TrilinosWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_TRILINOS +#endif // DEAL_II_WITH_TRILINOS /*---------------------------- trilinos_precondition.h ---------------------------*/ diff --git a/deal.II/include/deal.II/lac/trilinos_solver.h b/deal.II/include/deal.II/lac/trilinos_solver.h index 57c3798338..a0ed043623 100644 --- a/deal.II/include/deal.II/lac/trilinos_solver.h +++ b/deal.II/include/deal.II/lac/trilinos_solver.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include # include @@ -658,7 +658,7 @@ namespace TrilinosWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_TRILINOS +#endif // DEAL_II_WITH_TRILINOS /*---------------------------- trilinos_solver.h ---------------------------*/ diff --git a/deal.II/include/deal.II/lac/trilinos_sparse_matrix.h b/deal.II/include/deal.II/lac/trilinos_sparse_matrix.h index 13cfcae00a..36a7123ced 100644 --- a/deal.II/include/deal.II/lac/trilinos_sparse_matrix.h +++ b/deal.II/include/deal.II/lac/trilinos_sparse_matrix.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include # include @@ -34,7 +34,7 @@ # include # include # include -# ifdef DEAL_II_COMPILER_SUPPORTS_MPI +# ifdef DEAL_II_WITH_MPI # include # include "mpi.h" # else @@ -3971,7 +3971,7 @@ namespace TrilinosWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_TRILINOS +#endif // DEAL_II_WITH_TRILINOS /*----------------------- trilinos_sparse_matrix.h --------------------*/ diff --git a/deal.II/include/deal.II/lac/trilinos_sparsity_pattern.h b/deal.II/include/deal.II/lac/trilinos_sparsity_pattern.h index 38aacf23b0..0fc9641727 100644 --- a/deal.II/include/deal.II/lac/trilinos_sparsity_pattern.h +++ b/deal.II/include/deal.II/lac/trilinos_sparsity_pattern.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include # include @@ -29,7 +29,7 @@ # include # include -# ifdef DEAL_II_COMPILER_SUPPORTS_MPI +# ifdef DEAL_II_WITH_MPI # include # include "mpi.h" # else @@ -1850,7 +1850,7 @@ namespace TrilinosWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_TRILINOS +#endif // DEAL_II_WITH_TRILINOS /*-------------------- trilinos_sparsity_pattern.h --------------------*/ diff --git a/deal.II/include/deal.II/lac/trilinos_vector.h b/deal.II/include/deal.II/lac/trilinos_vector.h index de581cf460..374bc9a29b 100644 --- a/deal.II/include/deal.II/lac/trilinos_vector.h +++ b/deal.II/include/deal.II/lac/trilinos_vector.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include # include @@ -538,7 +538,7 @@ namespace TrilinosWrappers { vector.reset (new Epetra_FEVector(Epetra_Map (static_cast(v.size()), 0, -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI Epetra_MpiComm(MPI_COMM_SELF) #else Epetra_SerialComm() @@ -835,7 +835,7 @@ namespace TrilinosWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_TRILINOS +#endif // DEAL_II_WITH_TRILINOS /*---------------------------- trilinos_vector.h ---------------------------*/ diff --git a/deal.II/include/deal.II/lac/trilinos_vector_base.h b/deal.II/include/deal.II/lac/trilinos_vector_base.h index 7f2b5faa4c..172bc10777 100644 --- a/deal.II/include/deal.II/lac/trilinos_vector_base.h +++ b/deal.II/include/deal.II/lac/trilinos_vector_base.h @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS #include # include @@ -29,7 +29,7 @@ # define TrilinosScalar double # include "Epetra_ConfigDefs.h" -# ifdef DEAL_II_COMPILER_SUPPORTS_MPI // only if MPI is installed +# ifdef DEAL_II_WITH_MPI // only if MPI is installed # include "mpi.h" # include "Epetra_MpiComm.h" # else @@ -1265,7 +1265,7 @@ namespace TrilinosWrappers } #ifdef DEBUG -# ifdef DEAL_II_COMPILER_SUPPORTS_MPI +# ifdef DEAL_II_WITH_MPI // check that every process has decided // to use the same mode. This will // otherwise result in undefined @@ -1992,7 +1992,7 @@ namespace TrilinosWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_TRILINOS +#endif // DEAL_II_WITH_TRILINOS /*---------------------------- trilinos_vector_base.h ---------------------------*/ diff --git a/deal.II/include/deal.II/lac/vector.h b/deal.II/include/deal.II/lac/vector.h index 9e648e1419..05ebaa680d 100644 --- a/deal.II/include/deal.II/lac/vector.h +++ b/deal.II/include/deal.II/lac/vector.h @@ -28,7 +28,7 @@ DEAL_II_NAMESPACE_OPEN -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC namespace PETScWrappers { class Vector; @@ -39,7 +39,7 @@ namespace PETScWrappers } #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS namespace TrilinosWrappers { namespace MPI @@ -190,7 +190,7 @@ public: Vector (const Vector &v); #endif -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC /** * Another copy constructor: copy the * values from a sequential PETSc wrapper @@ -219,7 +219,7 @@ public: Vector (const PETScWrappers::MPI::Vector &v); #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS /** * Another copy constructor: copy * the values from a Trilinos @@ -427,7 +427,7 @@ public: */ Vector &operator= (const BlockVector &v); -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC /** * Another copy operator: copy the * values from a sequential PETSc @@ -462,7 +462,7 @@ public: #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS /** * Another copy operator: copy * the values from a (sequential diff --git a/deal.II/include/deal.II/lac/vector.templates.h b/deal.II/include/deal.II/lac/vector.templates.h index 301c64e05f..aadddeec7d 100644 --- a/deal.II/include/deal.II/lac/vector.templates.h +++ b/deal.II/include/deal.II/lac/vector.templates.h @@ -20,12 +20,12 @@ #include #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include #endif @@ -152,7 +152,7 @@ Vector::Vector (const Vector &v) #endif -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC template @@ -205,7 +205,7 @@ Vector::Vector (const PETScWrappers::MPI::Vector &v) #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS template Vector::Vector (const TrilinosWrappers::MPI::Vector &v) @@ -659,7 +659,7 @@ namespace internal } result = outer_results[0]; } -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS else if (vec_size > 4 * internal::Vector::minimum_parallel_grain_size) { // split the vector into smaller pieces to be @@ -1198,7 +1198,7 @@ Vector::operator = (const BlockVector &v) -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC template Vector & @@ -1243,7 +1243,7 @@ Vector::operator = (const PETScWrappers::MPI::Vector &v) #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS template Vector & diff --git a/deal.II/include/deal.II/matrix_free/mapping_info.templates.h b/deal.II/include/deal.II/matrix_free/mapping_info.templates.h index 8878b70eed..7c7a57292b 100644 --- a/deal.II/include/deal.II/matrix_free/mapping_info.templates.h +++ b/deal.II/include/deal.II/matrix_free/mapping_info.templates.h @@ -861,7 +861,7 @@ end_set: { // print_memory_statistics involves global communication, so we can // disable the check here only if no processor has any such data -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI unsigned int general_size_glob = 0, general_size_loc = jacobians.size(); MPI_Allreduce (&general_size_loc, &general_size_glob, 1, MPI_UNSIGNED, MPI_MAX, size_info.communicator); @@ -880,7 +880,7 @@ end_set: MemoryConsumption::memory_consumption (jacobians_grad_upper)); } -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI unsigned int quad_size_glob = 0, quad_size_loc = quadrature_points.size(); MPI_Allreduce (&quad_size_loc, &quad_size_glob, 1, MPI_UNSIGNED, MPI_MAX, size_info.communicator); diff --git a/deal.II/include/deal.II/matrix_free/matrix_free.h b/deal.II/include/deal.II/matrix_free/matrix_free.h index cab5642913..2ec5a1ac7f 100644 --- a/deal.II/include/deal.II/matrix_free/matrix_free.h +++ b/deal.II/include/deal.II/matrix_free/matrix_free.h @@ -33,7 +33,7 @@ #include #include -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS #include #include #include @@ -1792,7 +1792,7 @@ namespace internal } -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS // This defines the TBB data structures that are needed to schedule the // partition-partition variant @@ -2043,7 +2043,7 @@ namespace internal VectorStruct &dst; }; -#endif // DEAL_II_USE_MT +#endif // DEAL_II_WITH_THREADS } // end of namespace internal @@ -2062,7 +2062,7 @@ MatrixFree::cell_loop OutVector &dst, const InVector &src) const { -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS // Use multithreading if so requested and if there is enough work to do in // parallel (the code might hang if there are less than two chunks!) diff --git a/deal.II/include/deal.II/matrix_free/matrix_free.templates.h b/deal.II/include/deal.II/matrix_free/matrix_free.templates.h index a6c4f1915f..ccb397894f 100644 --- a/deal.II/include/deal.II/matrix_free/matrix_free.templates.h +++ b/deal.II/include/deal.II/matrix_free/matrix_free.templates.h @@ -72,7 +72,7 @@ namespace internal void assert_communicator_equality (const dealii::Triangulation &tria, const MPI_Comm &comm_mf) { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI const parallel::distributed::Triangulation *dist_tria = dynamic_cast*>(&tria); if (dist_tria != 0) @@ -136,7 +136,7 @@ internal_reinit(const Mapping &mapping, // initialize the basic multithreading information that needs to be // passed to the DoFInfo structure -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS if (additional_data.tasks_parallel_scheme != AdditionalData::none) { task_info.use_multithreading = true; @@ -231,7 +231,7 @@ internal_reinit(const Mapping &mapping, // initialize the basic multithreading information that needs to be // passed to the DoFInfo structure -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS if (additional_data.tasks_parallel_scheme != AdditionalData::none) { task_info.use_multithreading = true; @@ -913,7 +913,7 @@ namespace internal /* // try to balance the number of cells before and after the boundary part // on each processor. probably not worth it! - #ifdef DEAL_II_COMPILER_SUPPORTS_MPI + #ifdef DEAL_II_WITH_MPI MPI_Allreduce (&n_boundary_cells, &n_max_boundary_cells, 1, MPI_UNSIGNED, MPI_MAX, size_info.communicator); #endif diff --git a/deal.II/include/deal.II/multigrid/mg_transfer.h b/deal.II/include/deal.II/multigrid/mg_transfer.h index b4117d4ea0..8ea9888b27 100644 --- a/deal.II/include/deal.II/multigrid/mg_transfer.h +++ b/deal.II/include/deal.II/multigrid/mg_transfer.h @@ -45,7 +45,7 @@ namespace internal typedef ::dealii::SparseMatrix Matrix; }; -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS template <> struct MatrixSelector { diff --git a/deal.II/include/deal.II/multigrid/mg_transfer.templates.h b/deal.II/include/deal.II/multigrid/mg_transfer.templates.h index 5b00fb46c6..eac5bb03d7 100644 --- a/deal.II/include/deal.II/multigrid/mg_transfer.templates.h +++ b/deal.II/include/deal.II/multigrid/mg_transfer.templates.h @@ -101,7 +101,7 @@ namespace } } -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS /** * Adjust vectors on all levels to * correct size. Here, we just @@ -121,7 +121,7 @@ namespace (&mg_dof.get_tria())); AssertThrow(tria!=NULL, ExcMessage("multigrid with Trilinos vectors only works with distributed Triangulation!")); -#ifdef DEAL_II_USE_P4EST +#ifdef DEAL_II_WITH_P4EST for (unsigned int level=v.min_level(); level<=v.max_level(); ++level) { diff --git a/deal.II/include/deal.II/numerics/matrix_tools.h b/deal.II/include/deal.II/numerics/matrix_tools.h index 96975a55fb..38be9336e2 100644 --- a/deal.II/include/deal.II/numerics/matrix_tools.h +++ b/deal.II/include/deal.II/numerics/matrix_tools.h @@ -46,7 +46,7 @@ namespace hp } -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC namespace PETScWrappers { class SparseMatrix; @@ -61,7 +61,7 @@ namespace PETScWrappers } #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS namespace TrilinosWrappers { class SparseMatrix; @@ -828,7 +828,7 @@ namespace MatrixTools BlockVector &right_hand_side, const bool eliminate_columns = true); -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC /** * Apply dirichlet boundary conditions to * the system matrix and vectors as @@ -928,7 +928,7 @@ namespace MatrixTools #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS /** * Apply dirichlet boundary * conditions to the system matrix diff --git a/deal.II/include/deal.II/numerics/vector_tools.templates.h b/deal.II/include/deal.II/numerics/vector_tools.templates.h index 1122d97729..b62546dbe2 100644 --- a/deal.II/include/deal.II/numerics/vector_tools.templates.h +++ b/deal.II/include/deal.II/numerics/vector_tools.templates.h @@ -5671,7 +5671,7 @@ namespace VectorTools } } -#ifdef DEAL_II_USE_P4EST +#ifdef DEAL_II_WITH_P4EST // if this was a distributed // DoFHandler, we need to do the // reduction over the entire domain diff --git a/deal.II/source/base/data_out_base.cc b/deal.II/source/base/data_out_base.cc index 6c2f998438..6ce14e028e 100644 --- a/deal.II/source/base/data_out_base.cc +++ b/deal.II/source/base/data_out_base.cc @@ -48,11 +48,11 @@ // we use uint32_t and uint8_t below, which are declared here: #include -#ifdef HAVE_LIBZ +#ifdef DEAL_II_WITH_ZLIB # include #endif -#ifdef DEAL_II_HAVE_HDF5 +#ifdef DEAL_II_WITH_HDF5 #include #endif @@ -218,7 +218,7 @@ namespace -#ifdef HAVE_LIBZ +#ifdef DEAL_II_WITH_ZLIB /** * Do a zlib compression followed * by a base64 encoding of the @@ -1435,7 +1435,7 @@ namespace VtuStream::write_point (const unsigned int, const Point &p) { -#if !defined(HAVE_LIBZ) +#if !defined(DEAL_II_WITH_ZLIB) // write out coordinates stream << p; // fill with zeroes @@ -1457,7 +1457,7 @@ namespace void VtuStream::flush_points () { -#ifdef HAVE_LIBZ +#ifdef DEAL_II_WITH_ZLIB // compress the data we have in // memory and write them to the // stream. then release the data @@ -1476,7 +1476,7 @@ namespace unsigned int d2, unsigned int d3) { -#if !defined(HAVE_LIBZ) +#if !defined(DEAL_II_WITH_ZLIB) stream << start << '\t' << start+d1; if (dim>=2) @@ -1515,7 +1515,7 @@ namespace void VtuStream::flush_cells () { -#ifdef HAVE_LIBZ +#ifdef DEAL_II_WITH_ZLIB // compress the data we have in // memory and write them to the // stream. then release the data @@ -1529,7 +1529,7 @@ namespace std::ostream & VtuStream::operator<< (const std::vector &data) { -#ifdef HAVE_LIBZ +#ifdef DEAL_II_WITH_ZLIB // compress the data we have in // memory and write them to the // stream. then release the data @@ -2481,7 +2481,7 @@ void DataOutBase::write_ucd (const std::vector > &patches, { AssertThrow (out, ExcIO()); -#ifndef DEAL_II_COMPILER_SUPPORTS_MPI +#ifndef DEAL_II_WITH_MPI // verify that there are indeed // patches to be written out. most // of the times, people just forget @@ -2580,7 +2580,7 @@ void DataOutBase::write_dx (const std::vector > &patches, { AssertThrow (out, ExcIO()); -#ifndef DEAL_II_COMPILER_SUPPORTS_MPI +#ifndef DEAL_II_WITH_MPI // verify that there are indeed // patches to be written out. most // of the times, people just forget @@ -2878,7 +2878,7 @@ void DataOutBase::write_gnuplot (const std::vector > &patche { AssertThrow (out, ExcIO()); -#ifndef DEAL_II_COMPILER_SUPPORTS_MPI +#ifndef DEAL_II_WITH_MPI // verify that there are indeed // patches to be written out. most // of the times, people just forget @@ -3113,7 +3113,7 @@ void DataOutBase::write_povray (const std::vector > &patches { AssertThrow (out, ExcIO()); -#ifndef DEAL_II_COMPILER_SUPPORTS_MPI +#ifndef DEAL_II_WITH_MPI // verify that there are indeed // patches to be written out. most // of the times, people just forget @@ -3480,7 +3480,7 @@ void DataOutBase::write_eps (const std::vector > &patches, { Assert (out, ExcIO()); -#ifndef DEAL_II_COMPILER_SUPPORTS_MPI +#ifndef DEAL_II_WITH_MPI // verify that there are indeed // patches to be written out. most // of the times, people just forget @@ -3862,7 +3862,7 @@ void DataOutBase::write_gmv (const std::vector > &patches, Assert(dim<=3, ExcNotImplemented()); AssertThrow (out, ExcIO()); -#ifndef DEAL_II_COMPILER_SUPPORTS_MPI +#ifndef DEAL_II_WITH_MPI // verify that there are indeed // patches to be written out. most // of the times, people just forget @@ -4016,7 +4016,7 @@ void DataOutBase::write_tecplot (const std::vector > &patche { AssertThrow (out, ExcIO()); -#ifndef DEAL_II_COMPILER_SUPPORTS_MPI +#ifndef DEAL_II_WITH_MPI // verify that there are indeed // patches to be written out. most // of the times, people just forget @@ -4303,7 +4303,7 @@ void DataOutBase::write_tecplot_binary (const std::vector > AssertThrow (out, ExcIO()); -#ifndef DEAL_II_COMPILER_SUPPORTS_MPI +#ifndef DEAL_II_WITH_MPI // verify that there are indeed // patches to be written out. most // of the times, people just forget @@ -4610,7 +4610,7 @@ DataOutBase::write_vtk (const std::vector > &patches, { AssertThrow (out, ExcIO()); -#ifndef DEAL_II_COMPILER_SUPPORTS_MPI +#ifndef DEAL_II_WITH_MPI // verify that there are indeed // patches to be written out. most // of the times, people just forget @@ -4867,7 +4867,7 @@ void DataOutBase::write_vtu_header (std::ostream &out) << "\n-->\n"; out << " > &patch { AssertThrow (out, ExcIO()); -#ifndef DEAL_II_COMPILER_SUPPORTS_MPI +#ifndef DEAL_II_WITH_MPI // verify that there are indeed // patches to be written out. most // of the times, people just forget @@ -5008,7 +5008,7 @@ void DataOutBase::write_vtu_main (const std::vector > &patch patches[0].data.n_rows())); -#ifdef HAVE_LIBZ +#ifdef DEAL_II_WITH_ZLIB const char *ascii_or_binary = "binary"; #else const char *ascii_or_binary = "ascii"; @@ -5097,7 +5097,7 @@ void DataOutBase::write_vtu_main (const std::vector > &patch // uint8_t might be a typedef to unsigned // char which is then not printed as // ascii integers -#ifdef HAVE_LIBZ +#ifdef DEAL_II_WITH_ZLIB std::vector cell_types (n_cells, static_cast(vtk_cell_type[dim])); #else @@ -5473,7 +5473,7 @@ void DataOutInterface::write_vtu (std::ostream &out) const template void DataOutInterface::write_vtu_in_parallel (const char *filename, MPI_Comm comm) const { -#ifndef DEAL_II_COMPILER_SUPPORTS_MPI +#ifndef DEAL_II_WITH_MPI //without MPI fall back to the normal way to write a vtu file: (void)comm; @@ -5718,7 +5718,7 @@ XDMFEntry DataOutBase::create_xdmf_entry (const std::vector const unsigned int n_data_sets = data_names.size(); int myrank; -#ifndef DEAL_II_HAVE_HDF5 +#ifndef DEAL_II_WITH_HDF5 // throw an exception, but first make // sure the compiler does not warn about // the now unused function arguments @@ -5735,7 +5735,7 @@ XDMFEntry DataOutBase::create_xdmf_entry (const std::vector compute_sizes(patches, local_node_cell_count[0], local_node_cell_count[1]); // And compute the global total -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI MPI_Comm_rank(comm, &myrank); MPI_Allreduce(local_node_cell_count, global_node_cell_count, 2, MPI_UNSIGNED, MPI_SUM, comm); #else @@ -5826,7 +5826,7 @@ void DataOutBase::write_xdmf_file (const std::vector > &, { int myrank; -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI MPI_Comm_rank(comm, &myrank); #else (void)comm; @@ -5909,7 +5909,7 @@ template void DataOutInterface:: write_hdf5_parallel (const char *filename, MPI_Comm comm) const { -#ifndef DEAL_II_HAVE_HDF5 +#ifndef DEAL_II_WITH_HDF5 AssertThrow(false, ExcMessage ("HDF5 support is disabled.")); #endif DataOutBase::write_hdf5_parallel(get_patches(), get_dataset_names(), @@ -5924,7 +5924,7 @@ void DataOutBase::write_hdf5_parallel (const std::vector > & const char *filename, MPI_Comm comm) { -#ifndef DEAL_II_HAVE_HDF5 +#ifndef DEAL_II_WITH_HDF5 // throw an exception, but first make // sure the compiler does not warn about // the now unused function arguments @@ -5946,7 +5946,7 @@ void DataOutBase::write_hdf5_parallel (const std::vector > & // If HDF5 is not parallel and we're using multiple processes, abort #ifndef H5_HAVE_PARALLEL -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI int world_size; MPI_Comm_size(comm, &world_size); AssertThrow (world_size <= 1, @@ -5964,7 +5964,7 @@ void DataOutBase::write_hdf5_parallel (const std::vector > & plist_id = H5Pcreate(H5P_FILE_ACCESS); AssertThrow(plist_id != -1, ExcIO()); // If MPI is enabled *and* HDF5 is parallel, we can do parallel output -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI #ifdef H5_HAVE_PARALLEL // Set the access to use the specified MPI_Comm object status = H5Pset_fapl_mpio(plist_id, comm, MPI_INFO_NULL); @@ -5980,7 +5980,7 @@ void DataOutBase::write_hdf5_parallel (const std::vector > & // Compute the global total number of nodes/cells // And determine the offset of the data for this process -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI MPI_Allreduce(local_node_cell_count, global_node_cell_count, 2, MPI_UNSIGNED, MPI_SUM, comm); MPI_Scan(local_node_cell_count, global_node_cell_offsets, 2, MPI_UNSIGNED, MPI_SUM, comm); global_node_cell_offsets[0] -= local_node_cell_count[0]; @@ -6056,7 +6056,7 @@ void DataOutBase::write_hdf5_parallel (const std::vector > & // Create the property list for a collective write plist_id = H5Pcreate(H5P_DATASET_XFER); AssertThrow(plist_id >= 0, ExcIO()); -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI #ifdef H5_HAVE_PARALLEL status = H5Pset_dxpl_mpio(plist_id, H5FD_MPIO_COLLECTIVE); AssertThrow(status >= 0, ExcIO()); diff --git a/deal.II/source/base/function_parser.cc b/deal.II/source/base/function_parser.cc index 13630cf90a..72a1717f9a 100644 --- a/deal.II/source/base/function_parser.cc +++ b/deal.II/source/base/function_parser.cc @@ -15,7 +15,7 @@ #include #include -#ifdef HAVE_FUNCTIONPARSER +#ifdef DEAL_II_WITH_FUNCTIONPARSER #include namespace fparser { @@ -55,7 +55,7 @@ FunctionParser::~FunctionParser() } -#ifdef HAVE_FUNCTIONPARSER +#ifdef DEAL_II_WITH_FUNCTIONPARSER template void FunctionParser::initialize (const std::string &variables, const std::vector &expressions, diff --git a/deal.II/source/base/index_set.cc b/deal.II/source/base/index_set.cc index 2b1c3f0d53..0767f106f9 100644 --- a/deal.II/source/base/index_set.cc +++ b/deal.II/source/base/index_set.cc @@ -16,8 +16,8 @@ #include #include -#ifdef DEAL_II_USE_TRILINOS -# ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_TRILINOS +# ifdef DEAL_II_WITH_MPI # include # endif # include @@ -371,7 +371,7 @@ void IndexSet::fill_index_vector(std::vector &indices) const -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS Epetra_Map IndexSet::make_trilinos_map (const MPI_Comm &communicator, @@ -383,7 +383,7 @@ IndexSet::make_trilinos_map (const MPI_Comm &communicator, return Epetra_Map (static_cast(size()), static_cast(n_elements()), 0, -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI Epetra_MpiComm(communicator)); #else Epetra_SerialComm()); @@ -401,7 +401,7 @@ IndexSet::make_trilinos_map (const MPI_Comm &communicator, : 0), 0, -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI Epetra_MpiComm(communicator)); #else Epetra_SerialComm()); diff --git a/deal.II/source/base/logstream.cc b/deal.II/source/base/logstream.cc index 67852cb616..475e30ffa5 100644 --- a/deal.II/source/base/logstream.cc +++ b/deal.II/source/base/logstream.cc @@ -137,7 +137,7 @@ LogStream::~LogStream() // deliberate memory leak and // instead destroying an empty // object -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS if (this == &deallog) { stream_map_type *dummy = new stream_map_type(); diff --git a/deal.II/source/base/mpi.cc b/deal.II/source/base/mpi.cc index ed1d846780..4d1a83c771 100644 --- a/deal.II/source/base/mpi.cc +++ b/deal.II/source/base/mpi.cc @@ -19,8 +19,8 @@ #include #include -#ifdef DEAL_II_USE_TRILINOS -# ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_TRILINOS +# ifdef DEAL_II_WITH_MPI # include # include # include @@ -28,8 +28,8 @@ # endif #endif -#ifdef DEAL_II_USE_PETSC -# ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_PETSC +# ifdef DEAL_II_WITH_MPI # include # include # include @@ -38,8 +38,8 @@ # endif #endif -#ifdef DEAL_II_USE_SLEPC -# ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_SLEPC +# ifdef DEAL_II_WITH_MPI # include # endif #endif @@ -52,7 +52,7 @@ namespace Utilities namespace MPI { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI // Unfortunately, we have to work // around an oddity in the way PETSc // and some gcc versions interact. If @@ -317,11 +317,11 @@ namespace Utilities ExcMessage ("You can only create a single object of this class " "in a program since it initializes the MPI system.")); -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI // if we have PETSc, we will initialize it and let it handle MPI. // Otherwise, we will do it. -#ifdef DEAL_II_USE_PETSC -# ifdef DEAL_II_USE_SLEPC +#ifdef DEAL_II_WITH_PETSC +# ifdef DEAL_II_WITH_SLEPC // Initialise SLEPc (with PETSc): SlepcInitialize(&argc, &argv, PETSC_NULL, PETSC_NULL); # else @@ -353,14 +353,14 @@ namespace Utilities MPI_InitFinalize::~MPI_InitFinalize() { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI // make memory pool release all MPI-based vectors that are no // longer used at this point. this is relevant because the // static object destructors run for these vectors at the end of // the program would run after MPI_Finalize is called, leading // to errors -# if defined(DEAL_II_USE_TRILINOS) +# if defined(DEAL_II_WITH_TRILINOS) GrowingVectorMemory ::release_unused_memory (); GrowingVectorMemory @@ -373,7 +373,7 @@ namespace Utilities // calling PETScFinalize. running the calls below after // PetscFinalize has already been called will therefore // yield errors of double deallocations -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC if ((PetscInitializeCalled == PETSC_TRUE) && (PetscFinalizeCalled == PETSC_FALSE)) @@ -387,7 +387,7 @@ namespace Utilities GrowingVectorMemory ::release_unused_memory (); -# ifdef DEAL_II_USE_SLEPC +# ifdef DEAL_II_WITH_SLEPC // and now end SLEPc (with PETSc) SlepcFinalize(); # else diff --git a/deal.II/source/base/multithread_info.cc b/deal.II/source/base/multithread_info.cc index 7bc1a74e28..78ef8a56ea 100644 --- a/deal.II/source/base/multithread_info.cc +++ b/deal.II/source/base/multithread_info.cc @@ -27,7 +27,7 @@ DEAL_II_NAMESPACE_OPEN -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS /* Detecting how many processors a given machine has is something that varies greatly between operating systems. For a few operating diff --git a/deal.II/source/base/partitioner.cc b/deal.II/source/base/partitioner.cc index c9d482967f..40cb4ebd1a 100644 --- a/deal.II/source/base/partitioner.cc +++ b/deal.II/source/base/partitioner.cc @@ -147,7 +147,7 @@ namespace Utilities // find out the end index for each processor // and communicate it (this implies the start // index for the next processor) -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI if (n_procs < 2) { Assert (ghost_indices_data.n_elements() == 0, ExcInternalError()); diff --git a/deal.II/source/base/subscriptor.cc b/deal.II/source/base/subscriptor.cc index bb4638541a..17278853fa 100644 --- a/deal.II/source/base/subscriptor.cc +++ b/deal.II/source/base/subscriptor.cc @@ -147,7 +147,7 @@ void Subscriptor::do_subscribe (const char *id) const Threads::Mutex::ScopedLock lock (subscription_lock); ++counter; -#ifndef DEAL_II_USE_MT +#ifndef DEAL_II_WITH_THREADS const char *const name = (id != 0) ? id : unknown_subscriber; map_iterator it = counter_map.find(name); @@ -174,7 +174,7 @@ void Subscriptor::do_unsubscribe (const char *id) const Threads::Mutex::ScopedLock lock (subscription_lock); --counter; -#ifndef DEAL_II_USE_MT +#ifndef DEAL_II_WITH_THREADS map_iterator it = counter_map.find(name); Assert (it != counter_map.end(), ExcNoSubscriber(object_info->name(), name)); Assert (it->second > 0, ExcNoSubscriber(object_info->name(), name)); @@ -193,7 +193,7 @@ unsigned int Subscriptor::n_subscriptions () const void Subscriptor::list_subscribers () const { -#ifndef DEAL_II_USE_MT +#ifndef DEAL_II_WITH_THREADS for (map_iterator it = counter_map.begin(); it != counter_map.end(); ++it) deallog << it->second << '/' diff --git a/deal.II/source/base/thread_management.cc b/deal.II/source/base/thread_management.cc index da4db796a2..47a3859120 100644 --- a/deal.II/source/base/thread_management.cc +++ b/deal.II/source/base/thread_management.cc @@ -147,7 +147,7 @@ namespace Threads -#ifndef DEAL_II_USE_MT +#ifndef DEAL_II_WITH_THREADS DummyBarrier::DummyBarrier (const unsigned int count, const char *, void *) diff --git a/deal.II/source/base/timer.cc b/deal.II/source/base/timer.cc index 633b1a32d7..2cdda32570 100644 --- a/deal.II/source/base/timer.cc +++ b/deal.II/source/base/timer.cc @@ -44,7 +44,7 @@ Timer::Timer() : cumulative_time (0.), cumulative_wall_time (0.) -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI , mpi_communicator (MPI_COMM_SELF) , sync_wall_time (false) #endif @@ -56,7 +56,7 @@ Timer::Timer() // in case we use an MPI compiler, use // the communicator given from input -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI Timer::Timer(MPI_Comm mpi_communicator, bool sync_wall_time_) : @@ -105,7 +105,7 @@ void Timer::start () { running = true; -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI if (sync_wall_time) MPI_Barrier(mpi_communicator); #endif @@ -168,7 +168,7 @@ double Timer::stop () # error Unsupported platform. Porting not finished. #endif -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI if (sync_wall_time && Utilities::System::job_supports_mpi()) { this->mpi_data @@ -271,7 +271,7 @@ TimerOutput::TimerOutput (std::ostream &stream, output_type (output_type), out_stream (stream, true), output_is_enabled (true) -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI , mpi_communicator (MPI_COMM_SELF) #endif {} @@ -286,13 +286,13 @@ TimerOutput::TimerOutput (ConditionalOStream &stream, output_type (output_type), out_stream (stream), output_is_enabled (true) -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI , mpi_communicator (MPI_COMM_SELF) #endif {} -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI TimerOutput::TimerOutput (MPI_Comm mpi_communicator, std::ostream &stream, diff --git a/deal.II/source/base/utilities.cc b/deal.II/source/base/utilities.cc index a934b69c96..47db7dd009 100644 --- a/deal.II/source/base/utilities.cc +++ b/deal.II/source/base/utilities.cc @@ -34,8 +34,8 @@ #endif -#ifdef DEAL_II_USE_TRILINOS -# ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_TRILINOS +# ifdef DEAL_II_WITH_MPI # include # include # include @@ -557,7 +557,7 @@ namespace Utilities bool job_supports_mpi () { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI int MPI_has_been_started = 0; MPI_Initialized(&MPI_has_been_started); @@ -599,14 +599,14 @@ namespace Utilities } -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS namespace Trilinos { const Epetra_Comm & comm_world() { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI static Teuchos::RCP communicator = Teuchos::rcp (new Epetra_MpiComm (MPI_COMM_WORLD), true); #else @@ -622,7 +622,7 @@ namespace Utilities const Epetra_Comm & comm_self() { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI static Teuchos::RCP communicator = Teuchos::rcp (new Epetra_MpiComm (MPI_COMM_SELF), true); #else @@ -638,7 +638,7 @@ namespace Utilities Epetra_Comm * duplicate_communicator (const Epetra_Comm &communicator) { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI // see if the communicator is in fact a // parallel MPI communicator; if so, @@ -671,7 +671,7 @@ namespace Utilities // communicator if this whole // thing was created as an MPI // communicator -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI Epetra_MpiComm *mpi_comm = dynamic_cast(&communicator); if (mpi_comm != 0) diff --git a/deal.II/source/distributed/grid_refinement.cc b/deal.II/source/distributed/grid_refinement.cc index ecd73bb4d2..28acfffcd6 100644 --- a/deal.II/source/distributed/grid_refinement.cc +++ b/deal.II/source/distributed/grid_refinement.cc @@ -21,7 +21,7 @@ #include #include -#ifdef DEAL_II_USE_P4EST +#ifdef DEAL_II_WITH_P4EST #include #include diff --git a/deal.II/source/distributed/solution_transfer.cc b/deal.II/source/distributed/solution_transfer.cc index 7348b401a3..c328a6e230 100644 --- a/deal.II/source/distributed/solution_transfer.cc +++ b/deal.II/source/distributed/solution_transfer.cc @@ -13,7 +13,7 @@ #include -#ifdef DEAL_II_USE_P4EST +#ifdef DEAL_II_WITH_P4EST #include #include diff --git a/deal.II/source/distributed/solution_transfer.inst.in b/deal.II/source/distributed/solution_transfer.inst.in index 746ca2552e..70d0ef4fab 100644 --- a/deal.II/source/distributed/solution_transfer.inst.in +++ b/deal.II/source/distributed/solution_transfer.inst.in @@ -26,7 +26,7 @@ for (deal_II_dimension : DIMENSIONS) template class SolutionTransfer, DoFHandler >; -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC template class SolutionTransfer >; template class SolutionTransfer >; @@ -36,7 +36,7 @@ for (deal_II_dimension : DIMENSIONS) template class SolutionTransfer >; #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS template class SolutionTransfer >; template class SolutionTransfer >; diff --git a/deal.II/source/distributed/tria.cc b/deal.II/source/distributed/tria.cc index e43d03dc29..ebc48f1483 100644 --- a/deal.II/source/distributed/tria.cc +++ b/deal.II/source/distributed/tria.cc @@ -22,7 +22,7 @@ #include #include -#ifdef DEAL_II_USE_P4EST +#ifdef DEAL_II_WITH_P4EST # include # include # include @@ -45,7 +45,7 @@ DEAL_II_NAMESPACE_OPEN -#ifdef DEAL_II_USE_P4EST +#ifdef DEAL_II_WITH_P4EST namespace internal { @@ -3424,7 +3424,7 @@ namespace parallel } -#else // DEAL_II_USE_P4EST +#else // DEAL_II_WITH_P4EST namespace parallel { @@ -3454,7 +3454,7 @@ namespace parallel } -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI template MPI_Comm Triangulation::get_communicator () const @@ -3466,7 +3466,7 @@ namespace parallel } } -#endif // DEAL_II_USE_P4EST +#endif // DEAL_II_WITH_P4EST diff --git a/deal.II/source/distributed/tria.inst.in b/deal.II/source/distributed/tria.inst.in index 15733e9d50..9f1eae89b8 100644 --- a/deal.II/source/distributed/tria.inst.in +++ b/deal.II/source/distributed/tria.inst.in @@ -15,7 +15,7 @@ for (deal_II_dimension : DIMENSIONS) { -# ifdef DEAL_II_USE_P4EST +# ifdef DEAL_II_WITH_P4EST namespace internal \{ @@ -47,7 +47,7 @@ for (deal_II_dimension : DIMENSIONS) # endif \} \} -# endif // DEAL_II_USE_P4EST +# endif // DEAL_II_WITH_P4EST namespace parallel \{ diff --git a/deal.II/source/dofs/dof_handler_policy.cc b/deal.II/source/dofs/dof_handler_policy.cc index 9c5cc034c4..70050665a6 100644 --- a/deal.II/source/dofs/dof_handler_policy.cc +++ b/deal.II/source/dofs/dof_handler_policy.cc @@ -958,7 +958,7 @@ namespace internal /* --------------------- class ParallelDistributed ---------------- */ -#ifdef DEAL_II_USE_P4EST +#ifdef DEAL_II_WITH_P4EST namespace { @@ -1445,7 +1445,7 @@ namespace internal const std::vector &coarse_cell_to_p4est_tree_permutation, const std::vector &p4est_tree_to_coarse_cell_permutation) { -#ifndef DEAL_II_USE_P4EST +#ifndef DEAL_II_WITH_P4EST (void)vertices_with_ghost_neighbors; Assert (false, ExcNotImplemented()); #else @@ -1669,7 +1669,7 @@ namespace internal const std::vector &p4est_tree_to_coarse_cell_permutation, const unsigned int level) { -#ifndef DEAL_II_USE_P4EST +#ifndef DEAL_II_WITH_P4EST (void)vertices_with_ghost_neighbors; Assert (false, ExcNotImplemented()); #else @@ -1878,7 +1878,7 @@ namespace internal } -#endif // DEAL_II_USE_P4EST +#endif // DEAL_II_WITH_P4EST @@ -1889,7 +1889,7 @@ namespace internal { NumberCache number_cache; -#ifndef DEAL_II_USE_P4EST +#ifndef DEAL_II_WITH_P4EST (void)dof_handler; Assert (false, ExcNotImplemented()); #else @@ -2110,7 +2110,7 @@ namespace internal } } #endif // DEBUG -#endif // DEAL_II_USE_P4EST +#endif // DEAL_II_WITH_P4EST return number_cache; } @@ -2122,7 +2122,7 @@ namespace internal distribute_mg_dofs (DoFHandler &dof_handler, std::vector &number_caches) const { -#ifndef DEAL_II_USE_P4EST +#ifndef DEAL_II_WITH_P4EST (void)dof_handler; (void)number_caches; Assert (false, ExcNotImplemented()); @@ -2358,7 +2358,7 @@ namespace internal } -#endif // DEAL_II_USE_P4EST +#endif // DEAL_II_WITH_P4EST } @@ -2373,7 +2373,7 @@ namespace internal NumberCache number_cache; -#ifndef DEAL_II_USE_P4EST +#ifndef DEAL_II_WITH_P4EST Assert (false, ExcNotImplemented()); #else diff --git a/deal.II/source/dofs/dof_renumbering.cc b/deal.II/source/dofs/dof_renumbering.cc index 3f0d782f33..8295743bfa 100644 --- a/deal.II/source/dofs/dof_renumbering.cc +++ b/deal.II/source/dofs/dof_renumbering.cc @@ -718,7 +718,7 @@ namespace DoFRenumbering = (dynamic_cast*> (&start->get_dof_handler().get_tria()))) { -#ifdef DEAL_II_USE_P4EST +#ifdef DEAL_II_WITH_P4EST std::vector local_dof_count(n_buckets); for (unsigned int c=0; c*> (&start->get_dof_handler().get_tria()))) { -#ifdef DEAL_II_USE_P4EST +#ifdef DEAL_II_WITH_P4EST std::vector local_dof_count(n_buckets); for (unsigned int c=0; cn_cells (0); ++c) diff --git a/deal.II/source/dofs/dof_tools.cc b/deal.II/source/dofs/dof_tools.cc index b9fea91748..45a2e0406f 100644 --- a/deal.II/source/dofs/dof_tools.cc +++ b/deal.II/source/dofs/dof_tools.cc @@ -3008,7 +3008,7 @@ namespace DoFTools Assert (0<=direction && direction *tria diff --git a/deal.II/source/fe/fe_tools.cc b/deal.II/source/fe/fe_tools.cc index 26ed3a42fa..6edaecf2a3 100644 --- a/deal.II/source/fe/fe_tools.cc +++ b/deal.II/source/fe/fe_tools.cc @@ -1298,7 +1298,7 @@ namespace FETools Assert(u2.size()==dof2.n_dofs(), ExcDimensionMismatch(u2.size(), dof2.n_dofs())); -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC if (dynamic_cast(&u1) != 0) if (dynamic_cast*>(&dof1) != 0) { @@ -1459,7 +1459,7 @@ namespace FETools Assert(u1_interpolated.size()==dof1.n_dofs(), ExcDimensionMismatch(u1_interpolated.size(), dof1.n_dofs())); -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC if (dynamic_cast(&u1) != 0) if (dynamic_cast*>(&dof1) != 0) { @@ -1539,7 +1539,7 @@ namespace FETools Assert(u1_interpolated.size() == dof1.n_dofs(), ExcDimensionMismatch(u1_interpolated.size(), dof1.n_dofs())); -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC if (dynamic_cast(&u1) != 0) if (dynamic_cast*>(&dof1) != 0) { @@ -1656,7 +1656,7 @@ namespace FETools // interpolate back to dof1 // taking into account // constraints1 -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC if (dynamic_cast(&u1) != 0) { AssertThrow (dynamic_cast(&u1_interpolated) != 0, @@ -1701,7 +1701,7 @@ namespace FETools Assert(u1_difference.size()==dof1.n_dofs(), ExcDimensionMismatch(u1_difference.size(), dof1.n_dofs())); -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC if (dynamic_cast(&u1) != 0) if (dynamic_cast*>(&dof1) != 0) { diff --git a/deal.II/source/fe/fe_tools.inst.in b/deal.II/source/fe/fe_tools.inst.in index f54ca54f59..b78de54520 100644 --- a/deal.II/source/fe/fe_tools.inst.in +++ b/deal.II/source/fe/fe_tools.inst.in @@ -217,7 +217,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS Vector &); -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC template void interpolate @@ -252,7 +252,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS template void interpolate @@ -389,7 +389,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS Vector &); -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS template void interpolate diff --git a/deal.II/source/fe/mapping_q1_eulerian.inst.in b/deal.II/source/fe/mapping_q1_eulerian.inst.in index cef3b9ec3d..e479e35903 100644 --- a/deal.II/source/fe/mapping_q1_eulerian.inst.in +++ b/deal.II/source/fe/mapping_q1_eulerian.inst.in @@ -17,7 +17,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS #if deal_II_dimension <= deal_II_space_dimension template class MappingQ1Eulerian, deal_II_space_dimension>; template class MappingQ1Eulerian, deal_II_space_dimension>; -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC template class MappingQ1Eulerian; #endif #endif diff --git a/deal.II/source/fe/mapping_q_eulerian.inst.in b/deal.II/source/fe/mapping_q_eulerian.inst.in index 1bfedd75b3..4bed2047f6 100644 --- a/deal.II/source/fe/mapping_q_eulerian.inst.in +++ b/deal.II/source/fe/mapping_q_eulerian.inst.in @@ -15,7 +15,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS { #if deal_II_dimension <= deal_II_space_dimension template class MappingQEulerian, deal_II_space_dimension>; -# ifdef DEAL_II_USE_PETSC +# ifdef DEAL_II_WITH_PETSC template class MappingQEulerian; template class MappingQEulerian -#ifdef HAVE_LIBNETCDF +#ifdef DEAL_II_WITH_NETCDF #include #endif @@ -1179,7 +1179,7 @@ void GridIn<2, 3>::read_netcdf (const std::string &) template <> void GridIn<2>::read_netcdf (const std::string &filename) { -#ifndef HAVE_LIBNETCDF +#ifndef DEAL_II_WITH_NETCDF // do something with unused // filename filename.c_str(); @@ -1451,7 +1451,7 @@ void GridIn<2>::read_netcdf (const std::string &filename) template <> void GridIn<3>::read_netcdf (const std::string &filename) { -#ifndef HAVE_LIBNETCDF +#ifndef DEAL_II_WITH_NETCDF // do something with the function argument // to make sure it at least looks used, // even if it is not diff --git a/deal.II/source/grid/grid_refinement.cc b/deal.II/source/grid/grid_refinement.cc index ef37f953e9..1e2f5406bd 100644 --- a/deal.II/source/grid/grid_refinement.cc +++ b/deal.II/source/grid/grid_refinement.cc @@ -57,7 +57,7 @@ namespace } -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC PetscScalar max_element (const PETScWrappers::Vector &criteria) { @@ -85,7 +85,7 @@ namespace #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS TrilinosScalar max_element (const TrilinosWrappers::Vector &criteria) { diff --git a/deal.II/source/grid/grid_tools.cc b/deal.II/source/grid/grid_tools.cc index 34269bade2..7ee013a043 100644 --- a/deal.II/source/grid/grid_tools.cc +++ b/deal.II/source/grid/grid_tools.cc @@ -94,7 +94,7 @@ namespace GridTools // processor without being true on // all. however, we can ask for the global // number of active cells and use that -#ifdef DEAL_II_USE_P4EST +#ifdef DEAL_II_WITH_P4EST if (const parallel::distributed::Triangulation *p_tria = dynamic_cast*>(&tria)) Assert (p_tria->n_global_active_cells() == tria.n_cells(0), @@ -185,7 +185,7 @@ namespace GridTools double global_volume = 0; -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI if (const parallel::distributed::Triangulation *p_tria = dynamic_cast*>(&triangulation)) global_volume = Utilities::MPI::sum (local_volume, p_tria->get_communicator()); diff --git a/deal.II/source/lac/block_sparsity_pattern.cc b/deal.II/source/lac/block_sparsity_pattern.cc index f4fbb0d9e8..74db66d190 100644 --- a/deal.II/source/lac/block_sparsity_pattern.cc +++ b/deal.II/source/lac/block_sparsity_pattern.cc @@ -336,7 +336,7 @@ template class BlockSparsityPatternBase; template class BlockSparsityPatternBase; template class BlockSparsityPatternBase; template class BlockSparsityPatternBase; -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS template class BlockSparsityPatternBase; #endif @@ -669,7 +669,7 @@ BlockCompressedSimpleSparsityPattern::reinit ( } -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS namespace TrilinosWrappers { diff --git a/deal.II/source/lac/constraint_matrix.cc b/deal.II/source/lac/constraint_matrix.cc index 20ec7a081c..0c75accbb8 100644 --- a/deal.II/source/lac/constraint_matrix.cc +++ b/deal.II/source/lac/constraint_matrix.cc @@ -1844,7 +1844,7 @@ void ConstraintMatrix::condense (BlockCompressedSimpleSparsityPattern &sparsity) -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS // this is a specialization for a // parallel (non-block) Trilinos @@ -1902,7 +1902,7 @@ ConstraintMatrix::distribute (TrilinosWrappers::MPI::Vector &vec) const individual_indices.end()); } -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI const Epetra_MpiComm *mpi_comm = dynamic_cast(&vec.trilinos_vector().Comm()); @@ -1986,7 +1986,7 @@ ConstraintMatrix::distribute (TrilinosWrappers::MPI::BlockVector &vec) const individual_indices.end()); } -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI const Epetra_MpiComm *mpi_comm = dynamic_cast(&vec.block(0).trilinos_vector().Comm()); @@ -2035,7 +2035,7 @@ ConstraintMatrix::distribute (TrilinosWrappers::MPI::BlockVector &vec) const #endif -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC // this is a specialization for a // parallel (non-block) PETSc @@ -2287,12 +2287,12 @@ ConstraintMatrix::memory_consumption () const // can't do that - we have to rewrite those functions by hand if we want to // use them. The key is to use local ranges etc., which still needs to be // implemented. -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC VECTOR_FUNCTIONS(PETScWrappers::MPI::Vector); VECTOR_FUNCTIONS(PETScWrappers::MPI::BlockVector); #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS PARALLEL_VECTOR_FUNCTIONS(TrilinosWrappers::MPI::Vector); PARALLEL_VECTOR_FUNCTIONS(TrilinosWrappers::MPI::BlockVector); #endif @@ -2356,7 +2356,7 @@ MATRIX_VECTOR_FUNCTIONS(ChunkSparseMatrix, Vector); // BLOCK_MATRIX_FUNCTIONS(BlockSparseMatrixEZ); // BLOCK_MATRIX_VECTOR_FUNCTIONS(BlockSparseMatrixEZ, Vector); -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC MATRIX_FUNCTIONS(PETScWrappers::SparseMatrix); BLOCK_MATRIX_FUNCTIONS(PETScWrappers::BlockSparseMatrix); MATRIX_FUNCTIONS(PETScWrappers::MPI::SparseMatrix); @@ -2367,7 +2367,7 @@ MATRIX_VECTOR_FUNCTIONS(PETScWrappers::MPI::SparseMatrix, PETScWrappers::MPI::Ve BLOCK_MATRIX_VECTOR_FUNCTIONS(PETScWrappers::MPI::BlockSparseMatrix ,PETScWrappers::MPI::BlockVector); #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS MATRIX_FUNCTIONS(TrilinosWrappers::SparseMatrix); BLOCK_MATRIX_FUNCTIONS(TrilinosWrappers::BlockSparseMatrix); MATRIX_VECTOR_FUNCTIONS(TrilinosWrappers::SparseMatrix, TrilinosWrappers::Vector); @@ -2413,7 +2413,7 @@ BLOCK_SPARSITY_FUNCTIONS(BlockCompressedSparsityPattern); BLOCK_SPARSITY_FUNCTIONS(BlockCompressedSetSparsityPattern); BLOCK_SPARSITY_FUNCTIONS(BlockCompressedSimpleSparsityPattern); -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS SPARSITY_FUNCTIONS(TrilinosWrappers::SparsityPattern); BLOCK_SPARSITY_FUNCTIONS(TrilinosWrappers::BlockSparsityPattern); #endif @@ -2433,12 +2433,12 @@ ONLY_MATRIX_FUNCTIONS(MatrixBlock >); ONLY_MATRIX_FUNCTIONS(BlockSparseMatrix); ONLY_MATRIX_FUNCTIONS(BlockSparseMatrix); -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS ONLY_MATRIX_FUNCTIONS(TrilinosWrappers::SparseMatrix); ONLY_MATRIX_FUNCTIONS(TrilinosWrappers::BlockSparseMatrix); #endif -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC ONLY_MATRIX_FUNCTIONS(PETScWrappers::SparseMatrix); ONLY_MATRIX_FUNCTIONS(PETScWrappers::BlockSparseMatrix); ONLY_MATRIX_FUNCTIONS(PETScWrappers::MPI::SparseMatrix); diff --git a/deal.II/source/lac/petsc_block_sparse_matrix.cc b/deal.II/source/lac/petsc_block_sparse_matrix.cc index b05b5fd4d7..4701a9ff05 100644 --- a/deal.II/source/lac/petsc_block_sparse_matrix.cc +++ b/deal.II/source/lac/petsc_block_sparse_matrix.cc @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC DEAL_II_NAMESPACE_OPEN diff --git a/deal.II/source/lac/petsc_full_matrix.cc b/deal.II/source/lac/petsc_full_matrix.cc index 50a1da2298..fb5fbcd053 100644 --- a/deal.II/source/lac/petsc_full_matrix.cc +++ b/deal.II/source/lac/petsc_full_matrix.cc @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include @@ -44,4 +44,4 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC diff --git a/deal.II/source/lac/petsc_matrix_base.cc b/deal.II/source/lac/petsc_matrix_base.cc index 50962f17f4..12820212a3 100644 --- a/deal.II/source/lac/petsc_matrix_base.cc +++ b/deal.II/source/lac/petsc_matrix_base.cc @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -644,4 +644,4 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC diff --git a/deal.II/source/lac/petsc_matrix_free.cc b/deal.II/source/lac/petsc_matrix_free.cc index a0c656e66b..0a02fd6a27 100644 --- a/deal.II/source/lac/petsc_matrix_free.cc +++ b/deal.II/source/lac/petsc_matrix_free.cc @@ -13,7 +13,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC DEAL_II_NAMESPACE_OPEN @@ -285,4 +285,4 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC diff --git a/deal.II/source/lac/petsc_parallel_block_sparse_matrix.cc b/deal.II/source/lac/petsc_parallel_block_sparse_matrix.cc index 5b46603bdb..e56704cb8f 100644 --- a/deal.II/source/lac/petsc_parallel_block_sparse_matrix.cc +++ b/deal.II/source/lac/petsc_parallel_block_sparse_matrix.cc @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC DEAL_II_NAMESPACE_OPEN diff --git a/deal.II/source/lac/petsc_parallel_block_vector.cc b/deal.II/source/lac/petsc_parallel_block_vector.cc index 7d029a7b75..fc11d85a10 100644 --- a/deal.II/source/lac/petsc_parallel_block_vector.cc +++ b/deal.II/source/lac/petsc_parallel_block_vector.cc @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include @@ -41,4 +41,4 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC diff --git a/deal.II/source/lac/petsc_parallel_sparse_matrix.cc b/deal.II/source/lac/petsc_parallel_sparse_matrix.cc index 6fc035b56c..2120531cbd 100644 --- a/deal.II/source/lac/petsc_parallel_sparse_matrix.cc +++ b/deal.II/source/lac/petsc_parallel_sparse_matrix.cc @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -702,4 +702,4 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC diff --git a/deal.II/source/lac/petsc_parallel_vector.cc b/deal.II/source/lac/petsc_parallel_vector.cc index 4f9d798a2d..cf3bd0c4e7 100644 --- a/deal.II/source/lac/petsc_parallel_vector.cc +++ b/deal.II/source/lac/petsc_parallel_vector.cc @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -377,4 +377,4 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC diff --git a/deal.II/source/lac/petsc_precondition.cc b/deal.II/source/lac/petsc_precondition.cc index 1091895496..d799ae708f 100644 --- a/deal.II/source/lac/petsc_precondition.cc +++ b/deal.II/source/lac/petsc_precondition.cc @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -693,4 +693,4 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC diff --git a/deal.II/source/lac/petsc_solver.cc b/deal.II/source/lac/petsc_solver.cc index 65a4aa3b04..67d38bf5ef 100644 --- a/deal.II/source/lac/petsc_solver.cc +++ b/deal.II/source/lac/petsc_solver.cc @@ -14,7 +14,7 @@ #include #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -901,4 +901,4 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC diff --git a/deal.II/source/lac/petsc_sparse_matrix.cc b/deal.II/source/lac/petsc_sparse_matrix.cc index d69aa37780..af1333c040 100644 --- a/deal.II/source/lac/petsc_sparse_matrix.cc +++ b/deal.II/source/lac/petsc_sparse_matrix.cc @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -375,4 +375,4 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC diff --git a/deal.II/source/lac/petsc_vector.cc b/deal.II/source/lac/petsc_vector.cc index 47e116bb5c..31c9eb3427 100644 --- a/deal.II/source/lac/petsc_vector.cc +++ b/deal.II/source/lac/petsc_vector.cc @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include @@ -118,4 +118,4 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC diff --git a/deal.II/source/lac/petsc_vector_base.cc b/deal.II/source/lac/petsc_vector_base.cc index 4df8724dde..439a6bfcab 100644 --- a/deal.II/source/lac/petsc_vector_base.cc +++ b/deal.II/source/lac/petsc_vector_base.cc @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include @@ -1161,4 +1161,4 @@ namespace PETScWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC diff --git a/deal.II/source/lac/slepc_solver.cc b/deal.II/source/lac/slepc_solver.cc index c51f97ff56..7e2682ad2d 100644 --- a/deal.II/source/lac/slepc_solver.cc +++ b/deal.II/source/lac/slepc_solver.cc @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_SLEPC +#ifdef DEAL_II_WITH_SLEPC # include # include @@ -468,5 +468,5 @@ namespace { void dummy () {} } -#endif // DEAL_II_USE_SLEPC +#endif // DEAL_II_WITH_SLEPC diff --git a/deal.II/source/lac/slepc_spectral_transformation.cc b/deal.II/source/lac/slepc_spectral_transformation.cc index 90eaf291ec..977e29876b 100644 --- a/deal.II/source/lac/slepc_spectral_transformation.cc +++ b/deal.II/source/lac/slepc_spectral_transformation.cc @@ -15,7 +15,7 @@ #include -#ifdef DEAL_II_USE_SLEPC +#ifdef DEAL_II_WITH_SLEPC # include # include @@ -170,5 +170,5 @@ namespace { void dummy () {} } -#endif // DEAL_II_USE_SLEPC +#endif // DEAL_II_WITH_SLEPC diff --git a/deal.II/source/lac/solver.cc b/deal.II/source/lac/solver.cc index 6b9f042fcc..88e1e0ee78 100644 --- a/deal.II/source/lac/solver.cc +++ b/deal.II/source/lac/solver.cc @@ -34,7 +34,7 @@ template class Solver >; template class Solver >; template class Solver >; -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC template class Solver; template class Solver; #endif diff --git a/deal.II/source/lac/sparse_direct.cc b/deal.II/source/lac/sparse_direct.cc index 7043349a5e..316bfc10a4 100644 --- a/deal.II/source/lac/sparse_direct.cc +++ b/deal.II/source/lac/sparse_direct.cc @@ -36,7 +36,7 @@ DEAL_II_NAMESPACE_OPEN #endif // include UMFPACK file. -#ifdef HAVE_LIBUMFPACK +#ifdef DEAL_II_WITH_UMFPACK # include #endif @@ -1491,7 +1491,7 @@ initialize (const SparsityPattern &) {} -#ifdef HAVE_LIBUMFPACK +#ifdef DEAL_II_WITH_UMFPACK SparseDirectUMFPACK::SparseDirectUMFPACK () : @@ -1904,7 +1904,7 @@ SparseDirectUMFPACK::Tvmult_add ( Assert(false, ExcNotImplemented()); } -#ifdef DEAL_II_USE_MUMPS +#ifdef DEAL_II_WITH_MUMPS SparseDirectMUMPS::SparseDirectMUMPS () : initialize_called (false) @@ -2080,7 +2080,7 @@ void SparseDirectMUMPS::vmult (Vector &dst, copy_solution (dst); } -#endif // DEAL_II_USE_MUMPS +#endif // DEAL_II_WITH_MUMPS // explicit instantiations for SparseMatrixMA27 template @@ -2117,7 +2117,7 @@ InstantiateUMFPACK(BlockSparseMatrix) InstantiateUMFPACK(BlockSparseMatrix) // explicit instantiations for SparseDirectMUMPS -#ifdef DEAL_II_USE_MUMPS +#ifdef DEAL_II_WITH_MUMPS #define InstantiateMUMPS(MATRIX) \ template \ void SparseDirectMUMPS::initialize (const MATRIX &, const Vector &); diff --git a/deal.II/source/lac/sparsity_tools.cc b/deal.II/source/lac/sparsity_tools.cc index 99e69a582e..218f348d8e 100644 --- a/deal.II/source/lac/sparsity_tools.cc +++ b/deal.II/source/lac/sparsity_tools.cc @@ -18,7 +18,7 @@ #include -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI #include #include #include @@ -26,7 +26,7 @@ #include #endif -#ifdef DEAL_II_USE_METIS +#ifdef DEAL_II_WITH_METIS extern "C" { #include @@ -62,7 +62,7 @@ namespace SparsityTools // Make sure that METIS is actually // installed and detected -#ifndef DEAL_II_USE_METIS +#ifndef DEAL_II_WITH_METIS AssertThrow (false, ExcMETISNotInstalled()); #else @@ -374,7 +374,7 @@ namespace SparsityTools ExcInternalError()); } -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI template void distribute_sparsity_pattern(CSP_t &csp, const std::vector &rows_per_cpu, @@ -511,7 +511,7 @@ namespace SparsityTools const MPI_Comm & mpi_comm,\ const IndexSet & myrange) -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI SPARSITY_FUNCTIONS(CompressedSparsityPattern); SPARSITY_FUNCTIONS(CompressedSimpleSparsityPattern); SPARSITY_FUNCTIONS(BlockCompressedSimpleSparsityPattern); diff --git a/deal.II/source/lac/tridiagonal_matrix.cc b/deal.II/source/lac/tridiagonal_matrix.cc index 26531826da..ede29f74c5 100644 --- a/deal.II/source/lac/tridiagonal_matrix.cc +++ b/deal.II/source/lac/tridiagonal_matrix.cc @@ -228,7 +228,7 @@ template<> void TridiagonalMatrix::compute_eigenvalues() { -#ifdef HAVE_LIBLAPACK +#ifdef DEAL_II_WITH_LAPACK Assert(state == matrix, ExcState(state)); Assert(is_symmetric, ExcNotImplemented()); diff --git a/deal.II/source/lac/trilinos_block_sparse_matrix.cc b/deal.II/source/lac/trilinos_block_sparse_matrix.cc index 3cc7c978e3..9c5cffcac3 100644 --- a/deal.II/source/lac/trilinos_block_sparse_matrix.cc +++ b/deal.II/source/lac/trilinos_block_sparse_matrix.cc @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include # include @@ -232,7 +232,7 @@ namespace TrilinosWrappers // produce a dummy local map and pass it // off to the other function -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI Epetra_MpiComm trilinos_communicator (MPI_COMM_SELF); #else Epetra_SerialComm trilinos_communicator; diff --git a/deal.II/source/lac/trilinos_block_vector.cc b/deal.II/source/lac/trilinos_block_vector.cc index 46e2db16cd..2d2b8cf746 100644 --- a/deal.II/source/lac/trilinos_block_vector.cc +++ b/deal.II/source/lac/trilinos_block_vector.cc @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include diff --git a/deal.II/source/lac/trilinos_precondition.cc b/deal.II/source/lac/trilinos_precondition.cc index 15d34d5d4b..b57d0d403e 100644 --- a/deal.II/source/lac/trilinos_precondition.cc +++ b/deal.II/source/lac/trilinos_precondition.cc @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include # include @@ -34,7 +34,7 @@ namespace TrilinosWrappers { PreconditionBase::PreconditionBase() -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI : communicator (MPI_COMM_SELF) #endif @@ -46,7 +46,7 @@ namespace TrilinosWrappers : Subscriptor (), preconditioner (base.preconditioner), -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI communicator (base.communicator), #endif vector_distributor (new Epetra_Map(*base.vector_distributor)) @@ -62,7 +62,7 @@ namespace TrilinosWrappers void PreconditionBase::clear () { preconditioner.reset(); -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI communicator = MPI_COMM_SELF; #endif vector_distributor.reset(); @@ -720,4 +720,4 @@ namespace TrilinosWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_TRILINOS +#endif // DEAL_II_WITH_TRILINOS diff --git a/deal.II/source/lac/trilinos_solver.cc b/deal.II/source/lac/trilinos_solver.cc index 3f1e06cf19..60ae66c5de 100644 --- a/deal.II/source/lac/trilinos_solver.cc +++ b/deal.II/source/lac/trilinos_solver.cc @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include # include @@ -529,4 +529,4 @@ namespace TrilinosWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC diff --git a/deal.II/source/lac/trilinos_sparse_matrix.cc b/deal.II/source/lac/trilinos_sparse_matrix.cc index ac8ef24006..f01ada3dcc 100644 --- a/deal.II/source/lac/trilinos_sparse_matrix.cc +++ b/deal.II/source/lac/trilinos_sparse_matrix.cc @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include # include @@ -1504,4 +1504,4 @@ namespace TrilinosWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_TRILINOS +#endif // DEAL_II_WITH_TRILINOS diff --git a/deal.II/source/lac/trilinos_sparsity_pattern.cc b/deal.II/source/lac/trilinos_sparsity_pattern.cc index 472ece1bd5..f1d858b8d2 100644 --- a/deal.II/source/lac/trilinos_sparsity_pattern.cc +++ b/deal.II/source/lac/trilinos_sparsity_pattern.cc @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include # include @@ -742,4 +742,4 @@ namespace TrilinosWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_TRILINOS +#endif // DEAL_II_WITH_TRILINOS diff --git a/deal.II/source/lac/trilinos_vector.cc b/deal.II/source/lac/trilinos_vector.cc index 9a66831234..badd19f289 100644 --- a/deal.II/source/lac/trilinos_vector.cc +++ b/deal.II/source/lac/trilinos_vector.cc @@ -14,7 +14,7 @@ #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include # include @@ -399,7 +399,7 @@ namespace TrilinosWrappers last_action = Zero; Epetra_LocalMap map (static_cast(partitioning.size()), 0, -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI Epetra_MpiComm(communicator)); #else Epetra_SerialComm()); @@ -491,7 +491,7 @@ namespace TrilinosWrappers { Epetra_LocalMap map (static_cast(partitioning.size()), 0, -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI Epetra_MpiComm(communicator)); #else Epetra_SerialComm()); @@ -618,4 +618,4 @@ namespace TrilinosWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_TRILINOS +#endif // DEAL_II_WITH_TRILINOS diff --git a/deal.II/source/lac/trilinos_vector_base.cc b/deal.II/source/lac/trilinos_vector_base.cc index 63e8c4e9ca..9f52cb200f 100644 --- a/deal.II/source/lac/trilinos_vector_base.cc +++ b/deal.II/source/lac/trilinos_vector_base.cc @@ -15,7 +15,7 @@ #include #include -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include # include @@ -58,7 +58,7 @@ namespace TrilinosWrappers last_action (Zero), compressed (true), has_ghosts (false), -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI vector(new Epetra_FEVector( Epetra_Map(0,0,Epetra_MpiComm(MPI_COMM_SELF)))) #else @@ -91,7 +91,7 @@ namespace TrilinosWrappers // When we clear the vector, // reset the pointer and generate // an empty vector. -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI Epetra_Map map (0, 0, Epetra_MpiComm(MPI_COMM_SELF)); #else Epetra_Map map (0, 0, Epetra_SerialComm()); @@ -285,7 +285,7 @@ namespace TrilinosWrappers ++ptr; } -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI // in parallel, check that the vector // is zero on _all_ processors. const Epetra_MpiComm *mpi_comm @@ -303,7 +303,7 @@ namespace TrilinosWrappers bool VectorBase::is_non_negative () const { -#ifdef DEAL_II_COMPILER_SUPPORTS_MPI +#ifdef DEAL_II_WITH_MPI // if this vector is a parallel one, then // we need to communicate to determine // the answer to the current @@ -435,4 +435,4 @@ namespace TrilinosWrappers DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_TRILINOS +#endif // DEAL_II_WITH_TRILINOS diff --git a/deal.II/source/multigrid/mg_transfer_prebuilt.inst.in b/deal.II/source/multigrid/mg_transfer_prebuilt.inst.in index 71f90f8d3a..47e315f225 100644 --- a/deal.II/source/multigrid/mg_transfer_prebuilt.inst.in +++ b/deal.II/source/multigrid/mg_transfer_prebuilt.inst.in @@ -38,7 +38,7 @@ for (deal_II_dimension : DIMENSIONS; V1,V2 : DEAL_II_VEC_TEMPLATES; S1, S2 : REA for(deal_II_dimension : DIMENSIONS) { -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS template void MGTransferPrebuilt::copy_to_mg ( diff --git a/deal.II/source/numerics/derivative_approximation.inst.in b/deal.II/source/numerics/derivative_approximation.inst.in index aab6f6c3f5..39dcf37124 100644 --- a/deal.II/source/numerics/derivative_approximation.inst.in +++ b/deal.II/source/numerics/derivative_approximation.inst.in @@ -126,7 +126,7 @@ INSTANTIATE(Vector, hp::DoFHandler); INSTANTIATE(BlockVector, hp::DoFHandler); INSTANTIATE(BlockVector, hp::DoFHandler); -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC INSTANTIATE(PETScWrappers::Vector, DoFHandler); INSTANTIATE(PETScWrappers::BlockVector, DoFHandler); @@ -134,7 +134,7 @@ INSTANTIATE(PETScWrappers::Vector, hp::DoFHandler); INSTANTIATE(PETScWrappers::BlockVector, hp::DoFHandler); #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS INSTANTIATE(TrilinosWrappers::Vector, DoFHandler); INSTANTIATE(TrilinosWrappers::BlockVector, DoFHandler); INSTANTIATE(TrilinosWrappers::MPI::Vector, DoFHandler); diff --git a/deal.II/source/numerics/error_estimator.cc b/deal.II/source/numerics/error_estimator.cc index 3265d72233..676a4c7e7f 100644 --- a/deal.II/source/numerics/error_estimator.cc +++ b/deal.II/source/numerics/error_estimator.cc @@ -1172,7 +1172,7 @@ estimate (const Mapping<1,spacedim> &mapping, const types::subdomain_id subdomain_id_, const types::material_id material_id) { -#ifdef DEAL_II_USE_P4EST +#ifdef DEAL_II_WITH_P4EST if (dynamic_cast*> (&dof_handler.get_tria()) != 0) @@ -1523,7 +1523,7 @@ estimate (const Mapping &mapping, const types::subdomain_id subdomain_id_, const types::material_id material_id) { -#ifdef DEAL_II_USE_P4EST +#ifdef DEAL_II_WITH_P4EST if (dynamic_cast*> (&dof_handler.get_tria()) != 0) diff --git a/deal.II/source/numerics/error_estimator.inst.in b/deal.II/source/numerics/error_estimator.inst.in index 97aefce001..1b84c651f1 100644 --- a/deal.II/source/numerics/error_estimator.inst.in +++ b/deal.II/source/numerics/error_estimator.inst.in @@ -178,7 +178,7 @@ INSTANTIATE(parallel::distributed::Vector,hp::DoFHandler) INSTANTIATE(parallel::distributed::BlockVector,hp::DoFHandler) INSTANTIATE(parallel::distributed::BlockVector,hp::DoFHandler) -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC INSTANTIATE(PETScWrappers::Vector,DoFHandler) INSTANTIATE(PETScWrappers::BlockVector,DoFHandler) @@ -190,7 +190,7 @@ INSTANTIATE(PETScWrappers::MPI::BlockVector,DoFHandler) #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS INSTANTIATE(TrilinosWrappers::Vector,DoFHandler) INSTANTIATE(TrilinosWrappers::BlockVector,DoFHandler) diff --git a/deal.II/source/numerics/matrix_tools.cc b/deal.II/source/numerics/matrix_tools.cc index ae1165ea5d..776031f0f5 100644 --- a/deal.II/source/numerics/matrix_tools.cc +++ b/deal.II/source/numerics/matrix_tools.cc @@ -35,7 +35,7 @@ #include #include -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC # include # include # include @@ -43,7 +43,7 @@ # include #endif -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS # include # include # include @@ -2351,7 +2351,7 @@ namespace MatrixTools -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC namespace internal { @@ -2561,7 +2561,7 @@ namespace MatrixTools -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS namespace internal { diff --git a/deal.II/source/numerics/time_dependent.cc b/deal.II/source/numerics/time_dependent.cc index ad4470cbea..52d8d4f726 100644 --- a/deal.II/source/numerics/time_dependent.cc +++ b/deal.II/source/numerics/time_dependent.cc @@ -205,7 +205,7 @@ void TimeDependent::start_sweep (const unsigned int s) void TimeDependent::end_sweep (const unsigned int n_threads) { -#ifdef DEAL_II_USE_MT +#ifdef DEAL_II_WITH_THREADS if (n_threads > 1) { const unsigned int stride = timesteps.size() / n_threads; -- 2.39.5