Outils pour utilisateurs

Outils du site


logiciels:gromacs

Ceci est une ancienne révision du document !


Gromacs

GROMACS is an engine to perform molecular dynamics simulations and energy minimization.

  • Versions installées :
    • 5.0.2 avec support OpenMP et thread-MPI
    • 5.0.2 avec support OpenMP et MPI
    • 5.0.2 avec support OpenMP et GPU NVidia (:!: compilé avec Intel composer 2013)
    • 5.0.4, en simple et double précision, avec MPI ou sans

Utilisation

Voir les manuels d'utilisation sur http://www.gromacs.org/Documentation/Manual

Pour une discussion sur la parallélisation : http://www.gromacs.org/Documentation/Acceleration_and_parallelization

Sélection de la version

Pour sélectionner la version voulue : utiliser les modules

Par exemple :

module load gromacs/5.0.2-mpi

:!: Si vous utilisez la version GPU, vous devez faire

module unload intel/composer
module load intel/composer/xe_2013_sp1.2.144
module load gromacs/5.0.2-gpu

Pour la version 5.0.4, un seul fichier module existe. Le nom de l'exécutable change en fonction du mode de fonctionnement souhaité :

  • mdrun pour la version sans MPI en simple précision
  • mdrun_d pour la version sans MPI en double précision
  • mdrun_mpi pour la version avec MPI en simple précision
  • mdrun_mpi_d pour la version avec MPI en double précision

Performance

Les benchmarks suivants ont été réalisés sur une simulation de DHFR (une petite protéine), qui est couramment utilisée pour des benchmarks. Le système contient environ 23000 atomes. Il est possible de paralléliser de deux manières différentes :

  • avec MPI, qui est performant pour partager un job au sein d'un ou plusieurs noeuds
  • avec openMP, qui peut être performant pour partager des coeurs au sein d'un processus MPI sur un même noeud.

Voici un tableau des performances relevées avec Gromacs 5.0.2 compilé avec les compilateurs intel :

nb_coeurs      ntasks(MPI)     cpus-per-task(openMP)    GPU      Performance(ns/day)
        2               2                          1      0       10.955
        4               4                          1      0       14.817
        8               8                          1      0       21.747
       16              16                          1      0       64.457
       32              32                          1      0      110.067
       64              64                          1      0      156.836
      128             128                          1      0      268.282
      256             256                          1      0      255.346 #ici, on dépasse la limite de 100 atomes par coeur. Ça devrait mieux fonctionner avec un plus gros système
      256             128                          2      0      291.507 # pour un grand nombre de coeurs, il devient intéressant de diminuer le nombre de processus MPI au profit d'openMP
        8               1                          8      1       82.490
        8               2                          4      2       82.217 # la puissance à 2 GPU est limitée par le nombre de coeurs
       16               2                          8      2      118.781
       16               1                         16      1      112.530 # pas d'intérêt d'utiliser les 2 CPU pour 1 GPU, mais on constate également la limite du nombre de CPU.
       

Ne sont présentées ici que les configurations les plus rapides. En effet, sur CPU uniquement, openMP n'est efficace que pour des gros systèmes sur un grand nombre de coeurs. Avec moins de 256 coeurs, on constate une dégradation de performance quel que soit le nombre de threads openMP par processus MPI.

Avec des GPU, c'est différent. Il faut utiliser au moins un processus thread-MPI par GPU. Ensuite, on ajuste le nombre de threads openMP pour obtenir le nombre de coeurs voulu. En pratique, utiliser plus d'un thread-MPI par GPU dégrade la performance.

On constate qu'avec GPU on semble être limité par le nombre de CPU. À noter qu'il n'est pas possible d'utiliser plus que 16 coeurs (la partition Slurm ne contient que le noeud GPU). Ce comportement peut aussi être différent pour des plus gros sytèmes.

Exemples de fichiers batch slurm

Sur CPU

#!/bin/bash #SBATCH –partition=normal #SBATCH –ntasks=16 #SBATCH –cpus-per-task=1 #SBATCH –threads-per-core=1 #SBATCH –mem-per-cpu=1000 #SBATCH –time=2-00:00:00 #SBATCH –nodes=1-4

# the –nodes option sets the minimum and maximum number of cores. It is good to set the maximum to ntasks/16 to limit jobs spread on many many nodes.

module load gromacs #loads the default gromacs version export OMP_NUM_THREADS=$SLURM_CPUS_PER_TASK mdrun=“srun –kill-on-bad-exit=1 mdrun_mpi” #without the option, the job hangs and is not terminated when it fails. grompp=“gmx grompp” # for gromacs version 5 and later

if [ -r “state.cpt” ] ; then

  # if state.cpt exists in the current directory, that means we are in scratch and the calculation has run already
  restart="TRUE"

else

  restart="FALSE"

fi # restart=“FALSE” # you can force a restart or not with this line

if [ “$restart” == “TRUE” ] ; then

      MIN=false # we assume min step is done the first day
      #WORKDIR has to be where the data is, i.e. in scratch / inside the results.* folder. So submit this batch file from there.
      WORKDIR="$PWD"
      sleep 30 # to make sure all processes from the previous job are killed
      restartoptions="-cpi state.cpt -append"

