Sie sind auf Seite 1von 87

Introduction to DL_POLY

ILIAN TODOROV
SCIENTIFIC COMPUTING DEPARTMENT
STFC DARESBURY LABORATORY, UK

DL_POLY Trivia

General purpose parallel (classical) MD simulation software


It was conceived to meet needs of CCP5 - The Computer
Simulation of Condensed Phases (academic collaboration
community)
Written in modularised Fortran90 (NagWare & FORCHECK
compliant) with MPI2 (MPI1+MPI-I/O) & fully self-contained
1994 2010: DL_POLY_2 (RD) by W. Smith & T.R. Forester
(funded for 6 years by EPSRC at DL). In 2010 moved to a
BSD open source licence as DL_POLY_Classic.
2003 2010: DL_POLY_3 (DD) by I.T. Todorov & W. Smith
(funded for 4 years by NERC at Cambridge). Up-licensed to
DL_POLY_4 in 2010 free of charge to academic
researchers and at cost to industry (provided as source).
~ 15,500 licences taken out since 1994 (~1,600 annually)
~ 2,600 e-mail list and ~1,300 FORUM members (since 2005)

Current Versions

Written in modularised free formatted F90 (+MPI) with rigorous


code syntax (FORCHECK and NAGWare verified) and no external
library dependencies
DL_POLY_4 (version 5)
Domain Decomposition parallelisation, based on domain
decomposition (no dynamic load balancing), limits: up to
2.1109 atoms with inherent parallelisation
Parallel I/O (amber netCDF) and radiation damage features
Free format (flexible) reading with some fail-safe features
and basic reporting (but not fully fool-proofed)
DL_POLY Classic (version 1.9)
Replicated Data parallelisation, limits up to 30,000 atoms
with good parallelisation up to 100 (system dependent)
processors (running on any processor count)
Hyper-dynamics, Temperature Accelerated Dynamics,
Solvation Dynamics, Path Integral MD
Free format reading (somewhat rigid)

Molecular Dynamics in a Nutshell

Molecular Dynamics: Definitions

Theoretical tool for modelling the detailed microscopic behaviour


of many different types of systems, including; gases, liquids, solids,
polymers, surfaces and clusters.
In an MD simulation, the classical equations of motion governing
the microscopic time evolution of a many body system are solved
numerically, subject to the boundary conditions appropriate for the
geometry or symmetry of the system.
Can be used to monitor the microscopic mechanisms of energy
and mass transfer in chemical processes, and dynamical properties
such as absorption spectra, rate constants and transport properties
can be calculated.
Can be employed as a means of sampling from a statistical
mechanical ensemble and determining equilibrium properties.
These properties include average thermodynamic quantities
(pressure, volume, temperature, etc.), structure, and free energies
along reaction paths.

Molecular Dynamics for Beginners

MD simulations are used for:


Microscopic insight: we can follow the
motion of a single molecule (glass of
water)
Investigation of phase change (NaCl)
Understanding of complex systems like
polymers (plastics hydrophilic and
hydrophobic behaviour)

Example: Simulation of Argon

Pair Potential:

rcut

12 6
V (r ) 4
r r

Lagrangian:
N 1
1N

L(ri , vi ) mi vi 2 V (rij )
2 i
i j i

Lennard -Jones Potential

12 6
V (r ) 4
r r

V(r)

r
rcut
Pair-wise radial distance

Equations of Motion

d L L

dt vi ri

mi ai Fi
N

Fi f ij
j i

f ij iV (rij )

Lagrange Equation
time evolution

Force Evaluation
particle interactions

Boundary Conditions
2D cubic periodic

None biopolymer
simulations
Stochastic boundaries
biopolymers
Hard wall boundaries
pores, capillaries
Periodic boundaries
most MD simulations

Periodic Boundary Conditions

Triclinic

Truncated octahedron

Hexagonal prism

Rhombic dodecahedron

System Properties: Static (1)

1N 2
K. E. mi vi
2 i

