PNM in energygrp-table is not an energy group

GROMACS version: 2019.6
GROMACS modification: No

I am running the following command:
gmx_196 grompp -n index.ndx -f grompp.mdp -p topol.top -o topol.tpr -c conf.gro

And I am getting the following error:
PNM in energygrp-table is not an energy group

This is my mdp file:

; RUN CONTROL PARAMETERS
integrator               = sd
; Start time and timestep in ps
tinit                    = 0 
dt                       = 0.004
nsteps                   = 1000000
; For exact run continuation or redoing part of a run 
init_step                = 0 
; mode for center of mass motion removal
comm-mode                = Linear
; number of steps for center of mass motion removal
nstcomm                  = 1 
; group(s) for center of mass motion removal
comm-grps                =   

; OUTPUT CONTROL OPTIONS
; Output frequency for coords (x), velocities (v) and fo_ces (f) 
nstxout                  = 0 
nstvout                  = 0 
nstfout                  = 0 
; Output frequency for energies to log file and energy file
nstlog                   = 0 
nstenergy                = 5000
; Output frequency and precision for xtc file
nstxout-compressed       = 100 
compressed-x-precision   = 1000
; Selection of energy groups
energygrps               = WT PNM_&_BB PNM_&_BA PNM_&_BI

; NEIGHBORSEARCHING PARAMETERS
; nblist update frequency
nstlist                  = 5 
; ns algorithm (simple or grid)
ns-type                  = Grid
; Periodic boundary conditions: xyz, no, xy
pbc                      = xyz 
periodic_molecules       = no
; nblist cut-off    
rlist                    = 1.4 

; OPTIONS FOR ELECTROSTATICS AND VDW 
; Method for doing electrostatics
coulombtype              = User
rcoulomb-switch          = 0 
rcoulomb                 = 1.4 
; Relative dielectric constant for the medium and the reaction field
epsilon_r                = 1 
epsilon_rf               = 80
; Method for doing Van der Waals
vdw-type                 = User
; cut-off lengths    
rvdw-switch              = 0 
rvdw                     = 1.4 
; Apply long range dispersion corrections for Energy and Pressure
DispCorr                 = EnerPres
; Extension of the potential lookup tables beyond the cut-off
table-extension          = 1 
; Seperate tables between energy group pairs
Set energygrps           = PNM WT
energygrp_table          = PNM WT   WT WT
; Spacing for the PME/PPPM FFT grid
fourierspacing           = 0.12
; FFT grid size, when a value is 0 fourierspacing will be used
fourier_nx               = 0 
fourier_ny               = 0 
fourier_nz               = 0 
; EWALD/PME/PPPM parameters
pme_order                = 4 
ewald_rtol               = 1e-05
ewald_geometry           = 3d
epsilon_surface          = 0 

; IMPLICIT SOLVENT ALGORITHM
implicit_solvent         = No

; GENERALIZED BORN ELECTROSTATICS
; Algorithm for calculating Born radii
gb_algorithm             = Still
; Frequency of calculating the Born radii inside rlist
nstgbradii               = 1
; Cutoff for Born radii calculation; the contribution from atoms
; between rlist and rgbradii is updated every nstlist steps
rgbradii                 = 2
; Dielectric coefficient of the implicit solvent
gb_epsilon_solvent       = 80
; Salt concentration in M for Generalized Born models
gb_saltconc              = 0
; Scaling factors used in the OBC GB model. Default values are OBC(II)
gb_obc_alpha             = 1
gb_obc_beta              = 0.8
gb_obc_gamma             = 4.85
; Surface tension (kJ/mol/nm^2) for the SA (nonpolar surface) part of GBSA
; The default value (2.092) corresponds to 0.005 kcal/mol/Angstrom^2.
sa_surface_tension       = 2.092

; OPTIONS FOR WEAK COUPLING ALGORITHMS
; Temperature coupling
Tcoupl                   = no
; Groups to couple separately
tc-grps                  = System
; Time constant (ps) and reference temperature (K)
tau_t                    = 0.2
ref_t                    = 330
; Pressure coupling
Pcoupl                   = no
Pcoupltype               = isotropic
; Time constant (ps), compressibility (1/bar) and reference P (bar)
tau_p                    = 0.5
compressibility          = 4.5e-5
ref_p                    = 1.0
; Scaling of reference coordinates, No, All or COM
refcoord_scaling         = No

; GENERATE VELOCITIES FOR STARTUP RUN
gen-vel                  = no

; OPTIONS FOR BONDS
constraints              = none
cutoff-scheme = Group

I would appreciate any advice you have for me.

I was having trouble getting PNM as part of the energy group, so I added set energygrps to it, but it still doesnt seem to be working…

Your input file is inconsistent and defines energygrps multiple times.

Note that “set” in the second instance should break grompp because it is invalid syntax.

What is PNM, and what are you trying to accomplish with energygrps?

Hello Justin, thanks for your reply.
I have been trying to employ the VOTCA coarse-graining program, and it seems like they use energygrps to account for interactions. I managed to figure out the problems in the implementation, however. It was something to do with VOTCA’s organization, and not gmx.