#include <deal.II/matrix_free/matrix_free.h>
#include <deal.II/matrix_free/type_traits.h>
-#if DEBUG
+#ifdef DEBUG
# include <boost/algorithm/string/join.hpp>
#endif
(void)matrix_free;
(void)dof_info;
-#if DEBUG
+#ifdef DEBUG
if (vec.partitioners_are_compatible(*dof_info.vector_partitioner) == false)
{
unsigned int dof_index = numbers::invalid_unsigned_int;
fe.n_dofs_per_vertex() > 0;
});
-#if DEBUG
+#ifdef DEBUG
const bool fine_element_is_discontinuous =
std::all_of(dof_handler_fine.get_fe_collection().begin(),
dof_handler_fine.get_fe_collection().end(),
else if (std::abs(i[0] - 1.0) < 1e-12)
i[0] = 1.0;
-#if DEBUG
+#ifdef DEBUG
double sum_of_weights = 0;
for (unsigned int i = 0; i < this->size(); ++i)
sum_of_weights += this->weight(i);
for (const Edge &e : sub_graph)
identities_graph.erase(e);
-#if DEBUG
+#ifdef DEBUG
// There are three checks we ought to perform:
// - That the sub-graph is undirected, i.e. that every edge appears
// in both directions
Assert(size() == n, ExcDimensionMismatch(size(), n));
-# if DEBUG
+# ifdef DEBUG
{
// test ghost allocation in debug mode
PetscInt begin, end;
initlog();
deal_II_exceptions::disable_abort_on_exception();
-#if DEBUG
+#ifdef DEBUG
// Asserts should be triggered
const bool expected_result = false;
#else
initlog();
deal_II_exceptions::disable_abort_on_exception();
-#if DEBUG
+#ifdef DEBUG
// Asserts should be triggered
const bool expected_result = false;
#else
initlog();
deal_II_exceptions::disable_abort_on_exception();
-#if DEBUG
+#ifdef DEBUG
// Asserts should be triggered
const bool expected_result = false;
#else
initlog();
deal_II_exceptions::disable_abort_on_exception();
-#if DEBUG
+#ifdef DEBUG
// Asserts should be triggered
const bool expected_result_taped = false;
const bool expected_result_tapeless = false;
initlog();
deal_II_exceptions::disable_abort_on_exception();
-#if DEBUG
+#ifdef DEBUG
// Asserts should be triggered
const bool expected_result = false;
#else
using func_sd = CoupledFunction<dim, SDNumberType>;
symb_psi = func_sd::psi(symb_t, symb_v, symb_s);
-#if DEBUG_EXTRA
+#ifdef DEBUG_EXTRA
deallog << "symb_t: " << symb_t << std::endl;
deallog << "symb_v: " << symb_v << std::endl;
deallog << "symb_s: " << symb_s << std::endl;
symb_d2psi_dt_ds = SD::differentiate(symb_dpsi_ds, symb_t);
symb_d2psi_dv_ds = SD::differentiate(symb_dpsi_ds, symb_v);
symb_d2psi_ds_ds = SD::differentiate(symb_dpsi_ds, symb_s);
-#if DEBUG_EXTRA
+#ifdef DEBUG_EXTRA
print(deallog, "symb_psi", symb_psi);
print(deallog, "symb_dpsi_dt", symb_dpsi_dt);
print(deallog, "symb_dpsi_dv", symb_dpsi_dv);
symb_d2psi_ds_x_dv = SD::differentiate(symb_dpsi_ds, symb_v);
symb_d2psi_ds_x_ds = SD::differentiate(symb_dpsi_ds, symb_s);
-#if DEBUG
+#ifdef DEBUG
print(std::cout, "symb_st", symb_st);
print(std::cout, "symb_t", symb_t);
print(std::cout, "symb_v", symb_v);