Kinetic Energy:

2
T
K. E.
3Nk B

Temperature:

Uc

Configuration Energy:

Pressure:

V (rij )

1
PV Nk BT
3

i j i


ri fi
N
i

3 2 2 3Nk B

(U c )
Nk BT 1
NVE
2
2Cv
2

Specific heat:

System Properties: Static (2)

Structural Properties
Pair correlation (Radial Distribution Function):
n(r )
V
g(r )
2
2
4 r r N

(r rij )
i j i

Structure factor:
S (k ) 1 4

sin(kr)
g (r ) 1 r 2 dr
kr

Note: S(k) available from x-ray diffraction

System Properties: Dynamic (1)

Single correlation functions:

Mean squared displacement


(Einstein relation)

1
2
2 Dt = r i (t ) r i (0 )
3

Velocity Autocorrelation
(Green-Kubo relation)

1
D = 0 v i (t ) v i (0 ) d t
3

DL_POLY Essentials & Algorithms

Supported Molecular Entities

Rigid
molecules

Point ions
and atoms

Flexibly
linked rigid
molecules

Polarisable ions
(core+shell)
Flexible
molecules

Constraint
bonds

Rigid bond
linked rigid
molecules

Force Field Definitions I

particle: rigid ion or atom (charged or not), a core or a shell of a


polarisable ion (with or without associated degrees of freedom), a
massless charged site. A particle is a countable object and has a
global ID index.
site: a particle prototype that serves to defines the chemical &
physical nature (topology/connectivity/stoichiometry) of a particle
(mass, charge, frozen-ness). Sites are not atoms they are
prototypes!
Intra-molecular interactions: chemical bonds, bond angles,
dihedral angles, improper dihedral angles, inversions. Usually, the
members in a unit do not interact via an inter-molecular term.
However, this can be overridden for some interactions. These are
defined by site.

Inter-molecular interactions: van der Waals, metal (2B/E/EAM,


Gupta, Finnis-Sinclair, Sutton-Chen), Tersoff, three-body, fourbody. Defined by species.

Force Field Definitions II

Electrostatics: Standard Ewald*, Hautman-Klein (2D) Ewald*,


SPM Ewald (3D FFTs), Force-Shifted Coulomb, Reaction Field,
Fennell damped FSC+RF, Distance dependent dielectric constant,
Fuchs correction for non charge neutral MD cells.
Ion polarisation via Dynamic (Adiabatic) or Relaxed shell model.
External fields: Electric, Magnetic, Gravitational, Oscillating &
Continuous Shear, Containing Sphere, Repulsive Wall.
Intra-molecular like interactions: tethers, core shells units,
constraint and PMF units, rigid body units. These are also defined
by site.
Potentials: parameterised analytical forms defining the
interactions. These are always spherically symmetric!
THE CHEMICAL NATURE OF PARTICLES DOES NOT CHANGE
IN SPACE AND TIME!!! *

Force Field by Sums

N'


V( r1 , r2 ,....., rN ) U pair (| ri rj |)
i, j

N'

Tersoff

i, j, k

metal
N bond


ri , rj , rk

N'

N'
Vpair (| ri rj |)
i, j

U bond

i bond , ra , rb

N'

4 body


ri , rj , rk , rn

N'

F ij (| ri rj |)

i,
j

U angle

dihed


i dihed , ra , rb , rc , rd

i dihed

i tether

i, j


,
angle ra , rb , rc

i angle

N dihed

qiq j

| ri rj |
i, j, k,n

N angle

N'


ri , rj , rk

i, j, k

i bond

N tether

3 body

1
4 0

U tether

N invers

invers


iinvers , ra , rb , rc , rd

i invers

i tether , rt , rt 0

N core-shell

i core-shell

U core-shell

icore-shell , | ri rj |

i 1

external

ri

Boundary Conditions

None (e.g. isolated macromolecules)


Cubic periodic boundaries
Orthorhombic periodic boundaries
Parallelepiped (triclinic) periodic boundaries

