<P>
Dear Mark,<BR>
<BR>
Thank you very much for the reply.<BR>
Well I used the following job script:<BR>
#!/bin/bash<BR>
#PBS&nbsp; -l vmem=800MB<BR>
#PBS&nbsp; -l ncpus=4<BR>
#PBS&nbsp; -l jobfs=10MB<BR>
#PBS&nbsp; -l software=gromacs<BR>
#PBS&nbsp; -l other=mpi<BR>
#PBS&nbsp; -q express<BR>
#PBS&nbsp; -wd<BR>
module&nbsp; load gromacs/3.3.2&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; <BR>
grompp_d -np $PBS_NCPUS -f mdout_NVE.mdp -p topol.top -c conf_100ps.gro -t pr.trr&nbsp; -o binary.tpr<BR>
mpirun mdrun_mpi_d -s binary.tpr -o pr1.trr -c output_1.gro -g topol.log<BR>
Note: pr.trr is the trajectory from 100ps NVT simulations, and conf_100ps.gro is the equilibrated box from the same.<BR>
--------------------------------------------------------------<BR>
MY .mdp file, for running NVE simulation after a 100ps equilibration with NVT, is pasted here:<BR>
title&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = Howdie<BR>
cpp&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = /usr/bin/cpp<BR>
; RUN CONTROL PARAMETERS<BR>
integrator&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp;  = md<BR>
; Start time and timestep in ps<BR>
tinit&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 0<BR>
dt&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp;  = 0.0015;<BR>
nsteps&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp;  = 40000<BR>
; For exact run continuation or redoing part of a run<BR>
init_step&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 100001<BR>
; number of steps for center of mass motion removal<BR>
nstcomm&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 1<BR>
; group(s) for center of mass motion removal<BR>
comm-grps&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = SOL<BR>
; OUTPUT CONTROL OPTIONS<BR>
; Output frequency for coords (x), velocities (v) and forces (f)<BR>
nstxout&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 0<BR>
nstvout&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 0<BR>
nstfout&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 0<BR>
; Checkpointing helps you continue after crashes<BR>
nstcheckpoint&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 1000<BR>
; Output frequency for energies to log file and energy file<BR>
nstlog&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp;  = 10000<BR>
nstenergy&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 1000<BR>
; Output frequency and precision for xtc file<BR>
nstxtcout&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 0<BR>
xtc-precision&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 1000<BR>
; select multiple groups. By default all atoms will be written.<BR>
; NEIGHBORSEARCHING PARAMETERS<BR>
nstlist&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 10<BR>
; ns algorithm (simple or grid)<BR>
ns_type&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = grid<BR>
; Periodic boundary conditions:<BR>
pbc&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = xyz<BR>
; nblist cut-off<BR>
rlist&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 1.0<BR>
; OPTIONS FOR ELECTROSTATICS AND VDW<BR>
; Method for doing electrostatics<BR>
coulombtype&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = pme<BR>
rcoulomb&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp;  = 1.0<BR>
ewald_rtol&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp;  = 1e-5&nbsp; ; since erfc(sigma*rcutoff)=ewald_rtol<BR>
optimize_fft&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp;  = yes<BR>
; Relative dielectric constant for the medium<BR>
epsilon_r&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 1&nbsp; ; for water<BR>
; Method for doing Van der Waals<BR>
vdw-type&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp;  = cut-off<BR>
rvdw&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp;  = 1.0<BR>
; Spacing for the PME/PPPM FFT grid<BR>
fourierspacing&nbsp; &nbsp; &nbsp; &nbsp; &nbsp;  = 0.12 ;<BR>
; EWALD/PME/PPPM parameters<BR>
pme_order&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 4<BR>
ewald_geometry&nbsp; &nbsp; &nbsp; &nbsp; &nbsp;  = 3d<BR>
epsilon_surface&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 0<BR>
; OPTIONS FOR WEAK COUPLING ALGORITHMS<BR>
; Temperature coupling<BR>
Tcoupl&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp;  = no<BR>
; Groups to couple separately<BR>
tc-grps&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = SOL<BR>
; Time constant (ps) and reference temperature (K)<BR>
tau-t&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 0.1<BR>
ref-t&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 300<BR>
; Pressure coupling<BR>
Pcoupl&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp;  = no<BR>
Pcoupltype&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp;  = Isotropic<BR>
; Time constant (ps), compressibility (1/bar) and reference P (bar)<BR>
tau-p&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 0.5<BR>
compressibility&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 4.5e-5<BR>
ref-p&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 1.0<BR>
; GENERATE VELOCITIES FOR STARTUP RUN<BR>
gen_vel&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = no<BR>
gen-temp&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp;  = 300<BR>
gen-seed&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp;  = 173529<BR>
; OPTIONS FOR BONDS<BR>
constraints&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = all-bonds<BR>
constraint_algorithm&nbsp; &nbsp;  = shake<BR>
shake_tol&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 0.0001<BR>
morse&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = no<BR>
--------------------------------------------------------<BR>
I suspect I made something wrong in these variables; Could anyone please correct it?<BR>
tinit&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 0<BR>
; For exact run continuation or redoing part of a run<BR>
init_step&nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; &nbsp; = 100001<BR>
<BR>
regards,<BR>
Jestin<BR>
<BR>
<BR>
<BR>
<BR>

</P>
<br><br>
<Table border=0 Width=644 Height=57 cellspacing=0 cellpadding=0 style='font-family:Verdana;font-size:11px;line-height:15px;'><TR><td><a href='http://adworks.rediff.com/cgi-bin/AdWorks/click.cgi/www.rediff.com/signature-home.htm/1050715198@Middle5/2076213_2068813/2076295/1?PARTNER=3&OAS_QUERY=null' target=new ><img src ='http://imadworks.rediff.com/cgi-bin/AdWorks/adimage.cgi/2076213_2068813/creative_2076295.gif'  alt='ICL'  border=0></a></td></TR></Table>