else # options for the beginning of the run

      MIN=true
      simname=`basename $PWD`
      WORKDIR="$HOME/scratch/gromacs/run.$SLURM_JOB_ID.gromacs.$simname"
      #
      # Directory used to store the results
      #
      mkdir -p $WORKDIR || {
              echo "ERROR Creating the working directory"
              exit 1
      }
      cp * $WORKDIR
      ln -sfn $WORKDIR "results.$SLURM_JOB_ID" # create symbolic link to scratch
      cd $WORKDIR
      restartoptions=""

fi

cd $WORKDIR

if [ $MIN = “true” ]; then

$grompp -f em.mdp -c md.gro -n md.ndx -p md.top -o em.tpr
$mdrun -s em.tpr -o em.trr -c em.gro -e em.edr -g em.log
$grompp -f pr.mdp -c em.gro -n md.ndx -p md.top -r em.gro -o pr.tpr
$mdrun -s pr.tpr -o pr.trr -c pr.gro -e pr.edr -g pr.log
mv pr.gro 0.gro

fi

#use the following line if you want to prolong a simulation that crashed or terminated normally. #if you just want to finish it after a crash, comment it. #adjust the -until option to the total amount of ps you want to have. #gmx convert-tpr -s md.tpr -o md.tpr -until 1000000

# tricky part: submit the same job, that will only be run after the current one crashes. sbatch -d afternotok:$SLURM_JOB_ID $0

if [ “$restart” == “FALSE” ] ; then

  $grompp -f md.mdp -c 0.gro -n md.ndx -p md.top -o md.tpr

fi

#the -cpi option will use your checkpoint to restart the calculation and continue writing to your files. $mdrun -s md.tpr -o md.trr -x md.xtc -c md_out.gro -e md.edr -g md.log $restartoptions

rm -f md.trr # remove the big file (>1GB) after the calculation rm -f \#* # remove the backup files

Exemple de fichier batch slurm sur GPU

Sur 1 GPU

#!/bin/bash
#SBATCH --partition=gpu
#SBATCH --qos=gpu
#SBATCH --gres=gpu:1
#SBATCH --ntasks=1
#SBATCH --cpus-per-task=8
#SBATCH --threads-per-core=1
#SBATCH --mem-per-cpu=1000
#SBATCH --time=7-00:00:00

module load gromacs/5.0.2-gpu
export OMP_NUM_THREADS=$SLURM_CPUS_PER_TASK

WORKDIR="$HOME/scratch/$SLURM_JOB_ID"

MIN=true
grompp=grompp
mdrun="mdrun"

# Directory used to store the results
mkdir $WORKDIR || {
        echo "ERROR Creating the working directory"
        exit 1
}

cp * $WORKDIR
cd $WORKDIR

if [ $MIN = "true" ]; then

  $grompp -f em.mdp -c md.gro -n md.ndx -p md.top -o em.tpr
  $mdrun -s em.tpr -o em.trr -c em.gro -e em.edr -g em.log

  $grompp -f pr.mdp -c em.gro -n md.ndx -p md.top -r em.gro -o pr.tpr
  $mdrun -s pr.tpr -o pr.trr -c pr.gro -e pr.edr -g pr.log

  mv pr.gro 0.gro

fi

$grompp -f md.mdp -c 0.gro -n md.ndx -p md.top -o md.tpr
$mdrun -s md.tpr -o md.trr -x md.xtc -c md_out.gro -e md.edr -g md.log
rm -f md.trr # remove the uncompressed trajectory after the calculation
rm -f \#* # remove backup files

Sur 2 GPUs

#!/bin/bash
#SBATCH --partition=gpu
#SBATCH --qos=gpu
#SBATCH --gres=gpu:2
#SBATCH --ntasks=2
#SBATCH --cpus-per-task=8
#SBATCH --threads-per-core=1
#SBATCH --mem-per-cpu=1000
#SBATCH --time=7-00:00:00

module load gromacs/5.0.2-gpu
export OMP_NUM_THREADS=$SLURM_CPUS_PER_TASK

WORKDIR="$HOME/scratch/$SLURM_JOB_ID"

MIN=true
grompp=grompp
mdrun="mdrun"

# Directory used to store the results
mkdir $WORKDIR || {
        echo "ERROR Creating the working directory"
        exit 1
}

cp * $WORKDIR
cd $WORKDIR

if [ $MIN = "true" ]; then

  $grompp -f em.mdp -c md.gro -n md.ndx -p md.top -o em.tpr
  $mdrun -s em.tpr -o em.trr -c em.gro -e em.edr -g em.log

  $grompp -f pr.mdp -c em.gro -n md.ndx -p md.top -r em.gro -o pr.tpr
  $mdrun -s pr.tpr -o pr.trr -c pr.gro -e pr.edr -g pr.log

  mv pr.gro 0.gro

fi

$grompp -f md.mdp -c 0.gro -n md.ndx -p md.top -o md.tpr
$mdrun -s md.tpr -o md.trr -x md.xtc -c md_out.gro -e md.edr -g md.log
rm -f md.trr # remove the uncompressed trajectory after the calculation
rm -f \#* # remove backup files
Vous pourriez laisser un commentaire si vous étiez connecté.
logiciels/gromacs.1446735813.txt.gz · Dernière modification: 2015/11/05 16:03 de fabrep03