diff --git a/cpp/field.cpp b/cpp/field.cpp
index 81f71e10d330ea0886091d13348584378e01011c..8cfeeaf3ec07c4646cf6c185b222161c8e88ef95 100644
--- a/cpp/field.cpp
+++ b/cpp/field.cpp
@@ -799,8 +799,8 @@ int field<rnumber, be, fc>::write_filtered(
             }
         }
     }
-    DEBUG_MSG("count[0] = %ld, offset[0] = %ld\n",
-            count[0], offset[0]);
+    //DEBUG_MSG("count[0] = %ld, offset[0] = %ld\n",
+    //        count[0], offset[0]);
     if (nz>=2)
     {
         assert(nz%2==0);
@@ -812,8 +812,8 @@ int field<rnumber, be, fc>::write_filtered(
             offset[1] = cz*nz/2;
             memshape [1] = this->clayout->sizes[1];
             memoffset[1] = cz*(this->clayout->sizes[1] - nz/2);
-            DEBUG_MSG("cz = %d, count[1] + offset[1] = %ld\n",
-                    cz, count[1] + offset[1]);
+            //DEBUG_MSG("cz = %d, count[1] + offset[1] = %ld\n",
+            //        cz, count[1] + offset[1]);
 
             //now write data
             mspace = H5Screate_simple(ndim(fc), memshape, NULL);
@@ -830,7 +830,7 @@ int field<rnumber, be, fc>::write_filtered(
         offset[1] = 0;
         memshape [1] = this->clayout->sizes[1];
         memoffset[1] = 0;
-        DEBUG_MSG("filtered write nz=1\n");
+        //DEBUG_MSG("filtered write nz=1\n");
 
         //now write data
         mspace = H5Screate_simple(ndim(fc), memshape, NULL);
@@ -921,9 +921,9 @@ void field<rnumber, be, fc>::compute_rspace_stats(
         // and possible component indices that are NOT averaged over
         // HDF5 dataset has 2 extra indices for time and order of moment,
         // and possible component indices
-        DEBUG_MSG("ndims = %d, ndim(fc) = %d, dsetname = %s\n",
-                ndims, ndim(fc),
-                dset_name.c_str());
+        //DEBUG_MSG("ndims = %d, ndim(fc) = %d, dsetname = %s\n",
+        //        ndims, ndim(fc),
+        //        dset_name.c_str());
         assert(ndims == int(ndim(fc))-1);
         assert(dims[1] == nmoments);
         switch(ndims)
@@ -2130,12 +2130,12 @@ int make_gaussian_random_field(
                 rseed*omp_get_max_threads()*output_field->clayout->nprocs +
                 output_field->clayout->myrank*omp_get_max_threads() +
                 thread_id);
-        DEBUG_MSG("in make_gaussian_random_field, thread_id = %d, current_seed = %d\n", thread_id, current_seed);
+        //DEBUG_MSG("in make_gaussian_random_field, thread_id = %d, current_seed = %d\n", thread_id, current_seed);
         rgen[thread_id].seed(current_seed);
     }
     output_field->real_space_representation = false;
     *output_field = 0.0;
-    DEBUG_MSG("slope: %g\n", slope);
+    //DEBUG_MSG("slope: %g\n", slope);
     // inside loop use only thread-local random number generator
     kk->CLOOP_K2([&](
                 ptrdiff_t cindex,
diff --git a/cpp/full_code/NSVE_Stokes_particles.cpp b/cpp/full_code/NSVE_Stokes_particles.cpp
index 3606b162ce0be6b9904fa5a74ca63dcd1d011cf7..eb9b4084eb04583a6b6a28bb50432c93f0e213bc 100644
--- a/cpp/full_code/NSVE_Stokes_particles.cpp
+++ b/cpp/full_code/NSVE_Stokes_particles.cpp
@@ -47,7 +47,7 @@ int NSVE_Stokes_particles<rnumber>::initialize(void)
     particles_inner_computer_2nd_order_Stokes<double, long long int> current_particles_inner_computer;
     current_particles_inner_computer.set_drag_coefficient(0.1);
 
-    DEBUG_MSG_WAIT(MPI_COMM_WORLD, "before call to particles_system_builder\n");
+    //DEBUG_MSG_WAIT(MPI_COMM_WORLD, "before call to particles_system_builder\n");
     this->ps = particles_system_builder_with_p2p(
                 this->fs->cvelocity,                                                    // (field object)
                 this->fs->kk,                                                           // (kspace object, contains dkx, dky, dkz)
@@ -63,7 +63,7 @@ int NSVE_Stokes_particles<rnumber>::initialize(void)
                 std::move(p2p_ghost_collisions<double, long long int>()),
                 std::move(particles_inner_computer_2nd_order_Stokes<double, long long int>()),
                 this->tracers0_cutoff);
-    DEBUG_MSG_WAIT(MPI_COMM_WORLD, "after call to particles_system_builder\n");
+    //DEBUG_MSG_WAIT(MPI_COMM_WORLD, "after call to particles_system_builder\n");
     this->particles_output_writer_mpi = new particles_output_hdf5<
         long long int, double, 6>(
                 MPI_COMM_WORLD,
diff --git a/cpp/vorticity_equation.cpp b/cpp/vorticity_equation.cpp
index 58de8a5eca1d331b9fe4b4915603504c7aaab289..f062667104303cf50b15c903eca319eddc880595 100644
--- a/cpp/vorticity_equation.cpp
+++ b/cpp/vorticity_equation.cpp
@@ -461,7 +461,7 @@ template <class rnumber,
 void vorticity_equation<rnumber, be>::omega_nonlin(
         int src)
 {
-    DEBUG_MSG("vorticity_equation::omega_nonlin(%d)\n", src);
+    //DEBUG_MSG("vorticity_equation::omega_nonlin(%d)\n", src);
     assert(src >= 0 && src < 3);
     this->compute_velocity(this->v[src]);
     /* get fields from Fourier space to real space */
@@ -515,7 +515,7 @@ template <class rnumber,
           field_backend be>
 void vorticity_equation<rnumber, be>::step(double dt)
 {
-    DEBUG_MSG("vorticity_equation::step\n");
+    //DEBUG_MSG("vorticity_equation::step\n");
     TIMEZONE("vorticity_equation::step");
     *this->v[1] = 0.0;
     this->omega_nonlin(0);