Truncated octahedral periodic boundaries*

Rhombic dodecahedral periodic boundaries*


Slabs (i.e. x,y periodic, z non-periodic)

Assumed Parallel Architecture

DL_POLY is designed for homogenious


distributed parallel machines
M0

P0

P4

M4

M1

P1

P5

M5

M2

P2

P6

M6

M3

P3

P7

M7

Replicated Data Strategy I

Initialize

Initialize

Initialize

Initialize

Forces

Forces

Forces

Forces

Motion

Motion

Motion

Motion

Statistics

Statistics

Statistics

Statistics

Summary

Summary

Summary

Summary

Replicated Data Strategy II


Every processor sees
the full system
No memory distribution
(performance overheads
and limitations increase
with increasing system
size)
Functional/algorithmic
decomposition of the
workload
Cutoff 0.5 min system
width
Extensive global
communications
(extensive overheads
increase with increasing
system size)

Parallel (RD) Verlet List

P0

P0

P0

1,2

1,3

1,4

1,5

1,6

1,7

2,3

2,4

2,5

2,6

2,7

2,8

3,4

3,5

3,6

3,7

3,8

3,9

4,5

4,6

4,7

4,8

4,9

4,10

5,6

5,7

5,8

5,9

5,10

5,11

6,7

6,8

6,9

6,10

6,11

6,12

7,8

7,9

7,10

7,11

7,12

8,9

8,10

8,11

8,12

8,1

9,10

9,11

9,12

9,1

9,2

10,11

10,12

10,1

10,2

10,3

11,12

11,1

11,2

11,3

11,4

12,1

12,2

12,3

12,4

12,5

Distributed
list!

Domain Decomposition MD

Linked Cell Lists

Linked lists provide an elegant way to scale short-ranged


two body interactions from O(N2/2) to O(N). The
efficiency increases with increasing link cell partitioning
as a rule of thumb best efficacy is achieved for cubiclike partitioning with number of link-cells per domain 4
for any dimension.
Linked lists can be used with the same efficiency for 3body (bond-angles) and 4-body (dihedral & improper
dihedral & inversion angles) interactions. For these the
linked cell halo is double-layered and since cutoff3/4-body
0.5*cutoff2-body which makes the partitioning more
effective than that for the 2-body interactions.
The larger the particle density and/or the smaller the
cutoff with respect to the domain width, (the larger the
sub-selling and the better the spherical approximation of
the search area), the shorter the Verlet neighbour-list
search.

Linked Cell List Idea

Head of Chain
List

Link
List

Cell number
2

17

12

16

17

Link
Cell 2

10

16

10
1

12

10 11 12 13 14 15 16 17 18 19 20

Atom number

Sub-celling of LCs

1 2 3 4 5 6 7

Provides dynamically
adjustable workload for
variable local density
and VNL speed up of
30% (45% theoretically).
Provides excellent serial
performance, extremely
close to that of BrodeAhlrichs method for
construction of the Verlet
neighbour-list when
system sizes are smaller
< 5000 particles.

Parallel Force Calculation

Bonded forces:
- Algorithmic decomposition
- Interactions managed by bookkeeping arrays,
i.e. explicit bond definition
- Shared bookkeeping arrays

Nonbonded forces:
Distributed Verlet neighbour list (pair forces)
Link cells (3,4-body forces)

Implementations differ between DL_POLY_4 & C!

P0Local
force
terms
P1Local
force
terms
P2Local
force
terms

Processors

Molecular
force field
definition

Global Force Field

DL_POLY_C and Bonded Forces

P0Local
atomic
indices
Tricky!

P1Local
atomic
indices
P2Local
atomic
indices

Processor Domains

Molecular
force field
definition

Global force field

DL_POLY_4 and Bonded Forces

Topology Distribution

A
H

5
F

4
E

Replicated data

Domain decomposition

RD Distribution Scheme: Bond Forces

A2
A1

A3

P0

A6

A4

P1

A5

P2

A10

A8
A7

P3

A9

A11

P4

P5

A16

A14

A12
A13

P6

A15

P7

A17

P8

DD Distribution Scheme: Bond Forces

Ensembles and Algorithms


Integration:
Available as velocity Verlet (VV) or leapfrog Verlet (LFV)
generating flavours of the following ensembles
NVE
NVT (Ekin) Evans
NVT Andersen^, Langevin^, Berendsen, Nos-Hoover, GST
NPT Langevin^, Berendsen, Nos-Hoover, MartynaTuckerman-Klein^
NT/NPnAT/NPnT Langevin^, Berendsen, Nos-Hoover,
Martyna-Tuckerman-Klein^
Constraints & Rigid Body Solvers:
VV dependent RATTLE, No_Squish, QSHAKE*
LFV dependent SHAKE, Euler-Quaternion, QSHAKE*

Integration Algorithms

Essential Requirements:

Computational speed
Low memory demand
Accuracy
Stability (energy conservation, no drift)
Useful property - time reversibility
Extremely useful property symplecticness
= time reversibility + long term stability

Integration: Essential Idea

r (t+t)

v (t)t

r (t+t)

r (t)
f(t)t2/m

[r (t), v(t), f(t)]

[r (t+t), v(t+t), f(t+t)]

Simulation Cycle and Integration Schemes

Taylor expansion:
Setup

Set up initial
system

Forces

Calculate
forces

Motion

Calculate
motion

Stats.
Results

Accumulate
statistical data

Summarise
simulation

t 2 f n
rn 1 rn t vn
O t 3
2 m

Leapfrog Verlet (LFV)

Velocity Verlet (VV)

0. x i (t ), vi (t 12 t )

VV1. 0. x i (t ), vi (t ), f i (t )

1. f i (t ) calculated afresh

VV1. 1. vi (t 12 t ) vi (t )

t f i (t )
2 mi

f i (t )
mi VV1. 2. x (t t ) xi (t ) t v (t 1 t )
i
i
2
2
1
3. xi (t t ) xi (t ) t vi (t 2 t )
VV2. 0. f i (t t ) calculated afresh
2. vi (t 12 t ) vi (t 12 t ) t

VV2.1 . vi (t t ) vi (t 12 t )

t f i (t t )
2
mi

Integration Algorithms: Leapfrog Verlet

n 1/ 2 n 1/ 2 t n
vi
vi
Fi (t 3 )
mi
n 1 n
n 1/ 2
4
ri ri tvi
(t )
f n-2
rn-2

f n-1

rn-1
vn-3/2

fn
rn

Application in Practice
rn+1

vn-1/2 vn+1/2

Discrete time

n 1/ 2 n 1/ 2 t n
vi
vi

Fi
mi
n 1 n
n 1/ 2
ri ri tvi
n 1/ 2 n 1/ 2
n vi
vi
vi
2

Integration Algorithms: Velocity Verlet

n 1 n
n t 2 n
ri ri tvi
Fi (t 4 )
2mi
n 1 n t n n 1
vi vi
( Fi Fi ) (t 2 )
2mi
f n-2

f n-1

fn

f n+1

rn-2

rn-1

rn

rn+1

vn-2

vn-1

vn

vn+1

Discrete time

Application in Practice

n 1/ 2 n
t n
vi
vi
Fi
2mi
n 1 n
n 1/ 2
ri ri tvi
n 1 n 1/ 2
t n 1
vi vi

Fi
2mi

Constraint Solvers
t 2 f n g n
rn1 rn t vn
O t 3
2
m
t f n hn
vn 1 vn 1
O t 3
2
2 m

Taylor expansions:

SHAKE

iu

Gij i

io

u
d
ij
d ij

o
o
d ij
j
o

Gij G ji g ij d ij
2 u 2
ij (d ij d ij )
o u
g ij
2
2t
d ij d ij

ij

1
1

mi m j

RATTLE
RATTLE_R (SHAKE)

