Running Gromacs at UPPMAX¶
This page describes how to run the GROMACS molecular dynamics software on UPPMAX systems. See the gromacs web page for more information.
Have a look on this page as well - best practices running GROMAC on HPC.
Selected setups for benchmarking on HPC2N as examples.
Loading the gromac module¶
SBATCH script¶
adapted from HPC2N
#!/bin/bash -l
#SBATCH -A SNIC_project
#SBATCH -t 00:15:00
#SBATCH -p node -n 10
# Use 2 threads per task
#SBATCH -c 2
module load gromacs/2021.1.th
# Automatic selection of single or multi node based GROMACS
if [ $SLURM_JOB_NUM_NODES -gt 1 ]; then
  GMX="gmx_mpi"
  MPIRUN="mpirun"
  ntmpi=""
else
  GMX="gmx"
  MPIRUN=""
  ntmpi="-ntmpi $SLURM_NTASKS"
fi
# Automatic selection of ntomp argument based on "-c" argument to sbatch
if [ -n "$SLURM_CPUS_PER_TASK" ]; then
  ntomp="$SLURM_CPUS_PER_TASK"
else
  ntomp="1"
fi
# Make sure to set OMP_NUM_THREADS equal to the value used for ntomp
# to avoid complaints from GROMACS
export OMP_NUM_THREADS=$ntomp
$MPIRUN $GMX mdrun $ntmpi -ntomp $ntomp -s MEM.tpr -nsteps 10000 -resethway
How important is to select appropriate options¶
Here is a simple benchmark ran on single interactive session with 20CPUs using the MEM example from this benchmark:
module load gromacs/2021.1.th
mpirun -np XX gmx_mpi mdrun -ntomp YY -s MEM.tpr -nsteps 10000 -resethway
where XX * YY = 20
Notice how bad is the last run
$ mpirun -np 1 gmx_mpi mdrun -ntomp 20 -s MEM.tpr -nsteps 10000 -resethway (lines 25-26)
According to this short test, this particular setup runs best on single Rackham node with
$ mpirun -np 10 gmx_mpi mdrun -ntomp 2 -s MEM.tpr -nsteps 10000 -resethway (lines 8-10)
Running older versions of gromacs¶
Versions 4.5.1 to 5.0.4¶
The gromacs tools have been compiled serially. The mdrun program has also been compiled in parallel using MPI. The name of the parallel binary is mdrun_mpi.
Run the parallelized program using:
... where XXX is the number of cores to run the program on.
Version 5.1.1¶
The binary is gmx_mpi and (e.g.) the mdrun command is issued like this: