From 6de3dab72a152652acb6d5591f84401fd2b9366e Mon Sep 17 00:00:00 2001 From: Richard Berger <richard.berger@temple.edu> Date: Sun, 5 Aug 2018 23:59:52 -0400 Subject: [PATCH] Remove duplicates --- doc/src/body.txt | 456 ------------------------------------- doc/src/lammps.book | 4 - doc/src/lammps_support.txt | 7 - doc/src/manifolds.txt | 41 ---- 4 files changed, 508 deletions(-) delete mode 100644 doc/src/body.txt delete mode 100644 doc/src/lammps_support.txt delete mode 100644 doc/src/manifolds.txt diff --git a/doc/src/body.txt b/doc/src/body.txt deleted file mode 100644 index 4de5b52911..0000000000 --- a/doc/src/body.txt +++ /dev/null @@ -1,456 +0,0 @@ -"LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc :c - -:link(lws,http://lammps.sandia.gov) -:link(ld,Manual.html) -:link(lc,Commands_all.html) - -:line - -Body particles :h2 - -[Overview:] - -This doc page is not about a LAMMPS input script command, but about -body particles, which are generalized finite-size particles. -Individual body particles can represent complex entities, such as -surface meshes of discrete points, collections of sub-particles, -deformable objects, etc. Note that other kinds of finite-size -spherical and aspherical particles are also supported by LAMMPS, such -as spheres, ellipsoids, line segments, and triangles, but they are -simpler entities that body particles. See the "Howto -body"_Howto_.html doc page for a general overview of all -these particle types. - -Body particles are used via the "atom_style body"_atom_style.html -command. It takes a body style as an argument. The current body -styles supported by LAMMPS are as follows. The name in the first -column is used as the {bstyle} argument for the "atom_style -body"_atom_style.html command. - -{nparticle} : rigid body with N sub-particles -{rounded/polygon} : 2d polygons with N vertices -{rounded/polyhedron} : 3d polyhedra with N vertices, E edges and F faces :tb(s=:) - -The body style determines what attributes are stored for each body and -thus how they can be used to compute pairwise body/body or -bond/non-body (point particle) interactions. More details of each -style are described below. - -More styles may be added in the future. See the "Modify -body"_Modify_body.html doc page for details on how to add a new body -style to the code. - -:line - -[When to use body particles:] - -You should not use body particles to model a rigid body made of -simpler particles (e.g. point, sphere, ellipsoid, line segment, -triangular particles), if the interaction between pairs of rigid -bodies is just the summation of pairwise interactions between the -simpler particles. LAMMPS already supports this kind of model via the -"fix rigid"_fix_rigid.html command. Any of the numerous pair styles -that compute interactions between simpler particles can be used. The -"fix rigid"_fix_rigid.html command time integrates the motion of the -rigid bodies. All of the standard LAMMPS commands for thermostatting, -adding constraints, performing output, etc will operate as expected on -the simple particles. - -By contrast, when body particles are used, LAMMPS treats an entire -body as a single particle for purposes of computing pairwise -interactions, building neighbor lists, migrating particles between -processors, output of particles to a dump file, etc. This means that -interactions between pairs of bodies or between a body and non-body -(point) particle need to be encoded in an appropriate pair style. If -such a pair style were to mimic the "fix rigid"_fix_rigid.html model, -it would need to loop over the entire collection of interactions -between pairs of simple particles within the two bodies, each time a -single body/body interaction was computed. - -Thus it only makes sense to use body particles and develop such a pair -style, when particle/particle interactions are more complex than what -the "fix rigid"_fix_rigid.html command can already calculate. For -example, consider particles with one or more of the following -attributes: - -represented by a surface mesh -represented by a collection of geometric entities (e.g. planes + spheres) -deformable -internal stress that induces fragmentation :ul - -For these models, the interaction between pairs of particles is likely -to be more complex than the summation of simple pairwise interactions. -An example is contact or frictional forces between particles with -planar surfaces that inter-penetrate. Likewise, the body particle may -store internal state, such as a stress tensor used to compute a -fracture criterion. - -These are additional LAMMPS commands that can be used with body -particles of different styles - -"fix nve/body"_fix_nve_body.html : integrate motion of a body particle in NVE ensemble -"fix nvt/body"_fix_nvt_body.html : ditto for NVT ensemble -"fix npt/body"_fix_npt_body.html : ditto for NPT ensemble -"fix nph/body"_fix_nph_body.html : ditto for NPH ensemble -"compute body/local"_compute_body_local.html : store sub-particle attributes of a body particle -"compute temp/body"_compute_temp_body.html : compute temperature of body particles -"dump local"_dump.html : output sub-particle attributes of a body particle -"dump image"_dump_image.html : output body particle attributes as an image :tb(s=:) - -The pair styles defined for use with specific body styles are listed -in the sections below. - -:line - -[Specifics of body style nparticle:] - -The {nparticle} body style represents body particles as a rigid body -with a variable number N of sub-particles. It is provided as a -vanilla, prototypical example of a body particle, although as -mentioned above, the "fix rigid"_fix_rigid.html command already -duplicates its functionality. - -The atom_style body command for this body style takes two additional -arguments: - -atom_style body nparticle Nmin Nmax -Nmin = minimum # of sub-particles in any body in the system -Nmax = maximum # of sub-particles in any body in the system :pre - -The Nmin and Nmax arguments are used to bound the size of data -structures used internally by each particle. - -When the "read_data"_read_data.html command reads a data file for this -body style, the following information must be provided for each entry -in the {Bodies} section of the data file: - -atom-ID 1 M -N -ixx iyy izz ixy ixz iyz -x1 y1 z1 -... -xN yN zN :pre - -where M = 6 + 3*N, and N is the number of sub-particles in the body -particle. - -The integer line has a single value N. The floating point line(s) -list 6 moments of inertia followed by the coordinates of the N -sub-particles (x1 to zN) as 3N values. These values can be listed on -as many lines as you wish; see the "read_data"_read_data.html command -for more details. - -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 principal axes of the -rigid body itself. LAMMPS performs the latter calculation internally. -The coordinates of each sub-particle are specified as its x,y,z -displacement from the center-of-mass of the body particle. The -center-of-mass position of the particle is specified by the x,y,z -values in the {Atoms} section of the data file, as is the total mass -of the body particle. - -The "pair_style body/nparticle"_pair_body_nparticle.html command can be used with this -body style to compute body/body and body/non-body interactions. - -For output purposes via the "compute -body/local"_compute_body_local.html and "dump local"_dump.html -commands, this body style produces one datum for each of the N -sub-particles in a body particle. The datum has 3 values: - -1 = x position of sub-particle -2 = y position of sub-particle -3 = z position of sub-particle :pre - -These values are the current position of the sub-particle within the -simulation domain, not a displacement from the center-of-mass (COM) of -the body particle itself. These values are calculated using the -current COM and orientation of the body particle. - -For images created by the "dump image"_dump_image.html command, if the -{body} keyword is set, then each body particle is drawn as a -collection of spheres, one for each sub-particle. The size of each -sphere is determined by the {bflag1} parameter for the {body} keyword. -The {bflag2} argument is ignored. - -:line - -[Specifics of body style rounded/polygon:] - -The {rounded/polygon} body style represents body particles as a 2d -polygon with a variable number of N vertices. This style can only be -used for 2d models; see the "boundary"_boundary.html command. See the -"pair_style body/rounded/polygon" doc page for a diagram of two -squares with rounded circles at the vertices. Special cases for N = 1 -(circle) and N = 2 (rod with rounded ends) can also be specified. - -One use of this body style is for 2d discrete element models, as -described in "Fraige"_#body-Fraige. - -Similar to body style {nparticle}, the atom_style body command for -this body style takes two additional arguments: - -atom_style body rounded/polygon Nmin Nmax -Nmin = minimum # of vertices in any body in the system -Nmax = maximum # of vertices in any body in the system :pre - -The Nmin and Nmax arguments are used to bound the size of data -structures used internally by each particle. - -When the "read_data"_read_data.html command reads a data file for this -body style, the following information must be provided for each entry -in the {Bodies} section of the data file: - -atom-ID 1 M -N -ixx iyy izz ixy ixz iyz -x1 y1 z1 -... -xN yN zN -i j j k k ... -diameter :pre - -where M = 6 + 3*N + 2*N + 1, and N is the number of vertices in the -body particle. - -The integer line has a single value N. The floating point line(s) -list 6 moments of inertia followed by the coordinates of the N -vertices (x1 to zN) as 3N values (with z = 0.0 for each), followed by -2N vertex indices corresponding to the end points of the N edges, -followed by a single diameter value = the rounded diameter of the -circle that surrounds each vertex. The diameter value can be different -for each body particle. These floating-point values can be listed on -as many lines as you wish; see the "read_data"_read_data.html command -for more details. - -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 principal axes of the -rigid body itself. LAMMPS performs the latter calculation internally. -The coordinates of each vertex are specified as its x,y,z displacement -from the center-of-mass of the body particle. The center-of-mass -position of the particle is specified by the x,y,z values in the -{Atoms} section of the data file. - -For example, the following information would specify a square particle -whose edge length is sqrt(2) and rounded diameter is 1.0. The -orientation of the square is aligned with the xy coordinate axes which -is consistent with the 6 moments of inertia: ixx iyy izz ixy ixz iyz = -1 1 4 0 0 0. Note that only Izz matters in 2D simulations. - -3 1 27 -4 -1 1 4 0 0 0 --0.7071 -0.7071 0 --0.7071 0.7071 0 -0.7071 0.7071 0 -0.7071 -0.7071 0 -0 1 -1 2 -2 3 -3 0 -1.0 :pre - -A rod in 2D, whose length is 4.0, mass 1.0, rounded at two ends -by circles of diameter 0.5, is specified as follows: - -1 1 13 -2 -1 1 1.33333 0 0 0 --2 0 0 -2 0 0 -0.5 :pre - -A disk, whose diameter is 3.0, mass 1.0, is specified as follows: - -1 1 10 -1 -1 1 4.5 0 0 0 -0 0 0 -3.0 :pre - -The "pair_style body/rounded/polygon"_pair_body_rounded_polygon.html -command can be used with this body style to compute body/body -interactions. The "fix wall/body/polygon"_fix_wall_body_polygon.html -command can be used with this body style to compute the interaction of -body particles with a wall. - -:line - -[Specifics of body style rounded/polyhedron:] - -The {rounded/polyhedron} body style represents body particles as a 3d -polyhedron with a variable number of N vertices, E edges and F faces. -This style can only be used for 3d models; see the -"boundary"_boundary.html command. See the "pair_style -body/rounded/polygon" doc page for a diagram of a two 2d squares with -rounded circles at the vertices. A 3d cube with rounded spheres at -the 8 vertices and 12 rounded edges would be similar. Special cases -for N = 1 (sphere) and N = 2 (rod with rounded ends) can also be -specified. - -This body style is for 3d discrete element models, as described in -"Wang"_#body-Wang. - -Similar to body style {rounded/polygon}, the atom_style body command -for this body style takes two additional arguments: - -atom_style body rounded/polyhedron Nmin Nmax -Nmin = minimum # of vertices in any body in the system -Nmax = maximum # of vertices in any body in the system :pre - -The Nmin and Nmax arguments are used to bound the size of data -structures used internally by each particle. - -When the "read_data"_read_data.html command reads a data file for this -body style, the following information must be provided for each entry -in the {Bodies} section of the data file: - -atom-ID 3 M -N E F -ixx iyy izz ixy ixz iyz -x1 y1 z1 -... -xN yN zN -0 1 -1 2 -2 3 -... -0 1 2 -1 -0 2 3 -1 -... -1 2 3 4 -diameter :pre - -where M = 6 + 3*N + 2*E + 4*F + 1, and N is the number of vertices in -the body particle, E = number of edges, F = number of faces. - -The integer line has three values: number of vertices (N), number of -edges (E) and number of faces (F). The floating point line(s) list 6 -moments of inertia followed by the coordinates of the N vertices (x1 -to zN) as 3N values, followed by 2N vertex indices corresponding to -the end points of the E edges, then 4*F vertex indices defining F -faces. The last value is the diameter value = the rounded diameter of -the sphere that surrounds each vertex. The diameter value can be -different for each body particle. These floating-point values can be -listed on as many lines as you wish; see the -"read_data"_read_data.html command for more details. Because the -maxmimum vertices per face is hard-coded to be 4 -(i.e. quadrilaterals), faces with more than 4 vertices need to be -split into triangles or quadrilaterals. For triangular faces, the -last vertex index should be set to -1. - -The ordering of the 4 vertices within a face should follow -the right-hand rule so that the normal vector of the face points -outwards from the center of mass. - -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 principal axes of the -rigid body itself. LAMMPS performs the latter calculation internally. -The coordinates of each vertex are specified as its x,y,z displacement -from the center-of-mass of the body particle. The center-of-mass -position of the particle is specified by the x,y,z values in the -{Atoms} section of the data file. - -For example, the following information would specify a cubic particle -whose edge length is 2.0 and rounded diameter is 0.5. -The orientation of the cube is aligned with the xyz coordinate axes -which is consistent with the 6 moments of inertia: ixx iyy izz ixy ixz -iyz = 0.667 0.667 0.667 0 0 0. - -1 3 79 -8 12 6 -0.667 0.667 0.667 0 0 0 -1 1 1 -1 -1 1 --1 -1 1 --1 1 1 -1 1 -1 -1 -1 -1 --1 -1 -1 --1 1 -1 -0 1 -1 2 -2 3 -3 0 -4 5 -5 6 -6 7 -7 4 -0 4 -1 5 -2 6 -3 7 -0 1 2 3 -4 5 6 7 -0 1 5 4 -1 2 6 5 -2 3 7 6 -3 0 4 7 -0.5 :pre - -A rod in 3D, whose length is 4.0, mass 1.0 and rounded at two ends -by circles of diameter 0.5, is specified as follows: - -1 1 13 -2 -0 1.33333 1.33333 0 0 0 --2 0 0 -2 0 0 -0.5 :pre - -A sphere whose diameter is 3.0 and mass 1.0, is specified as follows: - -1 1 10 -1 -0.9 0.9 0.9 0 0 0 -0 0 0 -3.0 :pre - -The "pair_style -body/rounded/polhedron"_pair_body_rounded_polyhedron.html command can -be used with this body style to compute body/body interactions. The -"fix wall/body/polyhedron"_fix_wall_body_polygon.html command can be -used with this body style to compute the interaction of body particles -with a wall. - -:line - -For output purposes via the "compute -body/local"_compute_body_local.html and "dump local"_dump.html -commands, this body style produces one datum for each of the N -sub-particles in a body particle. The datum has 3 values: - -1 = x position of vertex -2 = y position of vertex -3 = z position of vertex :pre - -These values are the current position of the vertex within the -simulation domain, not a displacement from the center-of-mass (COM) of -the body particle itself. These values are calculated using the -current COM and orientation of the body particle. - -For images created by the "dump image"_dump_image.html command, if the -{body} keyword is set, then each body particle is drawn as a polygon -consisting of N line segments. Note that the line segments are drawn -between the N vertices, which does not correspond exactly to the -physical extent of the body (because the "pair_style -rounded/polygon"_pair_body_rounded_polygon.html defines finite-size -spheres at those point and the line segments between the spheres are -tangent to the spheres). The drawn diameter of each line segment is -determined by the {bflag1} parameter for the {body} keyword. The -{bflag2} argument is ignored. - -:line - -:link(body-Fraige) -[(Fraige)] F. Y. Fraige, P. A. Langston, A. J. Matchett, J. Dodds, -Particuology, 6, 455 (2008). - -:link(body-Wang) -[(Wang)] J. Wang, H. S. Yu, P. A. Langston, F. Y. Fraige, Granular -Matter, 13, 1 (2011). diff --git a/doc/src/lammps.book b/doc/src/lammps.book index 9cb2d8cd6c..c0ca357f21 100644 --- a/doc/src/lammps.book +++ b/doc/src/lammps.book @@ -107,10 +107,6 @@ Errors_bugs.html Errors_messages.html Errors_warnings.html -lammps_support.html -body.html -manifolds.html - lammps_commands.html atom_modify.html atom_style.html diff --git a/doc/src/lammps_support.txt b/doc/src/lammps_support.txt deleted file mode 100644 index fa460ce6c2..0000000000 --- a/doc/src/lammps_support.txt +++ /dev/null @@ -1,7 +0,0 @@ - -Supporting Information :h1 - -This section of the manual contains supporting information that -is not documenting individual commands but general concepts and -supporting information about entities like body particles or -manifolds. diff --git a/doc/src/manifolds.txt b/doc/src/manifolds.txt deleted file mode 100644 index 194a755868..0000000000 --- a/doc/src/manifolds.txt +++ /dev/null @@ -1,41 +0,0 @@ -"LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc :c - -:link(lws,http://lammps.sandia.gov) -:link(ld,Manual.html) -:link(lc,Commands_all.html) - -:line - -Manifolds (surfaces) :h2 - -[Overview:] - -This doc page is not about a LAMMPS input script command, but about -manifolds, which are generalized surfaces, as defined and used by the -USER-MANIFOLD package, to track particle motion on the manifolds. See -the src/USER-MANIFOLD/README file for more details about the package -and its commands. - -Below is a list of currently supported manifolds by the USER-MANIFOLD -package, their parameters and a short description of them. The -parameters listed here are in the same order as they should be passed -to the relevant fixes. - -{manifold} @ {parameters} @ {equation} @ {description} -cylinder @ R @ x^2 + y^2 - R^2 = 0 @ Cylinder along z-axis, axis going through (0,0,0) -cylinder_dent @ R l a @ x^2 + y^2 - r(z)^2 = 0, r(x) = R if | z | > l, r(z) = R - a*(1 + cos(z/l))/2 otherwise @ A cylinder with a dent around z = 0 -dumbbell @ a A B c @ -( x^2 + y^2 ) + (a^2 - z^2/c^2) * ( 1 + (A*sin(B*z^2))^4) = 0 @ A dumbbell -ellipsoid @ a b c @ (x/a)^2 + (y/b)^2 + (z/c)^2 = 0 @ An ellipsoid -gaussian_bump @ A l rc1 rc2 @ if( x < rc1) -z + A * exp( -x^2 / (2 l^2) ); else if( x < rc2 ) -z + a + b*x + c*x^2 + d*x^3; else z @ A Gaussian bump at x = y = 0, smoothly tapered to a flat plane z = 0. -plane @ a b c x0 y0 z0 @ a*(x-x0) + b*(y-y0) + c*(z-z0) = 0 @ A plane with normal (a,b,c) going through point (x0,y0,z0) -plane_wiggle @ a w @ z - a*sin(w*x) = 0 @ A plane with a sinusoidal modulation on z along x. -sphere @ R @ x^2 + y^2 + z^2 - R^2 = 0 @ A sphere of radius R -supersphere @ R q @ | x |^q + | y |^q + | z |^q - R^q = 0 @ A supersphere of hyperradius R -spine @ a, A, B, B2, c @ -(x^2 + y^2) + (a^2 - z^2/f(z)^2)*(1 + (A*sin(g(z)*z^2))^4), f(z) = c if z > 0, 1 otherwise; g(z) = B if z > 0, B2 otherwise @ An approximation to a dendtritic spine -spine_two @ a, A, B, B2, c @ -(x^2 + y^2) + (a^2 - z^2/f(z)^2)*(1 + (A*sin(g(z)*z^2))^2), f(z) = c if z > 0, 1 otherwise; g(z) = B if z > 0, B2 otherwise @ Another approximation to a dendtritic spine -thylakoid @ wB LB lB @ Various, see "(Paquay)"_#Paquay1 @ A model grana thylakoid consisting of two block-like compartments connected by a bridge of width wB, length LB and taper length lB -torus @ R r @ (R - sqrt( x^2 + y^2 ) )^2 + z^2 - r^2 @ A torus with large radius R and small radius r, centered on (0,0,0) :tb(s=@) - -:link(Paquay1) -[(Paquay)] Paquay and Kusters, Biophys. J., 110, 6, (2016). -preprint available at "arXiv:1411.3019"_http://arxiv.org/abs/1411.3019/. -- GitLab