G ji

o2 u 2
ij (d ij d ij )
g ij 2 o u
t
d ij d ij

ju

vio
i

d ij

RATTLE_V

vio

H ij H ji hij d ij
o
ij (vi v j ) d ij
hij
t
d ij2

Replicated Data SHAKE

Proc A

Proc B

MU1

MU2
MU3
MU4

Extended Ensembles in VV Casting

Velocity Verlet integration algorithms can be naturally derived from the


non-commutable Liouvile evolution operator by using a second order
Suzuki-Trotter expansion. Thus they are symplectic/true ensembles
(with conserved quantities) warranting conservation of the phase-space
volume, time-reversibility and long term numerical stability
Examplary VV Expansion of NVE to NVE kin, NVT, NPT & NT
VV1 :

VV2 :

x i (t ), vi (t ), f i (t )

x i (t t ), vi (t 12 t ), f i (t t ) afresh

Thermostat(t t 14 t )

: 14 t

Barostat (t t 12 t )

: 12 t

Thermostat(t 14 t t 12 t ) : 14 t
t f i (t )
vi (t t ) vi (t )
2 mi
1
2

: t
1
2

t
xi (t t ) xi (t )
vi (t 12 t ) : t
2
RATTLE _ R(t t t )
: t

vi (t t ) vi (t 12 t )

t f i (t t ) 1
: 2 t
2
mi

RATTLE _ V (t 12 t t t )

: t

Thermostat(t 12 t t 34 t )

: 14 t

Barostat (t 12 t t t )

: 12 t

Thermostat(t 32 t t t )

: 14 t

Base Functionality

Molecular dynamics of polyatomic systems with


options to save the micro evolution trajectory at
regular intervals
Optimisation by conjugate gradients method or zero
Kelvin annealing
Statistics of common thermodynamic properties
(temperature, pressure, energy, enthalpy, volume)
with options to specify collection intervals and stack
size for production of rolling and final averages
Calculation of RDFs and Z-density profiles
Temperature scaling, velocity re-Gaussing
Force capping in equilibration

DL_POLY_4 Specials

Radiation damage driven features:


defects analysis
boundary thermostats
volumetric expansion
replay history
variable time step algorithm
Extra ensembles:
Langevin, Andersen, MTK, GST
extensions of NsT to NPnAT and NPnT
Infrequent k-space Ewald evaluation
Direct VdW
Direct Metal
Force shifted VdW
I/O driven features Parallel I/O & netCDF
Extra Reporting

DL_POLY_Classic Specials

Hyperdynamics
Bias potential dynamics
Temperature accelerated
dynamics
Nudged elastic band
Solvation properties:
Energy decomposition
Spectroscopic solvent shifts
Free energy of solution
Metadynamics

DL_POLY I/O Files

I/O Files

Crystallographic
(Dynamic) data
Simulation
Control data
Molecular /
Topological Data
Tabulated twobody potentials
EAM potential
data
Reference data
for DEFECTS

Restart data

Final
configuration
Simulation
summary data
Trajectory Data
Defects data
MSD & T inst data
Statistics data
Best CGM
configuration
RDF data
Z density data
Restart data

DL_POLY Units

Internally, DL_POLY uses atomic scale units:

Mass
Charge
Length
Time
Force
Energy

mass of H atom (D) [Daltons]


charge on proton (e)
Angstroms ()
picoseconds (ps)
D ps-2
D 2 ps-2 [10 J mol-1]

pressure is expressed in k-atm for I/O

Acceptable FIELD Input Units

UNITS directive in FIELD file allows to opt for the


following energy units

Internal DL_POLY units


Electron-volts
Kilo calories per mol
Kilo Joules per mol
Kelvin per Boltzmann

10 J mol-1
eV
k-cal mol-1
k-J mol-1
K Boltzmann-1

All interaction MUST have the same energy units!

CONTROL File

SIMULATION CONTROL
Free Format
Mandatory
Driven by keywords:

