diff --git a/doc/molecule.html b/doc/molecule.html
index cec3bbe33..270a3742d 100644
--- a/doc/molecule.html
+++ b/doc/molecule.html
@@ -1,399 +1,399 @@
 <HTML>
 <CENTER><A HREF = "http://lammps.sandia.gov">LAMMPS WWW Site</A> - <A HREF = "Manual.html">LAMMPS Documentation</A> - <A HREF = "Section_commands.html#comm">LAMMPS Commands</A> 
 </CENTER>
 
 
 
 
 
 
 <HR>
 
 <H3>molecule command 
 </H3>
 <P><B>Syntax:</B>
 </P>
 <PRE>molecule ID file1 file2 ... 
 </PRE>
 <UL><LI>ID = user-assigned name for the molecule template
 <LI>file1,file2,... = names of files containing molecule descriptions 
 </UL>
 <P><B>Examples:</B>
 </P>
 <PRE>molecule 1 mymol
 molecule 1 co2.txt h2o.txt
 molecule CO2 co2.txt 
 </PRE>
 <P><B>Description:</B>
 </P>
 <P>Define a molecule template that can be used as part of other LAMMPS
 commands, typically to define a collection of particles as a bonded
 molecule or a rigid body.  Commands that currently use molecule
 templates (or will in the future) include:
 </P>
 <UL><LI><A HREF = "fix_deposit.html">fix deposit</A>
 <LI><A HREF = "fix_pour.html">fix pour</A>
 <LI><A HREF = "fix_rigid.html">fix rigid/small</A>
 <LI><A HREF = "fix_shake.html">fix shake</A>
-<LI><A HREF = "fix_gcmc.html">fix gcmc</A> (not yet)
+<LI><A HREF = "fix_gcmc.html">fix gcmc</A>
 <LI><A HREF = "create_atoms.html">create_atoms</A> 
 <LI><A HREF = "atom_style.html">atom_style template</A> 
 </UL>
 <P>The ID of a molecule template can only contain alphanumeric characters
 and underscores.
 </P>
 <P>A single template can contain multiple molecules, listed one per file.
 Many of the commands listed above currently use only the first
 molecule in the template, and will issue a warning if the template
 contains multiple molecules.  The <A HREF = "atom_style.html">atom_style
 template</A> command allows multiple-molecule templates
 to define a system with more than one templated molecule.
 </P>
 <P>IMPORTANT NOTE: When using the <A HREF = "atom_style.html">atom_style template</A>
 command with a molecule template that contains multiple molecules, you
 should insure the atom types, bond types, angle_types, etc in all the
 molecules are consistent.  E.g. if one molecule represents H2O and
 another CO2, then you probably do not want each molecule file to
 define 2 atom types and a single bond type, because they will conflict
 with each other when a mixture system of H2O and CO2 molecules is
 defined, e.g.  by the <A HREF = "read_data.html">read_data</A> command.  Rather the
 H2O molecule should define atom types 1 and 2, and bond type 1.  And
 the CO2 molecule should define atom types 3 and 4 (or atom types 3 and
 2 if a single oxygen type is desired), and bond type 2.
 </P>
 <P>The format of an individual molecule file is similar to the data file
 read by the <A HREF = "read_data.html">read_data</A> commands, and is as follows.
 </P>
 <P>A molecule file has a header and a body.  The header appears first.
 The first line of the header is always skipped; it typically contains
 a description of the file.  Then lines are read one at a time.  Lines
 can have a trailing comment starting with '#' that is ignored.  If the
 line is blank (only whitespace after comment is deleted), it is
 skipped.  If the line contains a header keyword, the corresponding
 value(s) is read from the line.  If it doesn't contain a header
 keyword, the line begins the body of the file.
 </P>
 <P>The body of the file contains zero or more sections.  The first line
 of a section has only a keyword.  The next line is skipped.  The
 remaining lines of the section contain values.  The number of lines
 depends on the section keyword as described below.  Zero or more blank
 lines can be used between sections.  Sections can appear in any order,
 with a few exceptions as noted below.
 </P>
 <P>These are the recognized header keywords.  Header lines can come in
 any order.  The numeric value(s) are read from the beginning of the
 line.  The keyword should appear at the end of the line.  All these
 settings have default values, as explained below.  A line need only
 appear if the value(s) are different than the default.
 </P>
 <UL><LI>N <I>atoms</I> = # of atoms N in molecule, default = 0
 <LI>Nb <I>bonds</I> = # of bonds Nb in molecule, default = 0
 <LI>Na <I>angles</I> = # of angles Na in molecule, default = 0
 <LI>Nd <I>dihedrals</I> = # of dihedrals Nd in molecule, default = 0
 <LI>Ni <I>impropers</I> = # of impropers Ni in molecule, default = 0
 <LI>Mtotal <I>mass</I> = total mass of molecule
 <LI>Xc Yc Zc <I>com</I> = coordinates of center-of-mass of molecule
 <LI>Ixx Iyy Izz Ixy Ixz Iyz <I>inertia</I> = 6 components of inertia tensor of molecule 
 </UL>
 <P>For <I>mass</I>, <I>com</I>, and <I>inertia</I>, the default is for LAMMPS to
 calculate this quantity itself if needed, assuming the molecules
 consists of a set of point particles.  You typically only need to
 specify these values for a rigid body consisting of overlapping
 finite-size particles.
 </P>
 <P>The mass and center-of-mass coordinates (Xc,Yc,Zc) are
 self-explanatory.  The 6 moments of inertia (ixx,iyy,izz,ixy,ixz,iyz)
 should be the values consistent with the current orientation of the
 rigid body around its center of mass.  The values are with respect to
 the simulation box XYZ axes, not with respect to the prinicpal axes of
 the rigid body itself.  LAMMPS performs the latter calculation
 internally.
 </P>
 <P>These are the allowed section keywords for the body of the file.
 </P>
 <UL><LI><I>Coords, Types, Charges, Diameters, Masses</I> = atom-property sections 
 <LI><I>Bonds, Angles, Dihedrals, Impropers</I> = molecular topology sections 
 <LI><I>Special Bond Counts, Special Bonds</I> = special neighbor info
 <LI><I>Shake Flags, Shake Atoms, Shake Bond Types</I> = SHAKE info 
 </UL>
 <P>IMPORTANT NOTE: Whether a section is required depends on how the
 molecule template is used by other LAMMPS commands.  For example, to
 add a molecule via the <A HREF = "fix_deposit.html">fix deposit</A> command, the
 Coords and Types sections are required.  To add a rigid body via the
 <A HREF = "fix_pout.html">fix pour</A> command, the Bonds (Angles, etc) sections are
 not required, since the molecule will be treated as a rigid body.
 Some sections are optional.  For example, the <A HREF = "fix_pour.html">fix pour</A>
 command can be used to add "molecules" which are clusters of
 finite-size granular particles.  If the Diameters section is not
 specified, each particle in the molecule will have a default diameter
 of 1.0.  See the doc pages for LAMMPS commands that use molecule
 templates for more details.
 </P>
 <P>Each section is listed below in alphabetic order.  The format of each
 section is described including the number of lines it must contain and
 rules (if any) for whether it can appear in the data file.  In each
 case the ID is ignored; it is simply included for readability, and
 should be a number from 1 to Nlines for the section, indicating which
 atom (or bond, etc) the entry applies to.  The lines are assumed to be
 listed in order from 1 to Nlines, but LAMMPS does not check for this.
 </P>
 <HR>
 
 <P><I>Coords</I> section:
 </P>
 <UL><LI>one line per atom
 <LI>line syntax: ID x y z
 <LI>x,y,z = coordinate of atom 
 </UL>
 <HR>
 
 <P><I>Types</I> section:
 </P>
 <UL><LI>one line per atom
 <LI>line syntax: ID type
 <LI>type = atom type of atom 
 </UL>
 <HR>
 
 <P><I>Charges</I> section:
 </P>
 <UL><LI>one line per atom
 <LI>line syntax: ID q
 <LI>q = charge on atom 
 </UL>
 <P>This section is only allowed for <A HREF = "atom_style.html">atom styles</A> that
 support charge.  If this section is not included, the default charge
 on each atom in the molecule is 0.0.
 </P>
 <HR>
 
 <P><I>Diameters</I> section:
 </P>
 <UL><LI>one line per atom
 <LI>line syntax: ID diam
 <LI>diam = diameter of atom 
 </UL>
 <P>This section is only allowed for <A HREF = "atom_style.html">atom styles</A> that
 support finite-size spherical particles, e.g. atom_style sphere.  If
 not listed, the default diameter of each atom in the molecule is 1.0.
 </P>
 <HR>
 
 <P><I>Masses</I> section:
 </P>
 <UL><LI>one line per atom
 <LI>line syntax: ID mass
 <LI>mass = mass of atom 
 </UL>
 <P>This section is only allowed for <A HREF = "atom_style.html">atom styles</A> that
 support per-atom mass, as opposed to per-type mass.  See the
 <A HREF = "mass.html">mass</A> command for details.  If this section is not
 included, the default mass for each atom is derived from its volume
 (see Diameters section) and a default density of 1.0, in
 <A HREF = "units.html">units</A> of mass/volume.
 </P>
 <HR>
 
 <P><I>Bonds</I> section:
 </P>
 <UL><LI>one line per bond
 <LI>line syntax: ID type atom1 atom2
 <LI>type = bond type (1-Nbondtype)
 <LI>atom1,atom2 = IDs of atoms in bond 
 </UL>
 <P>The IDs for the two atoms in each bond should be values
 from 1 to Natoms, where Natoms = # of atoms in the molecule.
 </P>
 <HR>
 
 <P><I>Angles</I> section:
 </P>
 <UL><LI>one line per angle
 <LI>line syntax: ID type atom1 atom2 atom3
 <LI>type = angle type (1-Nangletype)
 <LI>atom1,atom2,atom3 = IDs of atoms in angle 
 </UL>
 <P>The IDs for the three atoms in each angle should be values from 1 to
 Natoms, where Natoms = # of atoms in the molecule.  The 3 atoms are
 ordered linearly within the angle.  Thus the central atom (around
 which the angle is computed) is the atom2 in the list.
 </P>
 <HR>
 
 <P><I>Dihedrals</I> section:
 </P>
 <UL><LI>one line per dihedral
 <LI>line syntax: ID type atom1 atom2 atom3 atom4
 <LI>type = dihedral type (1-Ndihedraltype)
 <LI>atom1,atom2,atom3,atom4 = IDs of atoms in dihedral 
 </UL>
 <P>The IDs for the four atoms in each dihedral should be values from 1 to
 Natoms, where Natoms = # of atoms in the molecule.  The 4 atoms are
 ordered linearly within the dihedral.
 </P>
 <HR>
 
 <P><I>Impropers</I> section:
 </P>
 <UL><LI>one line per improper
 <LI>line syntax: ID type atom1 atom2 atom3 atom4
 <LI>type = improper type (1-Nimpropertype)
 <LI>atom1,atom2,atom3,atom4 = IDs of atoms in improper 
 </UL>
 <P>The IDs for the four atoms in each improper should be values from 1 to
 Natoms, where Natoms = # of atoms in the molecule.  The ordering of
 the 4 atoms determines the definition of the improper angle used in
 the formula for the defined <A HREF = "improper_style.html">improper style</A>.  See
 the doc pages for individual styles for details.
 </P>
 <HR>
 
 <P><I>Special Bond Counts</I> section:
 </P>
 <UL><LI>one line per atom
 <LI>line syntax: ID N1 N2 N3
 <LI>N1 = # of 1-2 bonds
 <LI>N2 = # of 1-3 bonds
 <LI>N3 = # of 1-4 bonds 
 </UL>
 <P>N1, N2, N3 are the number of 1-2, 1-3, 1-4 neighbors respectively of
 this atom within the topology of the molecule.  See the
 <A HREF = "special_bonds.html">special_bonds</A> doc page for more discussion of
 1-2, 1-3, 1-4 neighbors.  If this section appears, the Special Bonds
 section must also appear.  If this section is not specied, the
 atoms in the molecule will have no special bonds.
 </P>
 <HR>
 
 <P><I>Special Bonds</I> section:
 </P>
 <UL><LI>one line per atom
 <LI>line syntax: ID a b c d ...
 <LI>a,b,c,d,... = IDs of atoms in N1+N2+N3 special bonds 
 </UL>
 <P>A, b, c, d, etc are the IDs of the n1+n2+n3 atoms that are 1-2, 1-3,
 1-4 neighbors of this atom.  The IDs should be values from 1 to
 Natoms, where Natoms = # of atoms in the molecule.  The first N1
 values should be the 1-2 neighbors, the next N2 should be the 1-3
 neighbors, the last N3 should be the 1-4 neighbors.  No atom ID should
 appear more than once.  See the <A HREF = "special_bonds.html">special_bonds</A> doc
 page for more discussion of 1-2, 1-3, 1-4 neighbors.  If this section
 appears, the Special Bond Counts section must also appear.  If this
 section is not specied, the atoms in the molecule will have no special
 bonds.
 </P>
 <HR>
 
 <P><I>Shake Flags</I> section:
 </P>
 <UL><LI>one line per atom
 <LI>line syntax: ID flag
 <LI>flag = 0,1,2,3,4 
 </UL>
 <P>This section is only needed when molecules created using the template
 will be constrained by SHAKE via the "fix shake" command.  The other
 two Shake sections must also appear in the file, following this one.
 </P>
 <P>The meaning of the flag for each atom is as follows.  See the <A HREF = "fix_shake.html">fix
 shake</A> doc page for a further description of SHAKE
 clusters.
 </P>
 <UL><LI>0 = not part of a SHAKE cluster
 <LI>1 = part of a SHAKE angle cluster (two bonds and the angle they form)
 <LI>2 = part of a 2-atom SHAKE cluster with a single bond
 <LI>3 = part of a 3-atom SHAKE cluster with two bonds
 <LI>4 = part of a 4-atom SHAKE cluster with three bonds 
 </UL>
 <HR>
 
 <P><I>Shake Atoms</I> section:
 </P>
 <UL><LI>one line per atom
 <LI>line syntax: ID a b c d
 <LI>a,b,c,d = IDs of atoms in cluster 
 </UL>
 <P>This section is only needed when molecules created using the template
 will be constrained by SHAKE via the "fix shake" command.  The other
 two Shake sections must also appear in the file.
 </P>
 <P>The a,b,c,d values are atom IDs (from 1 to Natoms) for all the atoms
 in the SHAKE cluster that this atom belongs to.  The number of values
 that must appear is determined by the shake flag for the atom (see the
 Shake Flags section above).  All atoms in a particular cluster should
 list their a,b,c,d values identically.
 </P>
 <P>If flag = 0, no a,b,c,d values are listed on the line, just the
 (ignored) ID.
 </P>
 <P>If flag = 1, a,b,c are listed, where a = ID of central atom in the
 angle, and b,c the other two atoms in the angle.
 </P>
 <P>If flag = 2, a,b are listed, where a = ID of atom in bond with the the
 lowest ID, and b = ID of atom in bond with the highest ID.
 </P>
 <P>If flag = 3, a,b,c are listed, where a = ID of central atom,
 and b,c = IDs of other two atoms bonded to the central atom.
 </P>
 <P>If flag = 4, a,b,c,d are listed, where a = ID of central atom,
 and b,c,d = IDs of other three atoms bonded to the central atom.
 </P>
 <P>See the <A HREF = "fix_shake.html">fix shake</A> doc page for a further description
 of SHAKE clusters.
 </P>
 <HR>
 
 <P><I>Shake Bond Types</I> section:
 </P>
 <UL><LI>one line per atom
 <LI>line syntax: ID a b c
 <LI>a,b,c = bond types (or angle type) of bonds (or angle) in cluster 
 </UL>
 <P>This section is only needed when molecules created using the template
 will be constrained by SHAKE via the "fix shake" command.  The other
 two Shake sections must also appear in the file.
 </P>
 <P>The a,b,c values are bond types (from 1 to Nbondtypes) for all bonds
 in the SHAKE cluster that this atom belongs to.  The number of values
 that must appear is determined by the shake flag for the atom (see the
 Shake Flags section above).  All atoms in a particular cluster should
 list their a,b,c values identically.
 </P>
 <P>If flag = 0, no a,b,c values are listed on the line, just the
 (ignored) ID.
 </P>
 <P>If flag = 1, a,b,c are listed, where a = bondtype of the bond between
 the central atom and the first non-central atom (value b in the Shake
 Atoms section), b = bondtype of the bond between the central atom and
 the 2nd non-central atom (value c in the Shake Atoms section), and c =
 the angle type (1 to Nangletypes) of the angle between the 3 atoms.
 </P>
 <P>If flag = 2, only a is listed, where a = bondtype of the bond between
 the 2 atoms in the cluster.
 </P>
 <P>If flag = 3, a,b are listed, where a = bondtype of the bond between
 the central atom and the first non-central atom (value b in the Shake
 Atoms section), and b = bondtype of the bond between the central atom
 and the 2nd non-central atom (value c in the Shake Atoms section).
 </P>
 <P>If flag = 4, a,b,c are listed, where a = bondtype of the bond between
 the central atom and the first non-central atom (value b in the Shake
 Atoms section), b = bondtype of the bond between the central atom and
 the 2nd non-central atom (value c in the Shake Atoms section), and c =
 bondtype of the bond between the central atom and the 3rd non-central
 atom (value d in the Shake Atoms section).
 </P>
 <P>See the <A HREF = "fix_shake.html">fix shake</A> doc page for a further description
 of SHAKE clusters.
 </P>
 <HR>
 
 <P><B>Restrictions:</B> none
 </P>
 <P><B>Related commands:</B>
 </P>
 <P><A HREF = "fix_deposit.html">fix deposit</A>, <A HREF = "fix_pour.html">fix pour</A>,
 <A HREF = "fix_gcmc.html">fix_gcmc</A>
 </P>
 <P><B>Default:</B> none
 </P>
 </HTML>
