Constraint error in algorithm Lincs at step 0

I am trying to convert the lammps run to gromacs run.
The system is Sulphonated polystyrene-PEP system
Below is the gro.mdp

; Time step in ps
dt = 0.002

; Number of steps to run
nsteps = 100000000

; Remove center of mass motion every 100 steps
comm-mode = Linear
nstcomm = 100

; Write positions and velocities to the trr file every 5000 steps
; Output frequency for coords (x), velocities (v) and forces (f)
nstxout = 500000
nstvout = 500000

; Write to the log and energy file every 5000 steps
nstlog = 500000
nstenergy = 500000

; Calculate energies every 100 steps
nstcalcenergy = 100

; Write positions to three decimal places to xtc file every 5000 steps
nstxout-compressed = 500000
compressed-x-precision = 1000

; Use the Verlet cutoff scheme with grid neighbor searching; you should basically always use this when you can (the only time you wouldn’t would be if you were using tabulated potentials, buckingham interactions, or energy group exclusions; see manual for more detail)
cutoff-scheme = Verlet
ns_type = grid

; Periodic in all three dimensions
pbc = xyz

; Minimum cutoffs in nm for neighbor list, electrostatics, and LJ interactions. mdrun will tune rcoulomb for improved performance.
rlist = 1.2
rcoulomb = 1.2
rvdw = 1.2

; Use the PME algorithm (an alternative to PPPM) (this is very likely the electrostatics algorithm you want to use)
coulombtype = PME

; Smoothly shift vdw interactions to zero at the cutoff
vdw-type = Cut-off
vdw-modifier = Potential-shift-Verlet

; GENERATE VELOCITIES FOR STARTUP RUN =
gen-vel = yes
gen-temp = 500
gen-seed = 173529

; Use the v-rescale thermostat with a time constant of 0.1 ps and temperature of 600. V-rescale correctly samples the canonical distribution. Nose-hoover would be another good choice.
tcoupl = V-rescale
tc-grps = System
tau_t = 0.1
ref_t = 500

; Don’t use pressure coupling. For NPT this should be set. For equilibration, Berendsen is best since it is more stable. For production runs, Parrinello-Rahman is best since it samples the correct ensemble.
pcoupl = no
pcoupltype = Isotropic
tau-p = 1
refcoord-scaling = No

; Use the LINCS algorithm to turn all bonds with hydrogen atoms into constraints. This allows a larger timestep. (can also use shake if needed, but lincs is faster)
constraint_algorithm = lincs
constraints = H-bonds

; Do not generate initial velocities; rather this run is a continuation from a previous run. Alternately, set gen_vel to yes and give it a temperature to sample the maxwell distribution at, and set continuation to no.
;gen_vel = no
;continuation = yes

; Dielectric constant (DC) for cut-off or DC of reaction field =
epsilon-r = 30

I get below errors without writing 0 step.
Pls advise
Constraint error in algorithm Lincs at step 0
Wrote pdb files with previous and current coordinates
Energies (kJ/mol)
Bond Angle Ryckaert-Bell. LJ-14 Coulomb-14
4.27106e+05 1.50633e+06 5.91270e+05 6.86663e+11 3.05070e+03
LJ (SR) Coulomb (SR) Coul. recip. Potential Kinetic En.
-7.53248e+05 -3.79779e+04 1.25542e+03 6.86665e+11 7.08830e+22
Total Energy Conserved En. Temperature Pressure (bar) Constr. rmsd
7.08830e+22 7.08830e+22 1.57346e+19 1.88028e+20 1.83821e+07


Program: gmx mdrun, version 2024.2
Source file: src/gromacs/ewald/pme_redistribute.cpp (line 305)
MPI rank: 0 (out of 2)

Fatal error:
1 particles communicated to PME rank 0 are more than 2/3 times the cut-off out
of the domain decomposition cell of their charge group in dimension x.
This usually means that your system is not well equilibrated.

I think it seems risky starting a GROMACS simulation directly from the output of LAMMPS, using the output velocities. Even if that is what you would really want to do, I would still recommend testing if it works better if you run energy minimization and equilibration in GROMACS.