keyword [options] {data}


e.g.:
ensemble NPT Hoover 1.0 8.0

CONFIG [REVCON,CFGMIN] File

Initial atomic coordinates


Format
- Integers
(I10)
- Reals
(F20)
- Names
(A8)
Mandatory
Units:
- Position - Angstroms ()
- Velocity ps-1
- Force - D ps-2
Construction:
- Some kind of GUI essential
for complex systems

FIELD File

Force Field specification


Mandatory
Format:
-

Integers
Reals
Names
Keywords

(I5)
(F12)
(A8)
(A4)

Maps on to CONFIG file


structure
Construction
- Small systems - by hand
- Large systems nfold or
GUI!

TABLE File

Defines non-analytic
pair (vdw) potentials
Format
- Integers
(I10)
- Reals
(F15)
- Names
(A8)
Conditional, activated
by FIELD file option
Potential & Force
NB force (here) is:

G (r ) r U (r )
r

TABEAM File

Defines embedded atom potentials


Format
- Integers
(I10)
- Reals
(F15)
- Names
(A8)
Conditional, activated by FIELD file option
Potentials only
pair, embed & dens keywords for atom types
followed by data records (4 real numbers per
record)
Individual interpolation arrays

REVOLD [REVIVE] File

Provides program restart capability

File is unformatted (not human readable)

Contains thermodynamic accumulators, RDF


data, MSD data and other checkpoint data

REVIVE (output file) ---> REVOLD (input file)

OUTPUT File

Provides Job Summary (mandatory!)


Formatted to be human readable
Contents:
- Summary of input data
- Instantaneous thermodynamic data at selected intervals
- Rolling averages of thermodynamic data
- Statistical averages
- Final configuration
- Radial distribution data
- Estimated mean-square displacements and 3D diffusion
coefficient
Plus:
- Timing data, CFG and relaxed shell model iteration data
- Warning & Error reports

STATIS File

System properties at
intervals selected by user
Optional
Formatted (I10,E14)
Intended use: statistical
analysis (e.g. error) and
plotting vs. time.
Recommend use with GUI!
Header:
- Title
- Units
Data:
- Time step, time, #
entries
- System data

HISTORY File

Configuration data at user


selected intervals
Formatted
Optional
Header:
Title
Data level, cell key, number
Configuration data:
Time step and data keys
Cell Matrix
Atom name, mass, charge
X,Y,Z coordinates (level 0)
X,Y,Z velocities (level 1)
X,Y,Z forces (level 2)

RDFDAT [ZDNDAT] File

Formatted (A8,I10,E14)
Plotable
Optional
RDFs from pair forces
Header:
- Title
- No. plots & length of plot
RDF data:
- Atom symbols (2)
- Radius (A) & RDF
- Repeated
ZDNDAT file has same format

DL_POLY_4 Extra Files

REFERENCE file
Reference structure to compare against

DEFECTS file
Trajectory file of vacancies and interstitials
migration

MSDTMP file
Trajectory like file containing the each particles
Sqrt(MSDmean) and Tmean

DL_POLY_4 Performance

Proof of Concept on IBM p575 2005

300,763,000 NaCl with full SPME electrostatics


evaluation on 1024 CPU cores
Start-up time
Timestep time
FFT evaluation

1 hour
68 seconds
55 seconds

In theory ,the system can be seen by the eye. Although


you would need a very good microscope the MD cell
size for this system is 2m along the side and as the
wavelength of the visible light is 0.5m so it should be
theoretically possible.

Benchmarking BG/L Jlich 2007

Perfect
MD step total
Link cells
van der Waals
Ewald real
Ewald k-space

16000
14000

Speed Gain

12000
10000
8000
6000
4000

14.6 million particle Gd2Zr2O7 system

2000
2000

4000

6000

8000

10000

Processor count

12000

14000

16000

Weak Scaling