diff --git a/doc/molecule.txt b/doc/molecule.txt
index b70f165c7..1af3078c6 100644
--- a/doc/molecule.txt
+++ b/doc/molecule.txt
@@ -1,394 +1,394 @@
 "LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc :c
 
 :link(lws,http://lammps.sandia.gov)
 :link(ld,Manual.html)
 :link(lc,Section_commands.html#comm)
 
 :line
 
 molecule command :h3
 
 [Syntax:]
 
 molecule ID file1 file2 ... :pre
 
 ID = user-assigned name for the molecule template
 file1,file2,... = names of files containing molecule descriptions :ul
 
 [Examples:]
 
 molecule 1 mymol
 molecule 1 co2.txt h2o.txt
 molecule CO2 co2.txt :pre
 
 [Description:]
 
 Define a molecule template that can be used as part of other LAMMPS
 commands, typically to define a collection of particles as a bonded
 molecule or a rigid body.  Commands that currently use molecule
 templates (or will in the future) include:
 
 "fix deposit"_fix_deposit.html
 "fix pour"_fix_pour.html
 "fix rigid/small"_fix_rigid.html
 "fix shake"_fix_shake.html
-"fix gcmc"_fix_gcmc.html (not yet)
+"fix gcmc"_fix_gcmc.html
 "create_atoms"_create_atoms.html 
 "atom_style template"_atom_style.html :ul
 
 The ID of a molecule template can only contain alphanumeric characters
 and underscores.
 
 A single template can contain multiple molecules, listed one per file.
 Many of the commands listed above currently use only the first
 molecule in the template, and will issue a warning if the template
 contains multiple molecules.  The "atom_style
 template"_atom_style.html command allows multiple-molecule templates
 to define a system with more than one templated molecule.
 
 IMPORTANT NOTE: When using the "atom_style template"_atom_style.html
 command with a molecule template that contains multiple molecules, you
 should insure the atom types, bond types, angle_types, etc in all the
 molecules are consistent.  E.g. if one molecule represents H2O and
 another CO2, then you probably do not want each molecule file to
 define 2 atom types and a single bond type, because they will conflict
 with each other when a mixture system of H2O and CO2 molecules is
 defined, e.g.  by the "read_data"_read_data.html command.  Rather the
 H2O molecule should define atom types 1 and 2, and bond type 1.  And
 the CO2 molecule should define atom types 3 and 4 (or atom types 3 and
 2 if a single oxygen type is desired), and bond type 2.
 
 The format of an individual molecule file is similar to the data file
 read by the "read_data"_read_data.html commands, and is as follows.
 
 A molecule file has a header and a body.  The header appears first.
 The first line of the header is always skipped; it typically contains
 a description of the file.  Then lines are read one at a time.  Lines
 can have a trailing comment starting with '#' that is ignored.  If the
 line is blank (only whitespace after comment is deleted), it is
 skipped.  If the line contains a header keyword, the corresponding
 value(s) is read from the line.  If it doesn't contain a header
 keyword, the line begins the body of the file.
 
 The body of the file contains zero or more sections.  The first line
 of a section has only a keyword.  The next line is skipped.  The
 remaining lines of the section contain values.  The number of lines
 depends on the section keyword as described below.  Zero or more blank
 lines can be used between sections.  Sections can appear in any order,
 with a few exceptions as noted below.
 
 These are the recognized header keywords.  Header lines can come in
 any order.  The numeric value(s) are read from the beginning of the
 line.  The keyword should appear at the end of the line.  All these
 settings have default values, as explained below.  A line need only
 appear if the value(s) are different than the default.
 
 N {atoms} = # of atoms N in molecule, default = 0
 Nb {bonds} = # of bonds Nb in molecule, default = 0
 Na {angles} = # of angles Na in molecule, default = 0
 Nd {dihedrals} = # of dihedrals Nd in molecule, default = 0
 Ni {impropers} = # of impropers Ni in molecule, default = 0
 Mtotal {mass} = total mass of molecule
 Xc Yc Zc {com} = coordinates of center-of-mass of molecule
 Ixx Iyy Izz Ixy Ixz Iyz {inertia} = 6 components of inertia tensor of molecule :ul
 
 For {mass}, {com}, and {inertia}, the default is for LAMMPS to
 calculate this quantity itself if needed, assuming the molecules
 consists of a set of point particles.  You typically only need to
 specify these values for a rigid body consisting of overlapping
 finite-size particles.
 
 The mass and center-of-mass coordinates (Xc,Yc,Zc) are
 self-explanatory.  The 6 moments of inertia (ixx,iyy,izz,ixy,ixz,iyz)
 should be the values consistent with the current orientation of the
 rigid body around its center of mass.  The values are with respect to
 the simulation box XYZ axes, not with respect to the prinicpal axes of
 the rigid body itself.  LAMMPS performs the latter calculation
 internally.
 
 These are the allowed section keywords for the body of the file.
 
 {Coords, Types, Charges, Diameters, Masses} = atom-property sections 
 {Bonds, Angles, Dihedrals, Impropers} = molecular topology sections 
 {Special Bond Counts, Special Bonds} = special neighbor info
 {Shake Flags, Shake Atoms, Shake Bond Types} = SHAKE info :ul
 
 IMPORTANT NOTE: Whether a section is required depends on how the
 molecule template is used by other LAMMPS commands.  For example, to
 add a molecule via the "fix deposit"_fix_deposit.html command, the
 Coords and Types sections are required.  To add a rigid body via the
 "fix pour"_fix_pout.html command, the Bonds (Angles, etc) sections are
 not required, since the molecule will be treated as a rigid body.
 Some sections are optional.  For example, the "fix pour"_fix_pour.html
 command can be used to add "molecules" which are clusters of
 finite-size granular particles.  If the Diameters section is not
 specified, each particle in the molecule will have a default diameter
 of 1.0.  See the doc pages for LAMMPS commands that use molecule
 templates for more details.
 
 Each section is listed below in alphabetic order.  The format of each
 section is described including the number of lines it must contain and
 rules (if any) for whether it can appear in the data file.  In each
 case the ID is ignored; it is simply included for readability, and
 should be a number from 1 to Nlines for the section, indicating which
 atom (or bond, etc) the entry applies to.  The lines are assumed to be
 listed in order from 1 to Nlines, but LAMMPS does not check for this.
 
 :line
 
 {Coords} section:
 
 one line per atom
 line syntax: ID x y z
 x,y,z = coordinate of atom :ul
 
 :line
 
 {Types} section:
 
 one line per atom
 line syntax: ID type
 type = atom type of atom :ul
 
 :line
 
 {Charges} section:
 
 one line per atom
 line syntax: ID q
 q = charge on atom :ul
 
 This section is only allowed for "atom styles"_atom_style.html that
 support charge.  If this section is not included, the default charge
 on each atom in the molecule is 0.0.
 
 :line
 
 {Diameters} section:
 
 one line per atom
 line syntax: ID diam
 diam = diameter of atom :ul
 
 This section is only allowed for "atom styles"_atom_style.html that
 support finite-size spherical particles, e.g. atom_style sphere.  If
 not listed, the default diameter of each atom in the molecule is 1.0.
 
 :line
 
 {Masses} section:
 
 one line per atom
 line syntax: ID mass
 mass = mass of atom :ul
 
 This section is only allowed for "atom styles"_atom_style.html that
 support per-atom mass, as opposed to per-type mass.  See the
 "mass"_mass.html command for details.  If this section is not
 included, the default mass for each atom is derived from its volume
 (see Diameters section) and a default density of 1.0, in
 "units"_units.html of mass/volume.
 
 :line
 
 {Bonds} section:
 
 one line per bond
 line syntax: ID type atom1 atom2
 type = bond type (1-Nbondtype)
 atom1,atom2 = IDs of atoms in bond :ul
 
 The IDs for the two atoms in each bond should be values
 from 1 to Natoms, where Natoms = # of atoms in the molecule.
 
 :line
 
 {Angles} section:
 
 one line per angle
 line syntax: ID type atom1 atom2 atom3
 type = angle type (1-Nangletype)
 atom1,atom2,atom3 = IDs of atoms in angle :ul
 
 The IDs for the three atoms in each angle should be values from 1 to
 Natoms, where Natoms = # of atoms in the molecule.  The 3 atoms are
 ordered linearly within the angle.  Thus the central atom (around
 which the angle is computed) is the atom2 in the list.
 
 :line
 
 {Dihedrals} section:
 
 one line per dihedral
 line syntax: ID type atom1 atom2 atom3 atom4
 type = dihedral type (1-Ndihedraltype)
 atom1,atom2,atom3,atom4 = IDs of atoms in dihedral :ul
 
 The IDs for the four atoms in each dihedral should be values from 1 to
 Natoms, where Natoms = # of atoms in the molecule.  The 4 atoms are
 ordered linearly within the dihedral.
 
 :line
 
 {Impropers} section:
 
 one line per improper
 line syntax: ID type atom1 atom2 atom3 atom4
 type = improper type (1-Nimpropertype)
 atom1,atom2,atom3,atom4 = IDs of atoms in improper :ul
 
 The IDs for the four atoms in each improper should be values from 1 to
 Natoms, where Natoms = # of atoms in the molecule.  The ordering of
 the 4 atoms determines the definition of the improper angle used in
 the formula for the defined "improper style"_improper_style.html.  See
 the doc pages for individual styles for details.
 
 :line
 
 {Special Bond Counts} section:
 
 one line per atom
 line syntax: ID N1 N2 N3
 N1 = # of 1-2 bonds
 N2 = # of 1-3 bonds
 N3 = # of 1-4 bonds :ul
 
 N1, N2, N3 are the number of 1-2, 1-3, 1-4 neighbors respectively of
 this atom within the topology of the molecule.  See the
 "special_bonds"_special_bonds.html doc page for more discussion of
 1-2, 1-3, 1-4 neighbors.  If this section appears, the Special Bonds
 section must also appear.  If this section is not specied, the
 atoms in the molecule will have no special bonds.
 
 :line
 
 {Special Bonds} section:
 
 one line per atom
 line syntax: ID a b c d ...
 a,b,c,d,... = IDs of atoms in N1+N2+N3 special bonds :ul
 
 A, b, c, d, etc are the IDs of the n1+n2+n3 atoms that are 1-2, 1-3,
 1-4 neighbors of this atom.  The IDs should be values from 1 to
 Natoms, where Natoms = # of atoms in the molecule.  The first N1
 values should be the 1-2 neighbors, the next N2 should be the 1-3
 neighbors, the last N3 should be the 1-4 neighbors.  No atom ID should
 appear more than once.  See the "special_bonds"_special_bonds.html doc
 page for more discussion of 1-2, 1-3, 1-4 neighbors.  If this section
 appears, the Special Bond Counts section must also appear.  If this
 section is not specied, the atoms in the molecule will have no special
 bonds.
 
 :line
 
 {Shake Flags} section:
 
 one line per atom
 line syntax: ID flag
 flag = 0,1,2,3,4 :ul
 
 This section is only needed when molecules created using the template
 will be constrained by SHAKE via the "fix shake" command.  The other
 two Shake sections must also appear in the file, following this one.
 
 The meaning of the flag for each atom is as follows.  See the "fix
 shake"_fix_shake.html doc page for a further description of SHAKE
 clusters.
 
 0 = not part of a SHAKE cluster
 1 = part of a SHAKE angle cluster (two bonds and the angle they form)
 2 = part of a 2-atom SHAKE cluster with a single bond
 3 = part of a 3-atom SHAKE cluster with two bonds
 4 = part of a 4-atom SHAKE cluster with three bonds :ul
 
 :line
 
 {Shake Atoms} section:
 
 one line per atom
 line syntax: ID a b c d
 a,b,c,d = IDs of atoms in cluster :ul
 
 This section is only needed when molecules created using the template
 will be constrained by SHAKE via the "fix shake" command.  The other
 two Shake sections must also appear in the file.
 
 The a,b,c,d values are atom IDs (from 1 to Natoms) for all the atoms
 in the SHAKE cluster that this atom belongs to.  The number of values
 that must appear is determined by the shake flag for the atom (see the
 Shake Flags section above).  All atoms in a particular cluster should
 list their a,b,c,d values identically.
 
 If flag = 0, no a,b,c,d values are listed on the line, just the
 (ignored) ID.
 
 If flag = 1, a,b,c are listed, where a = ID of central atom in the
 angle, and b,c the other two atoms in the angle.
 
 If flag = 2, a,b are listed, where a = ID of atom in bond with the the
 lowest ID, and b = ID of atom in bond with the highest ID.
 
 If flag = 3, a,b,c are listed, where a = ID of central atom,
 and b,c = IDs of other two atoms bonded to the central atom.
 
 If flag = 4, a,b,c,d are listed, where a = ID of central atom,
 and b,c,d = IDs of other three atoms bonded to the central atom.
 
 See the "fix shake"_fix_shake.html doc page for a further description
 of SHAKE clusters.
 
 :line
 
 {Shake Bond Types} section:
 
 one line per atom
 line syntax: ID a b c
 a,b,c = bond types (or angle type) of bonds (or angle) in cluster :ul
 
 This section is only needed when molecules created using the template
 will be constrained by SHAKE via the "fix shake" command.  The other
 two Shake sections must also appear in the file.
 
 The a,b,c values are bond types (from 1 to Nbondtypes) for all bonds
 in the SHAKE cluster that this atom belongs to.  The number of values
 that must appear is determined by the shake flag for the atom (see the
 Shake Flags section above).  All atoms in a particular cluster should
 list their a,b,c values identically.
 
 If flag = 0, no a,b,c values are listed on the line, just the
 (ignored) ID.
 
 If flag = 1, a,b,c are listed, where a = bondtype of the bond between
 the central atom and the first non-central atom (value b in the Shake
 Atoms section), b = bondtype of the bond between the central atom and
 the 2nd non-central atom (value c in the Shake Atoms section), and c =
 the angle type (1 to Nangletypes) of the angle between the 3 atoms.
 
 If flag = 2, only a is listed, where a = bondtype of the bond between
 the 2 atoms in the cluster.
 
 If flag = 3, a,b are listed, where a = bondtype of the bond between
 the central atom and the first non-central atom (value b in the Shake
 Atoms section), and b = bondtype of the bond between the central atom
 and the 2nd non-central atom (value c in the Shake Atoms section).
 
 If flag = 4, a,b,c are listed, where a = bondtype of the bond between
 the central atom and the first non-central atom (value b in the Shake
 Atoms section), b = bondtype of the bond between the central atom and
 the 2nd non-central atom (value c in the Shake Atoms section), and c =
 bondtype of the bond between the central atom and the 3rd non-central
 atom (value d in the Shake Atoms section).
 
 See the "fix shake"_fix_shake.html doc page for a further description
 of SHAKE clusters.
 
 :line
 
 [Restrictions:] none
 
 [Related commands:]
 
 "fix deposit"_fix_deposit.html, "fix pour"_fix_pour.html,
 "fix_gcmc"_fix_gcmc.html
 
 [Default:] none