}
else
{
-# if defined(DEAL_II_COMPILER_CUDA_AWARE)
+# ifdef DEAL_II_COMPILER_CUDA_AWARE
cudaError_t cuda_error =
cudaMemcpy(ghost_array.data() + ghost_range.first,
ghost_array.data() + offset,
}
else
{
-# if defined(DEAL_II_COMPILER_CUDA_AWARE)
+# ifdef DEAL_II_COMPILER_CUDA_AWARE
cudaError_t cuda_error =
cudaMemcpy(ghost_array_ptr + offset,
ghost_array.data() + my_ghosts->first,
"import_from_ghosted_array_start as is passed "
"to import_from_ghosted_array_finish."));
-# if defined(DEAL_II_COMPILER_CUDA_AWARE)
+# ifdef DEAL_II_COMPILER_CUDA_AWARE
if (std::is_same<MemorySpaceType, MemorySpace::CUDA>::value)
{
cudaMemset(ghost_array.data(),
constexpr inline bool
Tensor<0, dim, Number>::operator==(const Tensor<0, dim, OtherNumber> &p) const
{
-# if defined(DEAL_II_ADOLC_WITH_ADVANCED_BRANCHING)
+# ifdef DEAL_II_ADOLC_WITH_ADVANCED_BRANCHING
Assert(!(std::is_same<Number, adouble>::value ||
std::is_same<OtherNumber, adouble>::value),
ExcMessage(
"Mismatch in vectorization capabilities: AVX-512F was detected during configuration of deal.II and switched on, but it is apparently not available for the file you are trying to compile at the moment. Check compilation flags controlling the instruction set, such as -march=native."
# endif
-# if defined(_MSC_VER)
+# ifdef _MSC_VER
# include <intrin.h>
# elif defined(__ALTIVEC__)
# include <altivec.h>
DEAL_II_EXPOSE_ADOLC_UNARY_MATH_FUNCTION(log)
DEAL_II_EXPOSE_ADOLC_UNARY_MATH_FUNCTION(log10)
DEAL_II_EXPOSE_ADOLC_UNARY_MATH_FUNCTION(sqrt)
-# if defined(DEAL_II_ADOLC_WITH_ATRIG_ERF)
+# ifdef DEAL_II_ADOLC_WITH_ATRIG_ERF
DEAL_II_EXPOSE_ADOLC_UNARY_MATH_FUNCTION(erf)
inline adouble
erfc(const adouble &x)
DEAL_II_EXPOSE_ADOLC_UNARY_MATH_FUNCTION(sinh)
DEAL_II_EXPOSE_ADOLC_UNARY_MATH_FUNCTION(cosh)
DEAL_II_EXPOSE_ADOLC_UNARY_MATH_FUNCTION(tanh)
-# if defined(DEAL_II_ADOLC_WITH_ATRIG_ERF)
+# ifdef DEAL_II_ADOLC_WITH_ATRIG_ERF
DEAL_II_EXPOSE_ADOLC_UNARY_MATH_FUNCTION(asinh)
DEAL_II_EXPOSE_ADOLC_UNARY_MATH_FUNCTION(acosh)
DEAL_II_EXPOSE_ADOLC_UNARY_MATH_FUNCTION(atanh)
-#if defined(DEAL_II_WITH_TRILINOS)
+#ifdef DEAL_II_WITH_TRILINOS
static std::vector<unsigned int>
sort_indices(const types::global_dof_index *v_begin,
const types::global_dof_index *v_end)
void
resize_val(const size_type new_allocated_size);
-#if defined(DEAL_II_WITH_TRILINOS)
+#ifdef DEAL_II_WITH_TRILINOS
# ifdef DEAL_II_TRILINOS_WITH_TPETRA
/**
* Return a TpetraWrappers::CommunicationPattern and store it for future
-#if defined(DEAL_II_WITH_TRILINOS)
+#ifdef DEAL_II_WITH_TRILINOS
template <typename Number>
void
ReadWriteVector<Number>::reinit(
-#if defined(DEAL_II_WITH_TRILINOS)
+#ifdef DEAL_II_WITH_TRILINOS
# ifdef DEAL_II_TRILINOS_WITH_TPETRA
template <typename Number>
void
-#if defined(DEAL_II_WITH_TRILINOS)
+#ifdef DEAL_II_WITH_TRILINOS
# ifdef DEAL_II_TRILINOS_WITH_TPETRA
template <typename Number>
TpetraWrappers::CommunicationPattern
#include <deal.II/base/config.h>
-#if defined(DEAL_II_WITH_TRILINOS)
+#ifdef DEAL_II_WITH_TRILINOS
# include <deal.II/base/index_set.h>
# include <deal.II/base/subscriptor.h>
#include <deal.II/base/config.h>
-#if defined(DEAL_II_WITH_TRILINOS)
+#ifdef DEAL_II_WITH_TRILINOS
# include <deal.II/lac/block_linear_operator.h>
# include <deal.II/lac/linear_operator.h>
#include <deal.II/base/config.h>
-#if defined(DEAL_II_TRILINOS_WITH_TPETRA)
+#ifdef DEAL_II_TRILINOS_WITH_TPETRA
# include <deal.II/base/communication_pattern_base.h>
#include <deal.II/base/config.h>
-#if defined(DEAL_II_TRILINOS_WITH_TPETRA)
+#ifdef DEAL_II_TRILINOS_WITH_TPETRA
# include <deal.II/base/index_set.h>
# include <deal.II/base/subscriptor.h>
-#if defined(DEAL_II_WITH_TRILINOS)
+#ifdef DEAL_II_WITH_TRILINOS
template <>
inline void
ElementAccess<LinearAlgebra::EpetraWrappers::Vector>::add(
-#if defined(DEAL_II_TRILINOS_WITH_TPETRA)
+#ifdef DEAL_II_TRILINOS_WITH_TPETRA
template <>
inline void
VectorHelper<LinearAlgebra::TpetraWrappers::Vector<double>>::extract(
release_unused_memory();
// Next with Trilinos:
-# if defined(DEAL_II_WITH_TRILINOS)
+# ifdef DEAL_II_WITH_TRILINOS
GrowingVectorMemory<
TrilinosWrappers::MPI::Vector>::release_unused_memory();
GrowingVectorMemory<
namespace System
{
-#if defined(__linux__)
+#ifdef __linux__
double
get_cpu_load()
// parsing /proc/self/stat would be a
// lot easier, but it does not contain
// VmHWM, so we use /status instead.
-#if defined(__linux__)
+#ifdef __linux__
std::ifstream file("/proc/self/status");
std::string line;
std::string name;
last_action = Insert;
}
-# if defined(DEBUG)
+# ifdef DEBUG
const Epetra_MpiComm *comm_ptr =
dynamic_cast<const Epetra_MpiComm *>(&(v.vector->Comm()));
Assert(comm_ptr != nullptr, ExcInternalError());
}
else
vector = std::move(actual_vec);
-# if defined(DEBUG)
+# ifdef DEBUG
const Epetra_MpiComm *comm_ptr =
dynamic_cast<const Epetra_MpiComm *>(&(vector->Comm()));
Assert(comm_ptr != nullptr, ExcInternalError());
// unusable since we can no longer detect whether something is a
// NaN. that said, to make the test work in these cases, simply
// switch off floating point exceptions for invalid arguments
-#if defined(DEAL_II_HAVE_FP_EXCEPTIONS)
+#ifdef DEAL_II_HAVE_FP_EXCEPTIONS
fedisableexcept(FE_INVALID);
#endif
// unusable since we can no longer detect whether something is a
// NaN. that said, to make the test work in these cases, simply
// switch off floating point exceptions for invalid arguments
-#if defined(DEAL_II_HAVE_FP_EXCEPTIONS)
+#ifdef DEAL_II_HAVE_FP_EXCEPTIONS
fedisableexcept(FE_INVALID);
#endif
// unusable since we can no longer detect whether something is a
// NaN. that said, to make the test work in these cases, simply
// switch off floating point exceptions for invalid arguments
-#if defined(DEAL_II_HAVE_FP_EXCEPTIONS)
+#ifdef DEAL_II_HAVE_FP_EXCEPTIONS
fedisableexcept(FE_INVALID);
#endif
#include <deal.II/grid/tria.h>
-#if defined(__linux__)
+#ifdef __linux__
# include <sched.h>
# include <sys/sysinfo.h>
#endif
bits_set = 0;
mask = 0x00;
-#if defined(__linux__)
+#ifdef __linux__
cpu_set_t my_set;
CPU_ZERO(&my_set);