Use enum class for gmx_omp_nthreads
[alexxy/gromacs.git] / src / gromacs / nbnxm / atomdata.cpp
index d2e497b6dafe07dab86faae6aed5f15729223af3..d74467f1634ebdf44e8942819532fc1803a8a8d5 100644 (file)
@@ -990,7 +990,7 @@ void nbnxn_atomdata_copy_x_to_nbat_x(const Nbnxm::GridSet&   gridSet,
     int gridEnd   = 0;
     getAtomRanges(gridSet, locality, &gridBegin, &gridEnd);
 
-    const int nth = gmx_omp_nthreads_get(emntPairsearch);
+    const int nth = gmx_omp_nthreads_get(ModuleMultiThread::Pairsearch);
 #pragma omp parallel for num_threads(nth) schedule(static)
     for (int th = 0; th < nth; th++)
     {
@@ -1246,7 +1246,7 @@ void reduceForces(nbnxn_atomdata_t* nbat, const gmx::AtomLocality locality, cons
         return;
     }
 
-    int nth = gmx_omp_nthreads_get(emntNonbonded);
+    int nth = gmx_omp_nthreads_get(ModuleMultiThread::Nonbonded);
 
     if (nbat->out.size() > 1)
     {