Solid Ar (32'000 atoms per CPU)


NaCl (27'000 ions per CPU)
SPC Water (20'736 ions per CPU)

1000

800

Speed Gain

fec
r
pe

n
tio
a
s
eli
l
l
a
33 million atoms
ar
p
t
28 million atoms

600

400

21 million atoms

n
allelisatio
r
a
p
d
o
o
g

200
max load
max load
max load

0
0

200

400

600

Processor Count

700'000 atoms per 1GB/CPU


220'000 ions per 1GB/CPU
210'000 ions per 1GB/CPU

800

1000

DL_POLY_4 RB v/s CB
HECToR (Cray XE6) 2013

Weak Scaling and Cost of Complexity


HECToR (Cray XE6) 2013

1.8
1.6

Time per timestep [s]

1.4

1.2
1
Argon

0.8

Transferrin

0.6

NaCl
RB water

0.4

CB water

0.2

0
0

200

400
600
MPI tasks count

800

1000

I/O Solutions

1. Serial read and write (sorted/unsorted) where only a single


MPI task, the master, handles it all and all the rest communicate
in turn to or get broadcasted to while the master completes
writing a configuration of the time evolution.
2. Parallel write via direct access or MPI-I/O (sorted/unsorted)
where ALL / SOME MPI tasks print in the same file in some
orderly manner so (no overlapping occurs using Fortran direct
access printing. However, it should be noted that the behaviour
of this method is not defined by the Fortran standard, and in
particular we have experienced problems when disk cache is not
coherent with the memory).
3. Parallel read via MPI-I/O or Fortran
4. Serial NetCDF read and write using NetCDF libraries for
machine-independent data formats of array-based, scientific
data (widely used by various scientific communities).

The Advanced Parallel I/O Strategy


HECToR (Cray XE6) 2012

P0

P1

M0

M1

I/O BATCH

I/O Group 0

72 I/O NODES

PX0-1
MX1-1

PX0

PX0+1

MX0

MX0+1

DISK

I/O BATCH

I/O BATCH

N compute cores of which M < N do I/O

PHEAD

I/O Group 1

PXn+1

MXn

MXn+1

WRITE ~ 50-150 Mbyte/s


with best performance
on 64 to 512 I/O Groups

Performance depends
on user defined number
of I/O groups, and I/O
batch (memory CPU to
I/O WRITE COMMS
disk) and buffer
I/O READ COMMS
(memory of comms
transactions between
CPUs)

MX1-1

Pslave

Memory

PXn

PX1-1

READ ~ 50-300 Mbyte/s


with best performance
on 16 to 128 I/O Groups

I/O Group n=M-1

PN-1
MN-1

Reasonable defaults as
a function of all MPI
tasks are provided

Obtaining & Building DL_POLY

DL_POLY Licensing and Support

Online Licence Facility at http://www.ccp5.ac.uk/DL_POLY/


The licence is
To protect copyright of Daresbury Laboratory
To reserve commercial rights
To provide documentary evidence justifying continued
support by UK Research Councils
It covers only the DL_POLY_4 package
Registered users are entered on the DL_POLY e-mailing list
Support is available (under CCP5 and EPSRC service level
agreement to CSED) only to UK academic researchers
For the rest of the world there is the online user forum
Last but not least there is a detailed, interactive, selfreferencing PDF (LaTeX) user manual

Supply of DL_POLY_4

Register at http://www.ccp5.ac.uk/DL_POLY/
Registration provides the decryption - procedure
and password (sent by e-mail)
Source is supplied by anonymous FTP (in an
invisible directory)
Source is in a tarred, gzipped and encrypted form
Successful unpacking produces a unix directory
structure
Test and benchmarking data are also available

DL_POLY_Classic Support

Full documentation of software supplied with source


Support is available through the online user forum or
the CCP5 user community
WWW:
http://www.ccp5.ac.uk/DL_POLY_CLASSIC/
FTP:
ftp://ftp.dl.ac.uk/ccp5/DL_POLY/
FORUM:
http://www.cse.stfc.ac.uk/disco/forums/ubbthreads.php/

Supply of DL_POLY_Classic

Downloads are available from CCPForge at


http://ccpforge.cse.rl.ac.uk/gf/project/dl_poly_classic/
No registration required BSD licence
Download source from: CCPForge: Projects: DL_POLY
Classic: Files: dl_poly_classic: dl_poly_classic1.9
Sources is a in tarred and gzipped form
Successful unpacking produces a unix directory
structure
Test data are also available

DL_POLY Directory Structure

build

DL_POLY

Home of makefiles

source

DL_POLY source code

execute

Home of executable
&
Working Directory

java

Java GUI source code

utility

Utility codes

data

Test data

DL_POLY_C v/s DL_POLY_4 Usage

1.
2.
3.
4.
5.

Note differences in capabilities (e.g. linked rigid bodies) !!!


Less than 10,000 atoms (if in parallel)? DL_POLY Classic
More than 30,000 atoms? DL_POLY_4
Ratio cell_width/rcut < 3 (in any direction)? DL_POLY_Classic
Less than 500 particles per processor? DL_POLY_Classic

DL_POLY_Classic
Simple molecules (no SHAKE)
8 or less, 10,000 atoms
16 or less, 20,000 atoms
32 or less, 30,000 atoms
Simple ionics
16 or less, 10,000 atoms
64 or less, 20,000 atoms
128 or less, 30,000 atoms
Molecules (with SHAKE)
64 max!

DL_POLY_4
Golden Rule 1: No fewer than
3x3x3 link cells per processor (if
in parallel)
Golden Rule 2: No fewer than
500 particles per processor (if in
parallel)!

DL_POLY Assisting Tools

The DL_POLY GUI


Developed by
Bill Smith

Java - Free!
Facilitate use of code
Selection of options (control of capability)
Construct (model) input files
Control of job submission
Analysis of output
Portable and easily extended by user

The Monitor Window

Show
Editor
Option

The Molecular Viewer

Editor
Button

Graphics
Buttons

Graphics
Window

The Molecular Editor

Editor
Buttons

Editor
Window

Available Menus

File - Simple file manipulation, exit etc.


FileMaker - make input files:
CONTROL, FIELD, CONFIG, TABLE

Execute
Select/store input files, run job
Analysis
Static, dynamic,statistics,viewing,plotting
Information
Licence, Force Field files, disclaimers etc.

A Typical GUI Panel

Buttons

Text Boxes

DL_FIELD http://www.ccp5.ac.uk/DL_FIELD/
Developed by
C.W. Yong

Orgainic Fields AMBER, CHARM, OPLS-AA, PCFF, Drieding,


CHARM19 (unated atom)
Inorganic Fields including a core-shell polarisation option
Solvation Features, Auto-CONNECT feature for mapping
complex random structures such as gels and random polymers
input units freedom and molecular rigidification

xyz
PDB

Protonated
SOD

DL_FIELD

black box

FIELD
4382
19400
7993
13000
730

CONFIG

atoms (excluding water)


bond interactions
angles interactions
dihedral interactions
VDW intearctions

DL_POLY & VMD

VMD is a free software package for visualising MD


data.
Website: http://www.ks.uiuc.edu/Research/vmd/
Useful for viewing snapshots and movies.
A plug in is available for DL_POLY HISTORY files
Otherwise convert HISTORY to XYZ or PDB format

DL_POLY on the Web

WWW:
http://www.ccp5.ac.uk/DL_POLY/
FTP:
ftp://ftp.dl.ac.uk/ccp5/DL_POLY/

DEV:
http://ccpforge.cse.rl.ac.uk/gf/project/dl-poly/
http://ccpforge.cse.rl.ac.uk/gf/project/dl_poly_classic/
FORUM:
http://www.cse.stfc.ac.uk/disco/forums/ubbthreads.php/

http://www.ccp5.ac.uk/DL_POLY/TUTORIAL/EXERCISES/index.html

Das könnte Ihnen auch gefallen