freud documentation¶
“Neurosis is the inability to tolerate ambiguity” - Sigmund Freud
The freud library is a Python package meant for the analysis of molecular dynamics and Monte Carlo simulation trajectories. The freud library works with and returns NumPy arrays.
Please visit our repository on Bitbucket for the library source code, post issues or bugs to our issue tracker, and ask questions and discuss on our forum.
Contents¶
Examples¶
Examples are provided as Jupyter notebooks in a separate
freud-examples repository. These can be run locally with the
jupyter notebook
command. These examples will also be provided as static notebooks on
NBViewer and interactive
notebooks on MyBinder.
Installation¶
Requirements¶
- NumPy is required to build freud
- Cython >= 0.23 is required to compile your own
_freud.cpp
file. Cython is not required to install freud - Boost is required to run freud
- Intel Threading Building Blocks is required to run freud
Documentation¶
You may use the online documentation from ReadTheDocs, or you may build the documentation yourself:
Building the documentation¶
The documentation is build with sphinx. To install sphinx, run
conda install sphinx
or
pip install sphinx
To build the documentation, run the following commands in the source directory:
cd doc
make html
# Then open build/html/index.html
To build a PDF of the documentation (requires LaTeX and/or PDFLaTeX):
cd doc
make latexpdf
# Then open build/latex/freud.pdf
Installation¶
Install freud via conda, glotzpkgs, or compile from source.
Install via conda¶
The code below will enable the glotzer conda channel and install freud.
conda config --add channels glotzer
conda install freud
Install via glotzpkgs¶
Please refer to the official glotzpkgs documentation.
First, make sure you have a working glotzpkgs environment.
# install from provided binary
gpacman -S freud
# installing your own version
cd /path/to/glotzpkgs/freud
gmakepkg
# tab completion is your friend here
gpacman -U freud-<version>-flux.pkg.tar.gz
# now you can load the binary
module load freud
Compile from source¶
It is easiest to install freud with a working conda install of the required packages:
- python (2.7, 3.4, 3.5, 3.6)
- numpy
- boost (2.7, 3.3 provided on flux, 3.4, 3.5)
- icu (requirement of boost)
- cython (not required, but a correct
_freud.cpp
file must be present to compile) - tbb
- cmake
The code that follows creates a build directory inside the freud source directory and builds freud:
mkdir build
cd build
cmake ../
# Use `cmake ../ -DENABLE_CYTHON=ON` to rebuild _freud.cpp
make install -j4
By default, freud installs to the USER_SITE directory.
USER_SITE
is on the Python search path by default, so there is no need to modify PYTHONPATH
.
To run out of the build directory, run make -j4
instead of make install -j4
and then add the build directory to
your PYTHONPATH
.
Note
freud makes use of submodules. CMake has been configured to automatically init and update submodules. However, if this does not work, or you would like to do this yourself, please execute:
git submodule update --init
Unit Tests¶
Run all unit tests with nosetests
in the source directory. To add a test, simply add a file to the tests directory, and nosetests will automatically discover it. Read this introduction to nosetests for more information.
# Install nose
conda install nose
# Run tests from the source directory
nosetests
Modules¶
Below is a list of modules in freud. To add your own module, read the development guide.
Bond Module¶
The bond module allows for the computation of bonds as defined by a map. Depending on the coordinate system desired, either a two or three dimensional array is supplied, with each element containing the bond index mapped to the pair geometry of that element. The user provides a list of indices to track, so that not all bond indices contained in the bond map need to be tracked in computation.
The bond module is designed to take in arrays using the same coordinate systems in the PMFT Module in freud.
Note
The coordinate system in which the calculation is performed is not the same as the coordinate system in which particle positions and orientations should be supplied. Only certain coordinate systems are available for certain particle positions and orientations:
- 2D particle coordinates (position: [\(x\), \(y\), \(0\)], orientation: \(\theta\)):
- \(X\), \(Y\)
- \(X\), \(Y\), \(\theta_2\)
- \(r\), \(\theta_1\), \(\theta_2\)
- 3D particle coordinates:
- \(X\), \(Y\), \(Z\)
Bonding Analysis¶
-
class
freud.bond.
BondingAnalysis
(num_particles, num_bonds)¶ Analyze the bond lifetimes and flux present in the system.
Module author: Eric Harper <harperic@umich.edu>
Parameters: - num_particles (unsigned int) – number of particles over which to calculate bonds
- num_bonds – number of bonds to track
-
bond_lifetimes
¶ Return the bond lifetimes.
-
compute
(self, frame_0, frame_1)¶ Calculates the changes in bonding states from one frame to the next.
Parameters: - frame_0 (
numpy.ndarray
, shape=(\(N_{particles}\), \(N_{bonds}\)), dtype=numpy.uint32
) – current/previous bonding frame (as output fromBondingR12
modules) - frame_1 (
numpy.ndarray
, shape=(\(N_{particles}\), \(N_{bonds}\)), dtype=numpy.uint32
) – next/current bonding frame (as output fromBondingR12
modules)
- frame_0 (
-
getBondLifetimes
(self)¶ Return the bond lifetimes.
Returns: lifetime of bonds Return type: numpy.ndarray
, shape=(\(N_{particles}\), varying), dtype=numpy.uint32
-
getNumBonds
(self)¶ Get number of bonds tracked.
Returns: number of bonds Return type: unsigned int
-
getNumFrames
(self)¶ Get number of frames calculated.
Returns: number of frames Return type: unsigned int
-
getNumParticles
(self)¶ Get number of particles being tracked.
Returns: number of particles Return type: unsigned int
-
getOverallLifetimes
(self)¶ Return the overall lifetimes.
Returns: lifetime of bonds Return type: numpy.ndarray
, shape=(\(N_{particles}\), varying), dtype=numpy.uint32
-
getTransitionMatrix
(self)¶ Return the transition matrix.
Returns: transition matrix Return type: numpy.ndarray
-
initialize
(self, frame_0)¶ Calculates the changes in bonding states from one frame to the next.
Parameters: frame_0 ( numpy.ndarray
, shape=(\(N_{particles}\), \(N_{bonds}\)), dtype=numpy.uint32
) – first bonding frame (as output fromBondingR12
modules)
-
num_bonds
¶ Get number of bonds being tracked.
-
num_frames
¶ Get number of frames calculated.
-
num_particles
¶ Get number of particles being tracked.
-
overall_lifetimes
¶ Return the overall lifetimes.
-
transition_matrix
¶ Return the transition matrix.
Coordinate System: \(x\), \(y\)¶
-
class
freud.bond.
BondingXY2D
(x_max, y_max, bond_map, bond_list)¶ Compute the bonds each particle in the system.
For each particle in the system determine which other particles are in which bonding sites.
Module author: Eric Harper <harperic@umich.edu>
Parameters: - x_max (float) – maximum x distance at which to search for bonds
- y_max (float) – maximum y distance at which to search for bonds
- bond_map (
numpy.ndarray
) – 3D array containing the bond index for each x, y coordinate - bond_list (
numpy.ndarray
) – list containing the bond indices to be tracked,bond_list[i] = bond_index
-
bonds
¶ Return the particle bonds.
-
box
¶ Get the box used in the calculation.
-
compute
(self, box, ref_points, ref_orientations, points, orientations, nlist=None)¶ Calculates the correlation function and adds to the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – points to calculate the bonding - ref_orientations (
numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.float32
) – orientations as angles to use in computation - points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – points to calculate the bonding - orientations (
numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.float32
) – orientations as angles to use in computation - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
getBonds
(self)¶ Return the particle bonds.
Returns: particle bonds Return type: numpy.ndarray
-
getBox
(self)¶ Get the box used in the calculation.
Returns: freud Box Return type: freud.box.Box()
-
getListMap
(self)¶ Get the dict used to map list idx to bond idx.
Returns: list_map Return type: dict >>> list_idx = list_map[bond_idx]
-
getRevListMap
(self)¶ Get the dict used to map list idx to bond idx.
Returns: list_map Return type: dict >>> bond_idx = list_map[list_idx]
-
list_map
¶ Get the dict used to map list idx to bond idx.
-
rev_list_map
¶ Get the dict used to map list idx to bond idx.
Coordinate System: \(x\), \(y\), \(\theta_2\)¶
-
class
freud.bond.
BondingXYT
(x_max, y_max, bond_map, bond_list)¶ Compute the bonds each particle in the system.
For each particle in the system determine which other particles are in which bonding sites.
Module author: Eric Harper <harperic@umich.edu>
Parameters: - x_max (float) – maximum x distance at which to search for bonds
- y_max (float) – maximum y distance at which to search for bonds
- bond_map (
numpy.ndarray
) – 3D array containing the bond index for each x, y coordinate - bond_list (
numpy.ndarray
) – list containing the bond indices to be tracked,bond_list[i] = bond_index
-
bonds
¶ Return the particle bonds.
-
box
¶ Get the box used in the calculation.
-
compute
(self, box, ref_points, ref_orientations, points, orientations, nlist=None)¶ Calculates the correlation function and adds to the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – points to calculate the bonding - ref_orientations (
numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.float32
) – orientations as angles to use in computation - points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – points to calculate the bonding - orientations (
numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.float32
) – orientations as angles to use in computation - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
getBonds
(self)¶ Return the particle bonds.
Returns: particle bonds Return type: numpy.ndarray
-
getBox
(self)¶ Get the box used in the calculation.
Returns: freud Box Return type: freud.box.Box()
-
getListMap
(self)¶ Get the dict used to map list idx to bond idx.
Returns: list_map Return type: dict >>> list_idx = list_map[bond_idx]
-
getRevListMap
(self)¶ Get the dict used to map list idx to bond idx.
Returns: list_map Return type: dict >>> bond_idx = list_map[list_idx]
-
list_map
¶ Get the dict used to map list idx to bond idx.
-
rev_list_map
¶ Get the dict used to map list idx to bond idx.
Coordinate System: \(r\), \(\theta_1\), \(\theta_2\)¶
-
class
freud.bond.
BondingR12
(r_max, bond_map, bond_list)¶ Compute the bonds each particle in the system.
For each particle in the system determine which other particles are in which bonding sites.
Module author: Eric Harper <harperic@umich.edu>
Parameters: - r_max (float) – distance to search for bonds
- bond_map (
numpy.ndarray
) – 3D array containing the bond index for each r, t2, t1 coordinate - bond_list (
numpy.ndarray
) – list containing the bond indices to be tracked,bond_list[i] = bond_index
-
bonds
¶ Return the particle bonds.
-
box
¶ Get the box used in the calculation.
-
compute
(self, box, ref_points, ref_orientations, points, orientations, nlist=None)¶ Calculates the correlation function and adds to the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – points to calculate the bonding - ref_orientations (
numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.float32
) – orientations as angles to use in computation - points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – points to calculate the bonding - orientations (
numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.float32
) – orientations as angles to use in computation - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
getBonds
(self)¶ Return the particle bonds.
Returns: particle bonds Return type: numpy.ndarray
-
getBox
(self)¶ Get the box used in the calculation.
Returns: freud Box Return type: freud.box.Box()
-
getListMap
(self)¶ Get the dict used to map list idx to bond idx.
Returns: list_map Return type: dict >>> list_idx = list_map[bond_idx]
-
getRevListMap
(self)¶ Get the dict used to map list idx to bond idx.
Returns: list_map Return type: dict >>> bond_idx = list_map[list_idx]
-
list_map
¶ Get the dict used to map list idx to bond idx.
-
rev_list_map
¶ Get the dict used to map list idx to bond idx.
Coordinate System: \(x\), \(y\), \(z\)¶
-
class
freud.bond.
BondingXYZ
(x_max, y_max, z_max, bond_map, bond_list)¶ Compute the bonds each particle in the system.
For each particle in the system determine which other particles are in which bonding sites.
Module author: Eric Harper <harperic@umich.edu>
Parameters: - x_max (float) – maximum x distance at which to search for bonds
- y_max (float) – maximum y distance at which to search for bonds
- z_max (float) – maximum z distance at which to search for bonds
- bond_map (
numpy.ndarray
) – 3D array containing the bond index for each x, y, z coordinate - bond_list (
numpy.ndarray
) – list containing the bond indices to be tracked,bond_list[i] = bond_index
-
bonds
¶ Return the particle bonds.
-
box
¶ Get the box used in the calculation.
-
compute
(self, box, ref_points, ref_orientations, points, orientations, nlist=None)¶ Calculates the correlation function and adds to the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – points to calculate the bonding - ref_orientations (
numpy.ndarray
, shape=(\(N_{particles}\), 4), dtype=numpy.float32
) – orientations as quaternions to use in computation - points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – points to calculate the bonding - orientations (
numpy.ndarray
, shape=(\(N_{particles}\), 4), dtype=numpy.float32
) – orientations as quaternions to use in computation - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
getBonds
(self)¶ Return the particle bonds.
Returns: particle bonds Return type: numpy.ndarray
-
getBox
(self)¶ Get the box used in the calculation.
Returns: freud Box Return type: freud.box.Box()
-
getListMap
(self)¶ Get the dict used to map list idx to bond idx.
Returns: list_map Return type: dict >>> list_idx = list_map[bond_idx]
-
getRevListMap
(self)¶ Get the dict used to map list idx to bond idx.
Returns: list_map Return type: dict >>> bond_idx = list_map[list_idx]
-
list_map
¶ Get the dict used to map list idx to bond idx.
-
rev_list_map
¶ Get the dict used to map list idx to bond idx.
Box Module¶
Contains data structures for simulation boxes.
Simulation Box¶
-
class
freud.box.
Box
(*args, **kwargs)[source]¶ The freud Box class for simulation boxes.
Module author: Richmond Newman <newmanrs@umich.edu>
Module author: Carl Simon Adorf <csadorf@umich.edu>
Module author: Bradley Dice <bdice@bradleydice.com>
Changed in version 0.7.0: Added box periodicity interface
For more information about the definition of the simulation box, please see:
Parameters: -
L
¶ Return the lengths of the box as a tuple (x, y, z).
-
Linv
¶ Return the inverse lengths of the box (1/Lx, 1/Ly, 1/Lz).
Returns: dimensions of the box as (1/Lx, 1/Ly, 1/Lz) Return type: (float, float, float)
-
Lx
¶ Length of the x-dimension of the box.
Getter: Returns this box’s x-dimension length Setter: Sets this box’s x-dimension length Type: float
-
Ly
¶ Length of the y-dimension of the box.
Getter: Returns this box’s y-dimension length Setter: Sets this box’s y-dimension length Type: float
-
Lz
¶ Length of the z-dimension of the box.
Getter: Returns this box’s z-dimension length Setter: Sets this box’s z-dimension length Type: float
-
classmethod
cube
(L)[source]¶ Construct a cubic box with equal lengths.
Parameters: L (float) – The edge length
-
dimensions
¶ Number of dimensions of this box (only 2 or 3 are supported).
Getter: Returns this box’s number of dimensions Setter: Sets this box’s number of dimensions Type: int
-
classmethod
from_matrix
(boxMatrix, dimensions=None)[source]¶ Initialize a box instance from a box matrix.
For more information and the source for this code, see: http://hoomd-blue.readthedocs.io/en/stable/box.html
-
getCoordinates
(self, f)¶ Alias for
makeCoordinates()
Deprecated since version 0.8: Use
makeCoordinates()
instead.
-
getImage
(self, vec)¶ Returns the image corresponding to a wrapped vector.
New in version 0.8.
Parameters: vec ( numpy.ndarray
, shape= \(\left(3\right)\), dtype=numpy.float32
) – Coordinates of unwrapped vectorReturns: Image index vector Return type: numpy.ndarray
, shape= \(\left(3\right)\), dtype=numpy.int32
-
getL
(self)¶ Return the lengths of the box as a tuple (x, y, z).
Returns: dimensions of the box as (x, y, z) Return type: (float, float, float)
-
getLatticeVector
(self, i)¶ Get the lattice vector with index \(i\).
Parameters: i (unsigned int) – Index (\(0 \leq i < d\)) of the lattice vector, where \(d\) is the box dimension (2 or 3) Returns: lattice vector with index \(i\)
-
getLinv
(self)¶ Return the inverse lengths of the box (1/Lx, 1/Ly, 1/Lz).
Returns: dimensions of the box as (1/Lx, 1/Ly, 1/Lz) Return type: (float, float, float)
-
getLx
(self)¶ Length of the x-dimension of the box.
Returns: This box’s x-dimension length Return type: float
-
getLy
(self)¶ Length of the y-dimension of the box.
Returns: This box’s y-dimension length Return type: float
-
getLz
(self)¶ Length of the z-dimension of the box.
Returns: This box’s z-dimension length Return type: float
-
getPeriodic
(self)¶ Get the box’s periodicity in each dimension.
Returns: Periodic attributes in x, y, z Return type: list[bool, bool, bool]
-
getPeriodicX
(self)¶ Get the box periodicity in the x direction.
Returns: True if periodic, False if not Return type: bool
-
getPeriodicY
(self)¶ Get the box periodicity in the y direction.
Returns: True if periodic, False if not Return type: bool
-
getPeriodicZ
(self)¶ Get the box periodicity in the z direction.
Returns: True if periodic, False if not Return type: bool
-
is2D
(self)¶ Return if box is 2D (True) or 3D (False).
Returns: True if 2D, False if 3D Return type: bool
-
makeCoordinates
(self, f)¶ Convert fractional coordinates into real coordinates.
Parameters: f ( numpy.ndarray
, shape= \(\left(3\right)\), dtype=numpy.float32
) – Fractional coordinates \(\left(x, y, z\right)\) between 0 and 1 within parallelepipedal boxReturns: Vector of real coordinates \(\left(x, y, z\right)\) Return type: list[float, float, float]
-
makeFraction
(self, vec)¶ Convert real coordinates into fractional coordinates.
Parameters: vec ( numpy.ndarray
, shape= \(\left(3\right)\), dtype=numpy.float32
) – Real coordinates within parallelepipedal boxReturns: A fractional coordinate vector
-
periodic
¶ Box periodicity in each dimension.
Getter: Returns this box’s periodicity in each dimension (True if periodic, False if not) Setter: Set this box’s periodicity in each dimension Type: list[bool, bool, bool]
-
set2D
(self, val)¶ Set the dimensionality to 2D (True) or 3D (False).
Parameters: val (bool) – 2D=True, 3D=False
-
setPeriodic
(self, x, y, z)¶ Set the box’s periodicity in each dimension.
Parameters:
-
setPeriodicX
(self, val)¶ Set the box periodicity in the x direction.
Parameters: val (bool) – True if periodic, False if not
-
setPeriodicY
(self, val)¶ Set the box periodicity in the y direction.
Parameters: val (bool) – True if periodic, False if not
-
setPeriodicZ
(self, val)¶ Set the box periodicity in the z direction.
Parameters: val (bool) – True if periodic, False if not
-
classmethod
square
(L)[source]¶ Construct a 2-dimensional (square) box with equal lengths.
Parameters: L (float) – The edge length
-
to_matrix
()[source]¶ Returns the box matrix (3x3).
Returns: box matrix Return type: list of lists, shape 3x3
-
unwrap
(self, vecs, imgs)¶ Unwrap a given array of vectors inside the box back into real space, using an array of image indices that determine how many times to unwrap in each dimension.
Parameters: - vecs (
numpy.ndarray
, shape= \(\left(3\right)\) or \(\left(N, 3\right)\), dtype=numpy.float32
) – Single vector or array of \(N\) vectors - imgs (
numpy.ndarray
, shape= \(\left(3\right)\) or \(\left(N, 3\right)\), dtype=numpy.int32
) – Single image index or array of \(N\) image indices
Note: vecs are returned in place (nothing returned)
- vecs (
-
wrap
(self, vecs)¶ Wrap a given array of vectors from real space into the box, using the periodic boundaries.
Note
Since the origin of the box is in the center, wrapping is equivalent to applying the minimum image convention to the input vectors.
Parameters: vecs ( numpy.ndarray
, shape= \(\left(3\right)\) or \(\left(N, 3\right)\), dtype=numpy.float32
) – Single vector or array of \(N\) vectorsNote: vecs are returned in place (nothing returned)
-
Cluster Module¶
Cluster Functions¶
-
class
freud.cluster.
Cluster
(box, rcut)¶ Finds clusters in a set of points.
Given a set of coordinates and a cutoff,
freud.cluster.Cluster
will determine all of the clusters of points that are made up of points that are closer than the cutoff. Clusters are labelled from 0 to the number of clusters-1 and an index array is returned wherecluster_idx[i]
is the cluster index in which particlei
is found. By the definition of a cluster, points that are not within the cutoff of another point end up in their own 1-particle cluster.Identifying micelles is one primary use-case for finding clusters. This operation is somewhat different, though. In a cluster of points, each and every point belongs to one and only one cluster. However, because a string of points belongs to a polymer, that single polymer may be present in more than one cluster. To handle this situation, an optional layer is presented on top of the
cluster_idx
array. Given a key value per particle (i.e. the polymer id), the computeClusterMembership function will processcluster_idx
with the key values in mind and provide a list of keys that are present in each cluster.Module author: Joshua Anderson <joaander@umich.edu>
Parameters: - box (
freud.box.Box
) – simulation box - rcut (float) – Particle distance cutoff
Note
2D:
freud.cluster.Cluster
properly handles 2D boxes. The points must be passed in as[x, y, 0]
. Failing to set z=0 will lead to undefined behavior.-
box
¶ Return the stored freud Box.
-
cluster_idx
¶ Returns 1D array of Cluster idx for each particle.
-
cluster_keys
¶ Returns the keys contained in each cluster.
-
computeClusterMembership
(self, keys)¶ Compute the clusters with key membership.
Loops over all particles and adds them to a list of sets. Each set contains all the keys that are part of that cluster.
Get the computed list with
getClusterKeys()
.Parameters: keys ( numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.uint32
) – Membership keys, one for each particle
-
computeClusters
(self, points, nlist=None, box=None)¶ Compute the clusters for the given set of points.
Parameters: - points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – particle coordinates - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds - box (
freud.box.Box
) – simulation box
- points (
-
getBox
(self)¶ Return the stored freud Box.
Returns: freud Box Return type: freud.box.Box
-
getClusterIdx
(self)¶ Returns 1D array of Cluster idx for each particle
Returns: 1D array of cluster idx Return type: numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.uint32
-
getClusterKeys
(self)¶ Returns the keys contained in each cluster.
Returns: list of lists of each key contained in clusters Return type: list
-
num_clusters
¶ Returns the number of clusters.
-
num_particles
¶ Returns the number of particles.
- box (
-
class
freud.cluster.
ClusterProperties
(box)¶ Routines for computing properties of point clusters.
Given a set of points and cluster ids (from
Cluster
, or another source), ClusterProperties determines the following properties for each cluster:- Center of mass
- Gyration tensor
The computed center of mass for each cluster (properly handling periodic boundary conditions) can be accessed with
getClusterCOM()
. This returns anumpy.ndarray
, shape= \(\left(N_{clusters}, 3 \right)\).The \(3 \times 3\) gyration tensor \(G\) can be accessed with
getClusterG()
. This returns anumpy.ndarray
, shape= \(\left(N_{clusters} \times 3 \times 3\right)\). The tensor is symmetric for each cluster.Module author: Joshua Anderson <joaander@umich.edu>
Parameters: box ( freud.box.Box
) – simulation box-
box
¶ Return the stored freud Box.
-
cluster_COM
¶ Returns the center of mass of the last computed cluster.
-
cluster_G
¶ Returns the cluster \(G\) tensors computed by the last call to
computeProperties()
. computeProperties.
-
cluster_sizes
¶ Returns the cluster sizes computed by the last call to
computeProperties()
. computeProperties.
-
computeProperties
(self, points, cluster_idx, box=None)¶ Compute properties of the point clusters.
Loops over all points in the given array and determines the center of mass of the cluster as well as the \(G\) tensor. These can be accessed after the call to ~.computeProperties() with
getClusterCOM()
andgetClusterG()
.Parameters: - points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – Positions of the particles making up the clusters - cluster_idx (
numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.uint32
) – List of cluster indexes for each particle - box (
freud.box.Box
) – simulation box
- points (
-
getBox
(self)¶ Return the stored
freud.box.Box
object.Returns: freud Box Return type: freud.box.Box
-
getClusterCOM
(self)¶ Returns the center of mass of the last computed cluster.
Returns: numpy array of cluster center of mass coordinates \(\left(x,y,z\right)\) Return type: numpy.ndarray
, shape=(\(N_{clusters}\), 3), dtype=numpy.float32
-
getClusterG
(self)¶ Returns the cluster \(G\) tensors computed by the last call to
computeProperties()
.Returns: list of gyration tensors for each cluster Return type: numpy.ndarray
, shape=(\(N_{clusters}\), 3, 3), dtype=numpy.float32
-
getClusterSizes
(self)¶ Returns the cluster sizes computed by the last call to
computeProperties()
. computeProperties.Returns: sizes of each cluster Return type: numpy.ndarray
, shape=(\(N_{clusters}\)), dtype=numpy.uint32
-
getNumClusters
(self)¶ Count the number of clusters found in the last call to
computeProperties()
Returns: number of clusters Return type: int
-
num_clusters
¶ Returns the number of clusters.
Density Module¶
The density module contains functions which deal with the density of the system.
Correlation Functions¶
-
class
freud.density.
FloatCF
(rmax, dr)¶ Computes the pairwise correlation function \(\left< p*q \right> \left( r \right)\) between two sets of points with associated values p and q.
Two sets of points and two sets of real values associated with those points are given. Computing the correlation function results in an array of the expected (average) product of all values at a given radial distance.
The values of r to compute the correlation function at are controlled by the rmax and dr parameters to the constructor. rmax determines the maximum r at which to compute the correlation function and dr is the step size for each bin.
Note
2D:
freud.density.FloatCF
properly handles 2D boxes. The points must be passed in as[x, y, 0]
. Failing to set z=0 will lead to undefined behavior.Self-correlation: It is often the case that we wish to compute the correlation function of a set of points with itself. If given the same arrays for both points and ref_points, we omit accumulating the self-correlation value in the first bin.
Module author: Matthew Spellings <mspells@umich.edu>
Parameters: -
R
¶ Bin centers.
-
RDF
¶ Returns the radial distribution function.
Returns: expected (average) product of all values at a given radial distance Return type: numpy.ndarray
, shape=(\(N_{bins}\)), dtype=numpy.float64
-
accumulate
(self, box, ref_points, refValues, points, values, nlist=None)¶ Calculates the correlation function and adds to the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – reference points to calculate the local density - refValues (
numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.float64
) – values to use in computation - points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – points to calculate the local density - values (
numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.float64
) – values to use in computation - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
box
¶ Get the box used in the calculation.
-
compute
(self, box, ref_points, refValues, points, values, nlist=None)¶ Calculates the correlation function for the given points. Will overwrite the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – reference points to calculate the local density - refValues (
numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.float64
) – values to use in computation - points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – points to calculate the local density - values (
numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.float64
) – values to use in computation - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
counts
¶ The counts.
-
getBox
(self)¶ Get the box used in the calculation
Returns: freud Box Return type: freud.box.Box
-
getCounts
(self)¶ Returns: counts of each histogram bin Return type: numpy.ndarray
, shape=(\(N_{bins}\)), dtype=numpy.int32
-
getR
(self)¶ Returns: values of bin centers Return type: numpy.ndarray
, shape=(\(N_{bins}\)), dtype=numpy.float32
-
getRDF
(self)¶ Returns the radial distribution function.
Returns: expected (average) product of all values at a given radial distance Return type: numpy.ndarray
, shape=(\(N_{bins}\)), dtype=numpy.float64
-
reduceCorrelationFunction
(self)¶ Reduces the histogram in the values over N processors to a single histogram. This is called automatically by
freud.density.FloatCF.getRDF()
,freud.density.FloatCF.getCounts()
.
-
resetCorrelationFunction
(self)¶ Resets the values of the correlation function histogram in memory
-
-
class
freud.density.
ComplexCF
(rmax, dr)¶ Computes the pairwise correlation function \(\left< p*q \right> \left( r \right)\) between two sets of points with associated values \(p\) and \(q\).
Two sets of points and two sets of complex values associated with those points are given. Computing the correlation function results in an array of the expected (average) product of all values at a given radial distance.
The values of \(r\) to compute the correlation function at are controlled by the rmax and dr parameters to the constructor. rmax determines the maximum r at which to compute the correlation function and dr is the step size for each bin.
Note
2D:
freud.density.ComplexCF
properly handles 2D boxes. The points must be passed in as[x, y, 0]
. Failing to set z=0 will lead to undefined behavior.Self-correlation: It is often the case that we wish to compute the correlation function of a set of points with itself. If given the same arrays for both points and ref_points, we omit accumulating the self-correlation value in the first bin.
Module author: Matthew Spellings <mspells@umich.edu>
Parameters: -
R
¶ The value of bin centers.
-
RDF
¶ The RDF.
-
accumulate
(self, box, ref_points, refValues, points, values, nlist=None)¶ Calculates the correlation function and adds to the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – reference points to calculate the local density - refValues (
numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.complex128
) – values to use in computation - points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – points to calculate the local density - values (
numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.complex128
) – values to use in computation - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
box
¶ Get the box used in the calculation.
-
compute
(self, box, ref_points, refValues, points, values, nlist=None)¶ Calculates the correlation function for the given points. Will overwrite the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – reference points to calculate the local density - refValues (
numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.complex128
) – values to use in computation - points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – points to calculate the local density - values (
numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.complex128
) – values to use in computation - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
counts
¶ The counts of each histogram.
-
getBox
(self)¶ Returns: freud Box Return type: freud.box.Box()
-
getCounts
(self)¶ Returns: counts of each histogram bin Return type: numpy.ndarray
, shape=(\(N_{bins}\)), dtype=numpy.int32
-
getR
(self)¶ The value of bin centers.
Returns: values of bin centers Return type: numpy.ndarray
, shape=(\(N_{bins}\)), dtype=numpy.float32
-
getRDF
(self)¶ The RDF.
Returns: expected (average) product of all values at a given radial distance Return type: numpy.ndarray
, shape=(\(N_{bins}\)), dtype=numpy.complex128
-
reduceCorrelationFunction
(self)¶ Reduces the histogram in the values over N processors to a single histogram. This is called automatically by
freud.density.ComplexCF.getRDF()
,freud.density.ComplexCF.getCounts()
.
-
resetCorrelationFunction
(self)¶ Resets the values of the correlation function histogram in memory
-
Gaussian Density¶
-
class
freud.density.
GaussianDensity
(*args)¶ Computes the density of a system on a grid.
Replaces particle positions with a Gaussian blur and calculates the contribution from the grid based upon the distance of the grid cell from the center of the Gaussian. The dimensions of the image (grid) are set in the constructor.
Module author: Joshua Anderson <joaander@umich.edu>
Parameters: - width (unsigned int) – number of pixels to make the image
- width_x (unsigned int) – number of pixels to make the image in x
- width_y (unsigned int) – number of pixels to make the image in y
- width_z (unsigned int) – number of pixels to make the image in z
- r_cut (float) – distance over which to blur
- sigma (float) – sigma parameter for Gaussian
Constructor Calls:
Initialize with all dimensions identical:
freud.density.GaussianDensity(width, r_cut, dr)
Initialize with each dimension specified:
freud.density.GaussianDensity(width_x, width_y, width_z, r_cut, dr)
-
box
¶ Get the box used in the calculation.
-
compute
(self, box, points)¶ Calculates the Gaussian blur for the specified points. Does not accumulate (will overwrite current image).
Parameters: - box (
freud.box.Box
) – simulation box - points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – points to calculate the local density
- box (
-
gaussian_density
¶ The image grid with the Gaussian density.
-
getBox
(self)¶ Returns: freud Box Return type: freud.box.Box
-
getGaussianDensity
(self)¶ Returns: Image (grid) with values of Gaussian Return type: numpy.ndarray
, shape=(\(w_x\), \(w_y\), \(w_z\)), dtype=numpy.float32
-
resetDensity
(self)¶ Resets the values of GaussianDensity in memory
Local Density¶
-
class
freud.density.
LocalDensity
(r_cut, volume, diameter)¶ Computes the local density around a particle.
The density of the local environment is computed and averaged for a given set of reference points in a sea of data points. Providing the same points calculates them against themselves. Computing the local density results in an array listing the value of the local density around each reference point. Also available is the number of neighbors for each reference point, giving the user the ability to count the number of particles in that region.
The values to compute the local density are set in the constructor. r_cut sets the maximum distance at which to calculate the local density. volume is the volume of a single particle. diameter is the diameter of the circumsphere of an individual particle.
Note
2D:
freud.density.LocalDensity
properly handles 2D boxes. The points must be passed in as[x, y, 0]
. Failing to set z=0 will lead to undefined behavior.Module author: Joshua Anderson <joaander@umich.edu>
Parameters: -
box
¶ Get the box used in the calculation.
-
compute
(self, box, ref_points, points=None, nlist=None)¶ Calculates the local density for the specified points. Does not accumulate (will overwrite current data).
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – reference points to calculate the local density - points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – (optional) points to calculate the local density - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
density
¶ Density array for each particle.
-
getBox
(self)¶ Returns: freud Box Return type: freud.box.Box
-
getDensity
(self)¶ Get the density array for each particle.
Returns: Density array for each particle Return type: numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.float32
-
getNumNeighbors
(self)¶ Return the number of neighbors for each particle.
Returns: Number of neighbors for each particle Return type: numpy.ndarray
, shape=(\(N_{particles}\)), dtype=numpy.float32
-
num_neighbors
¶ Number of neighbors for each particle.
-
Radial Distribution Function¶
-
class
freud.density.
RDF
(rmax, dr, rmin=0)¶ Computes RDF for supplied data.
The RDF (\(g \left( r \right)\)) is computed and averaged for a given set of reference points in a sea of data points. Providing the same points calculates them against themselves. Computing the RDF results in an RDF array listing the value of the RDF at each given \(r\), listed in the r array.
The values of \(r\) to compute the RDF are set by the values of rmin, rmax, dr in the constructor. rmax sets the maximum distance at which to calculate the \(g \left( r \right)\), rmin sets the minimum distance at which to calculate the \(g \left( r \right)\), and dr determines the step size for each bin.
Module author: Eric Harper <harperic@umich.edu>
Note
2D:
freud.density.RDF
properly handles 2D boxes. The points must be passed in as[x, y, 0]
. Failing to set z=0 will lead to undefined behavior.Parameters: Changed in version 0.7.0: Added optional rmin argument.
-
R
¶ Values of bin centers.
-
RDF
¶ Histogram of RDF values.
-
accumulate
(self, box, ref_points, points, nlist=None)¶ Calculates the RDF and adds to the current RDF histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – reference points to calculate the local density - points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – points to calculate the local density - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
box
¶ Get the box used in the calculation.
-
compute
(self, box, ref_points, points, nlist=None)¶ Calculates the RDF for the specified points. Will overwrite the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – reference points to calculate the local density - points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – points to calculate the local density - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
getBox
(self)¶ Returns: freud Box Return type: freud.box.Box
-
getNr
(self)¶ Get the histogram of cumulative RDF values.
Returns: histogram of cumulative RDF values Return type: numpy.ndarray
, shape=(\(N_{bins}\), 3), dtype=numpy.float32
-
getR
(self)¶ Values of the histogram bin centers.
Returns: values of the histogram bin centers Return type: numpy.ndarray
, shape=(\(N_{bins}\), 3), dtype=numpy.float32
-
getRDF
(self)¶ Histogram of RDF values.
Returns: histogram of RDF values Return type: numpy.ndarray
, shape=(\(N_{bins}\), 3), dtype=numpy.float32
-
n_r
¶ Histogram of cumulative RDF values.
-
reduceRDF
(self)¶ Reduces the histogram in the values over N processors to a single histogram. This is called automatically by
freud.density.RDF.getRDF()
,freud.density.RDF.getNr()
.
-
resetRDF
(self)¶ Resets the values of RDF in memory
-
Index Module¶
The index module exposes the \(1\)-dimensional indexer utilized in freud at the C++ level.
At the C++ level, freud utilizes “flat” arrays, i.e. an \(n\)-dimensional array with \(n_i\) elements in each index is represented as a \(1\)-dimensional array with \(\prod\limits_i n_i\) elements.
Index2D¶
-
class
freud.index.
Index2D
(*args)¶ freud-style indexer for flat arrays.
freud utilizes “flat” arrays at the C++ level i.e. an \(n\)-dimensional array with \(n_i\) elements in each index is represented as a \(1\)-dimensional array with \(\prod\limits_i n_i\) elements.
Note
freud indexes column-first i.e. Index2D(i, j) will return the \(1\)-dimensional index of the \(i^{th}\) column and the \(j^{th}\) row. This is the opposite of what occurs in a numpy array, in which array[i, j] returns the element in the \(i^{th}\) row and the \(j^{th}\) column
Module author: Joshua Anderson <joaander@umich.edu>
Parameters: - w (unsigned int) – width of 2D array (number of columns)
- h (unsigned int) – height of 2D array (number of rows)
Constructor Calls:
Initialize with all dimensions identical:
freud.index.Index2D(w)
Initialize with each dimension specified:
freud.index.Index2D(w, h)
-
__call__
(self, i, j)¶ Parameters: - i (unsigned int) – column index
- j (unsigned int) – row index
Returns: \(1\)-dimensional index in flat array
Return type: unsigned int
-
getNumElements
(self)¶ Get the number of elements in the array :return: number of elements in the array :rtype: unsigned int
-
num_elements
¶ Number of elements in the array.
Index3D¶
-
class
freud.index.
Index3D
(*args)¶ freud-style indexer for flat arrays.
freud utilizes “flat” arrays at the C++ level i.e. an \(n\)-dimensional array with \(n_i\) elements in each index is represented as a \(1\)-dimensional array with \(\prod\limits_i n_i\) elements.
Note
freud indexes column-first i.e. Index3D(i, j, k) will return the \(1\)-dimensional index of the \(i^{th}\) column, \(j^{th}\) row, and the \(k^{th}\) frame. This is the opposite of what occurs in a numpy array, in which array[i, j, k] returns the element in the \(i^{th}\) frame, \(j^{th}\) row, and the \(k^{th}\) column.
Module author: Joshua Anderson <joaander@umich.edu>
Parameters: - w (unsigned int) – width of 2D array (number of columns)
- h (unsigned int) – height of 2D array (number of rows)
- d (unsigned int) – depth of 2D array (number of frames)
Constructor Calls:
Initialize with all dimensions identical:
freud.index.Index3D(w)
Initialize with each dimension specified:
freud.index.Index3D(w, h, d)
-
__call__
(self, i, j, k)¶ Parameters: - i (unsigned int) – column index
- j (unsigned int) – row index
- k (unsigned int) – frame index
Returns: \(1\)-dimensional index in flat array
Return type: unsigned int
-
getNumElements
(self)¶ Get the number of elements in the array :return: number of elements in the array :rtype: unsigned int
-
num_elements
¶ Number of elements in the array.
Interface Module¶
The interface module contains functions to measure the interface between sets of points.
InterfaceMeasure¶
-
class
freud.interface.
InterfaceMeasure
(box, r_cut)¶ Measures the interface between two sets of points.
Module author: Matthew Spellings <mspells@umich.edu>
Parameters: - box (
freud.box.Box
) – simulation box - r_cut (float) – Distance to search for particle neighbors
-
compute
(self, ref_points, points, nlist=None)¶ Compute and return the number of particles at the interface between the two given sets of points.
Parameters: - ref_points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – one set of particle positions - points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – other set of particle positions - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- ref_points (
- box (
KSpace Module¶
Modules for calculating quantities in reciprocal space, including Fourier transforms of shapes and diffraction pattern generation.
Meshgrid¶
-
freud.kspace.
meshgrid2
(*arrs)[source]¶ Computes an n-dimensional meshgrid.
source: http://stackoverflow.com/questions/1827489/numpy-meshgrid-in-3d
Parameters: arrs – Arrays to meshgrid Returns: tuple of arrays Return type: tuple
Structure Factor¶
Methods for calculating the structure factor of different systems.
-
class
freud.kspace.
SFactor3DPoints
(box, g)[source]¶ Compute the full 3D structure factor of a given set of points.
Given a set of points \(\vec{r}_i\), SFactor3DPoints computes the static structure factor \(S \left( \vec{q} \right) = C_0 \left| {\sum_{m=1}^{N} \exp{\mathit{i}\vec{q}\cdot\vec{r_i}}} \right|^2\).
In this expression, \(C_0\) is a scaling constant chosen so that \(S\left(0\right) = 1\), and \(N\) is the number of particles.
\(S\) is evaluated on a grid of \(q\)-values \(\vec{q} = h \frac{2\pi}{L_x} \hat{i} + k \frac{2\pi}{L_y} \hat{j} + l \frac{2\pi}{L_z} \hat{k}\) for integer \(h,k,l: \left[-g,g\right]\) and \(L_x, L_y, L_z\) are the box lengths in each direction.
After calling
compute()
, access the \(q\) values withgetQ()
, the static structure factor values withgetS()
, and (if needed) the un-squared complex version of \(S\) withgetSComplex()
. All values are stored in 3Dnumpy.ndarray
structures. They are indexed by \(a, b, c\) where \(a=h+g, b=k+g, c=l+g\).Note
Due to the way that numpy arrays are indexed, access the returned S array as
S[c,b,a]
to get the value at \(q = \left(qx\left[a\right], qy\left[b\right], qz\left[c\right]\right)\).-
compute
(points)[source]¶ Compute the static structure factor of a given set of points.
After calling
compute()
, you can access the results withgetS()
,getSComplex()
, and the grid withgetQ()
.Parameters: points ( numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – points used to compute the static structure factor
-
getQ
()[source]¶ Get the \(q\) values at each point.
The structure factor
S[c,b,a]
is evaluated at the vector \(q = \left(qx\left[a\right], qy\left[b\right], qz\left[c\right]\right)\).Returns: (qx, qy, qz) Return type: tuple
-
getS
()[source]¶ Get the computed static structure factor.
Returns: The computed static structure factor as a copy Return type: numpy.ndarray
, shape=(X,Y), dtype=numpy.float32
-
getSComplex
()[source]¶ Get the computed complex structure factor (if you need the phase information).
Returns: The computed static structure factor, as a copy, without taking the magnitude squared Return type: numpy.ndarray
, shape=(X,Y), dtype=numpy.complex64
-
-
class
freud.kspace.
AnalyzeSFactor3D
(S)[source]¶ Analyze the peaks in a 3D structure factor.
Given a structure factor \(S\left(q\right)\) computed by classes such as
SFactor3DPoints
,AnalyzeSFactor3D
performs a variety of analysis tasks.- Identifies peaks
- Provides a list of peaks and the vector \(\vec{q}\) positions at which they occur
- Provides a list of peaks grouped by \(q^2\)
- Provides a full list of \(S\left(\left|q\right|\right)\) values vs \(q^2\) suitable for plotting the 1D analog of the structure factor
- Scans through the full 3D peaks and reconstructs the Bravais lattice
Note
All of these operations work in an indexed integer \(q\)-space \(h,k,l\). Any peak position values returned must be multiplied by \(2\pi/L\) to get to real \(q\) values in simulation units.
-
getPeakDegeneracy
(cut)[source]¶ Get a dictionary of peaks indexed by \(q^2\).
Parameters: cut ( numpy.ndarray
) – All \(S\left(q\right)\) values greater than cut will be counted as peaksReturns: a dictionary with keys \(q^2\) and a list of peaks for the corresponding values Return type: dict
-
getPeakList
(cut)[source]¶ Get a list of peaks in the structure factor.
Parameters: cut – All \(S\left(q\right)\) values greater than cut will be counted as peaks Returns: peaks, \(q\) as lists Return type: list
-
getSvsQ
()[source]¶ Get a list of all \(S\left(\left|q\right|\right)\) values vs \(q^2\).
Returns: S, qsquared Return type: numpy.ndarray
-
class
freud.kspace.
SingleCell3D
(k, ndiv, dK, boxMatrix)[source]¶ SingleCell3D objects manage data structures necessary to call the Fourier Transform functions that evaluate FTs for given form factors at a list of \(K\) points. SingleCell3D provides an interface to helper functions to calculate \(K\) points for a desired grid from the reciprocal lattice vectors calculated from an input boxMatrix. State is maintained as set_ and update_ functions invalidate internal data structures and as fresh data is restored with update_ function calls. This should facilitate management with a higher-level UI such as a GUI with an event queue.
I’m not sure what sort of error checking would be most useful, so I’m mostly allowing ValueErrors and such exceptions to just occur and then propagate up through the calling functions to be dealt with by the user.
-
add_ptype
(name)[source]¶ Create internal data structures for new particle type by name.
Particle type is inactive when added because parameters must be set before FT can be performed.
Parameters: name (str) – particle name
-
calculate
(*args, **kwargs)[source]¶ Calculate FT. The details and arguments will vary depending on the form factor chosen for the particles.
For any particle type-dependent parameters passed as keyword arguments, the parameter must be passed as a list of length
max(p_type)+1
with indices corresponding to the particle types defined. In other words, type-dependent parameters are optional (depending on the set of form factors being calculated), but if included must be defined for all particle types.Parameters: - position (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – array of particle positions in nm - orientation (
numpy.ndarray
, shape=(\(N_{particles}\), 4), dtype=numpy.float32
) – array of orientation quaternions - kwargs – additional keyword arguments passed on to form-factor-specific FT calculator
- position (
-
get_form_factors
()[source]¶ Get form factor names and indices.
Returns: list of factor names and indices Return type: list
-
get_ptypes
()[source]¶ Get ordered list of particle names.
Returns: list of particle names Return type: list
-
remove_ptype
(name)[source]¶ Remove internal data structures associated with ptype
name
.Parameters: name (str) – particle name Note
This shouldn’t usually be necessary, since particle types may be set inactive or have any of their properties updated through set_ methods.
-
set_box
(boxMatrix)[source]¶ Set box matrix.
Parameters: boxMatrix ( numpy.ndarray
, shape=(3, 3), dtype=numpy.float32
) – unit cell box matrix
-
set_dK
(dK)[source]¶ Set grid spacing in diffraction image.
Parameters: dK (float) – difference in \(K\) vector between two adjacent diffraction image grid points
-
set_form_factor
(name, ff)[source]¶ Set scattering form factor.
Parameters: - name (str) – particle type name
- ff (
list
) – scattering form factor named inget_form_factors()
-
set_k
(k)[source]¶ Set angular wave number of plane wave probe.
Parameters: k (float) – \(\left|k_0\right|\)
-
set_ndiv
(ndiv)[source]¶ Set number of grid divisions in diffraction image.
Parameters: ndiv (int) – define diffraction image as ndiv x ndiv grid
-
set_rq
(name, position, orientation)[source]¶ Set positions and orientations for a particle type.
To best maintain valid state in the event of changing numbers of particles, position and orientation are updated in a single method.
Parameters: - name (str) – particle type name
- position (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – (N,3) array of particle positions - orientation (
numpy.ndarray
, shape=(\(N_{particles}\), 4), dtype=numpy.float32
) – (N,4) array of particle quaternions
-
set_scale
(scale)[source]¶ Set scale factor. Store global value and set for each particle type.
Parameters: scale (float) – nm per unit for input file coordinates
-
update_K_constraint
()[source]¶ Recalculate constraint used to select \(K\) values.
The constraint used is a slab of epsilon thickness in a plane perpendicular to the \(k_0\) propagation, intended to provide easy emulation of TEM or relatively high-energy scattering.
-
-
class
freud.kspace.
FTfactory
[source]¶ Factory to return an FT object of the requested type.
-
getFTlist
()[source]¶ Get an ordered list of named FT types.
Returns: list of FT names Return type: list
-
getFTobject
(i, args=None)[source]¶ Get a new instance of an FT type from list returned by
getFTlist()
.Parameters: - i (int) – index into list returned by
getFTlist()
- args (
list
) – argument object used to initialize FT, overriding default set ataddFT()
- i (int) – index into list returned by
-
-
class
freud.kspace.
FTbase
[source]¶ Base class for FT calculation classes.
-
getFT
()[source]¶ Return Fourier Transform.
Returns: Fourier Transform Return type: numpy.ndarray
-
get_parambyname
(name)[source]¶ Get named parameter for object.
Parameters: name (str) – parameter name. Must exist in list returned by get_params()
Returns: parameter value Return type: float
-
get_params
()[source]¶ Get the parameter names accessible with
set_parambyname()
.Returns: parameter names Return type: list
-
set_K
(K)[source]¶ Set \(K\) points to be evaluated.
Parameters: K ( numpy.ndarray
) – list of \(K\) vectors at which to evaluate FT
-
set_parambyname
(name, value)[source]¶ Set named parameter for object.
Parameters: - name (str) – parameter name. Must exist in list returned by
get_params()
- value (float) – parameter value to set
- name (str) – parameter name. Must exist in list returned by
-
set_rq
(r, q)[source]¶ Set \(r\), \(q\) values.
Parameters: - r (
numpy.ndarray
) – \(r\) - q (
numpy.ndarray
) – \(q\)
- r (
-
-
class
freud.kspace.
FTdelta
[source]¶ Fourier transform a list of delta functions.
-
compute
(*args, **kwargs)[source]¶ Compute FT.
Calculate \(S = \sum_{\alpha} \exp^{-i \mathbf{K} \cdot \mathbf{r}_{\alpha}}\)
-
set_K
(K)[source]¶ Set \(K\) points to be evaluated.
Parameters: K ( numpy.ndarray
) – list of \(K\) vectors at which to evaluate FT
-
set_rq
(r, q)[source]¶ Set \(r\), \(q\) values.
Parameters: - r (
numpy.ndarray
) – \(r\) - q (
numpy.ndarray
) – \(q\)
- r (
-
-
class
freud.kspace.
FTsphere
[source]¶ Fourier transform for sphere.
Calculate \(S = \sum_{\alpha} \exp^{-i \mathbf{K} \cdot \mathbf{r}_{\alpha}}\)
-
class
freud.kspace.
FTpolyhedron
[source]¶ Fourier Transform for polyhedra.
-
compute
(*args, **kwargs)[source]¶ Compute FT.
Calculate \(S = \sum_{\alpha} \exp^{-i \mathbf{K} \cdot \mathbf{r}_{\alpha}}\)
-
get_radius
()[source]¶ Get radius parameter.
If appropriate, return value should be scaled by
get_parambyname('scale')
for interpretation.Returns: unscaled radius Return type: float
-
set_K
(K)[source]¶ Set \(K\) points to be evaluated.
Parameters: K ( numpy.ndarray
) – list of \(K\) vectors at which to evaluate FT
-
set_params
(verts, facets, norms, d, areas, volume)[source]¶ Construct list of facet offsets.
Parameters: - verts (
numpy.ndarray
, shape=(\(N_{verts}\), 3), dtype=numpy.float32
) – list of vertices - facets (
numpy.ndarray
, shape=(\(N_{facets}\), \(N_{verts}\)), dtype=numpy.float32
) – list of facets - norms (
numpy.ndarray
, shape=(\(N_{facets}\), 3), dtype=numpy.float32
) – list of norms - d (
numpy.ndarray
, shape=(\(N_{facets}\)), dtype=numpy.float32
) – list of d values - areas (
numpy.ndarray
, shape=(\(N_{facets}\)), dtype=numpy.float32
) – list of areas - volumes (
numpy.ndarray
) – list of volumes
- verts (
-
set_radius
(radius)[source]¶ Set radius of in-sphere.
Parameters: radius (float) – radius inscribed sphere radius without scale applied
-
set_rq
(r, q)[source]¶ Set \(r\), \(q\) values.
Parameters: - r (
numpy.ndarray
) – \(r\) - q (
numpy.ndarray
) – \(q\)
- r (
-
-
class
freud.kspace.
FTconvexPolyhedron
[source]¶ Fourier Transform for convex polyhedra.
-
Spoly3D
(k)[source]¶ Calculate Fourier transform of polyhedron.
Parameters: k (int) – angular wave vector at which to calculate \(S\left(i\right)\)
-
compute_py
(*args, **kwargs)[source]¶ Compute FT.
Calculate \(P = F * S\):
- \(S = \sum_{\alpha} \exp^{-i \mathbf{K} \cdot \mathbf{r}_{\alpha}}\)
- F is the analytical form factor for a polyhedron,
computed with
Spoly3D()
-
Diffraction Patterns¶
Methods for calculating diffraction patterns of various systems.
-
class
freud.kspace.
DeltaSpot
[source]¶ Base class for drawing diffraction spots on a 2D grid.
Based on the dimensions of a grid, determines which grid points need to be modified to represent a diffraction spot and generates the values in that subgrid. Spot is a single pixel at the closest grid point.
-
get_gridPoints
()[source]¶ Get indices of sub-grid.
Based on the type of spot and its center, return the grid mask of points containing the spot
-
-
class
freud.kspace.
GaussianSpot
[source]¶ Draw diffraction spot as a Gaussian blur.
Grid points filled according to Gaussian at spot center.
Utilities¶
Classes and methods used by other kspace modules.
-
class
freud.kspace.
Constraint
[source]¶ Constraint base class.
Base class for constraints on vectors to define the API. All constraints should have a ‘radius’ defining a bounding sphere and a ‘satisfies’ method to determine whether an input vector satisfies the constraint.
-
satisfies
(v)[source]¶ Constraint test.
Parameters: v ( numpy.ndarray
, shape=(3), dtype=numpy.float32
) – vector to test against constraint
-
-
class
freud.kspace.
AlignedBoxConstraint
[source]¶ Axis-aligned Box constraint.
Tetragonal box aligned with the coordinate system. Consider using a small z dimension to serve as a plane plus or minus some epsilon. Set R < L for a cylinder
-
satisfies
(v)[source]¶ Constraint test.
Parameters: v ( numpy.ndarray
, shape=(3), dtype=numpy.float32
) – vector to test against constraint
-
-
freud.kspace.
constrainedLatticePoints
()[source]¶ Generate a list of points satisfying a constraint.
Parameters: - v1 (
numpy.ndarray
, shape=(3), dtype=numpy.float32
) – lattice vector 1 along which to test points - v2 (
numpy.ndarray
, shape=(3), dtype=numpy.float32
) – lattice vector 2 along which to test points - v3 (
numpy.ndarray
, shape=(3), dtype=numpy.float32
) – lattice vector 3 along which to test points - constraint (
Constraint
) – constraint object to test lattice points against
- v1 (
-
freud.kspace.
reciprocalLattice3D
()[source]¶ Calculate reciprocal lattice vectors.
3D reciprocal lattice vectors with magnitude equal to angular wave number.
Parameters: - a1 (
numpy.ndarray
, shape=(3), dtype=numpy.float32
) – real space lattice vector 1 - a2 (
numpy.ndarray
, shape=(3), dtype=numpy.float32
) – real space lattice vector 2 - a3 (
numpy.ndarray
, shape=(3), dtype=numpy.float32
) – real space lattice vector 3
Returns: list of reciprocal lattice vectors
Return type: Note
For unit test,
dot(g[i], a[j]) = 2 * pi * diracDelta(i, j)
- a1 (
Locality Module¶
The locality module contains data structures to efficiently locate points based on their proximity to other points.
NeighborList¶
-
class
freud.locality.
NeighborList
¶ Class representing a certain number of “bonds” between particles. Computation methods will iterate over these bonds when searching for neighboring particles.
NeighborList objects are constructed for two sets of position arrays A (alternatively reference points; of length \(n_A\)) and B (alternatively target points; of length \(n_B\)) and hold a set of \(\left(i, j\right): i < n_A, j < n_B\) index pairs corresponding to near-neighbor points in A and B, respectively.
For efficiency, all bonds for a particular reference particle \(i\) are contiguous and bonds are stored in order based on reference particle index \(i\). The first bond index corresponding to a given particle can be found in \(\log(n_{bonds})\) time using
find_first_index()
.Module author: Matthew Spellings <mspells@umich.edu>
New in version 0.6.4.
Note
Typically, there is no need to instantiate this class directly. In most cases, users should manipulate
freud.locality.NeighborList
objects received from a neighbor search algorithm, such asfreud.locality.LinkCell
,freud.locality.NearestNeighbors
, orfreud.voronoi.Voronoi
.Example:
# Assume we have position as Nx3 array lc = LinkCell(box, 1.5).compute(box, positions) nlist = lc.nlist # Get all vectors from central particles to their neighbors rijs = positions[nlist.index_j] - positions[nlist.index_i] box.wrap(rijs)
-
copy
(self, other=None)¶ Create a copy. If other is given, copy its contents into this object. Otherwise, return a copy of this object.
-
filter
(self, filt)¶ Removes bonds that satisfy a boolean criterion.
Parameters: filt – Boolean-like array of bonds to keep (True means the bond stays) Note
This method modifies this object in-place.
Example:
# Keep only the bonds between particles of type A and type B nlist.filter(types[nlist.index_i] != types[nlist.index_j])
-
filter_r
(self, box, ref_points, points, float rmax, float rmin=0)¶ Removes bonds that are outside of a given radius range.
Parameters: - ref_points (
numpy.ndarray
, shape= \(\left(N_{points}, 3\right)\), dtype=numpy.float32
) – reference points to use for filtering - points (
numpy.ndarray
, shape= \(\left(N_{points}, 3\right)\), dtype=numpy.float32
) – target points to use for filtering - rmax (float) – maximum bond distance in the resulting neighbor list
- rmin (float) – minimum bond distance in the resulting neighbor list
Note
This method modifies this object in-place.
- ref_points (
-
find_first_index
(self, unsigned int i)¶ Returns the lowest bond index corresponding to a reference particle with an index \(\geq i\).
-
from_arrays
(type cls, Nref, Ntarget, index_i, index_j, weights=None)¶ Create a NeighborList from a set of bond information arrays.
Parameters: - Nref (unsigned int) – Number of reference points (corresponding to
index_i
) - Ntarget (unsigned int) – Number of target points (corresponding to
index_j
) - index_i (Array-like of unsigned ints, length
num_bonds
) – Array of integers corresponding to indices in the set of reference points - index_j (Array-like of unsigned ints, length
num_bonds
) – Array of integers corresponding to indices in the set of target points - weights (Array-like of floats, length
num_bonds
) – Array of per-bond weights (ifNone
is given, use a value of 1 for each weight)
- Nref (unsigned int) – Number of reference points (corresponding to
-
index_i
¶ The reference point indices from the last set of points this object was evaluated with. This array is read-only to prevent breakage of
find_first_index()
.
-
index_j
¶ The target point indices from the last set of points this object was evaluated with. This array is read-only to prevent breakage of
find_first_index()
.
-
neighbor_counts
¶ A neighbor count array, which is an array of length \(N_{ref}\) indicating the number of neighbors for each reference particle from the last set of points this object was evaluated with.
-
segments
¶ A segment array, which is an array of length \(N_{ref}\) indicating the first bond index for each reference particle from the last set of points this object was evaluated with.
-
weights
¶ The per-bond weights from the last set of points this object was evaluated with.
-
LinkCell¶
-
class
freud.locality.
LinkCell
(box, cell_width)¶ Supports efficiently finding all points in a set within a certain distance from a given point.
Module author: Joshua Anderson <joaander@umich.edu>
Parameters: - box (
freud.box.Box
) – simulation box - cell_width (float) – Maximum distance to find particles within
Note
2D:
freud.locality.LinkCell
properly handles 2D boxes. The points must be passed in as[x, y, 0]
. Failing to set z=0 will lead to undefined behavior.Example:
# Assume positions are an Nx3 array lc = LinkCell(box, 1.5) lc.computeCellList(box, positions) for i in range(positions.shape[0]): # Cell containing particle i cell = lc.getCell(positions[0]) # List of cell's neighboring cells cellNeighbors = lc.getCellNeighbors(cell) # Iterate over neighboring cells (including our own) for neighborCell in cellNeighbors: # Iterate over particles in each neighboring cell for neighbor in lc.itercell(neighborCell): pass # Do something with neighbor index # Using NeighborList API dens = density.LocalDensity(1.5, 1, 1) dens.compute(box, positions, nlist=lc.nlist)
-
box
¶ freud Box.
-
compute
(self, box, ref_points, points=None, exclude_ii=None)¶ Update the data structure for the given set of points and compute a NeighborList
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape= \(\left(N_{refpoints}, 3\right)\), dtype=numpy.float32
) – reference point coordinates - points (
numpy.ndarray
, shape= \(\left(N_{points}, 3\right)\), dtype=numpy.float32
) – point coordinates - exclude_ii – True if pairs of points with identical indices should be excluded; if None, is set to True if points is None or the same object as ref_points
- box (
-
computeCellList
(self, box, ref_points, points=None, exclude_ii=None)¶ Update the data structure for the given set of points and compute a NeighborList
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape= \(\left(N_{refpoints}, 3\right)\), dtype=numpy.float32
) – reference point coordinates - points (
numpy.ndarray
, shape= \(\left(N_{points}, 3\right)\), dtype=numpy.float32
) – point coordinates - exclude_ii – True if pairs of points with identical indices should be excluded; if None, is set to True if points is None or the same object as ref_points
- box (
-
getBox
(self)¶ Get the freud Box.
Returns: freud Box Return type: freud.box.Box
-
getCell
(self, point)¶ Returns the index of the cell containing the given point.
Parameters: point ( numpy.ndarray
, shape= \(\left(3\right)\), dtype=numpy.float32
) – point coordinates \(\left(x,y,z\right)\)Returns: cell index Return type: unsigned int
-
getCellNeighbors
(self, cell)¶ Returns the neighboring cell indices of the given cell.
Parameters: cell (unsigned int) – Cell index Returns: array of cell neighbors Return type: numpy.ndarray
, shape= \(\left(N_{neighbors}\right)\), dtype=numpy.uint32
-
getNumCells
(self)¶ Get the number of cells in this box.
Returns: the number of cells in this box Return type: unsigned int
-
itercell
(self, unsigned int cell)¶ Return an iterator over all particles in the given cell.
Parameters: cell (unsigned int) – Cell index Returns: iterator to particle indices in specified cell Return type: iter
-
num_cells
¶ The number of cells in this box.
- box (
NearestNeighbors¶
-
class
freud.locality.
NearestNeighbors
(rmax, n_neigh, scale=1.1, strict_cut=False)¶ Supports efficiently finding the \(N\) nearest neighbors of each point in a set for some fixed integer \(N\).
strict_cut == True
:rmax
will be strictly obeyed, and any particle which has fewer than \(N\) neighbors will have values ofUINT_MAX
assigned.strict_cut == False
(default):rmax
will be expanded to find the requested number of neighbors. Ifrmax
increases to the point that a cell list cannot be constructed, a warning will be raised and the neighbors already found will be returned.
Module author: Eric Harper <harperic@umich.edu>
Parameters: - rmax (float) – Initial guess of a distance to search within to find N neighbors
- n_neigh (unsigned int) – Number of neighbors to find for each point
- scale (float) – Multiplier by which to automatically increase
rmax
value if the requested number of neighbors is not found. Only utilized ifstrict_cut
is False. Scale must be greater than 1. - strict_cut (bool) – Whether to use a strict
rmax
or allow for automatic expansion, default is False
Example:
nn = NearestNeighbors(2, 6) nn.compute(box, positions, positions) hexatic = order.HexOrderParameter(2) hexatic.compute(box, positions, nlist=nn.nlist)
-
UINTMAX
¶ Value of C++ UINTMAX used to pad the arrays.
-
box
¶ freud Box.
-
compute
(self, box, ref_points, points, exclude_ii=None)¶ Update the data structure for the given set of points.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – coordinates of reference points - points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – coordinates of points - exclude_ii – True if pairs of points with identical indices should be excluded; if None, is set to True if points is None or the same object as ref_points
- box (
-
getBox
(self)¶ Get the freud Box.
Returns: freud Box Return type: freud.box.Box
-
getNRef
(self)¶ Get the number of particles this object found neighbors of.
Returns: the number of particles this object found neighbors of Return type: unsigned int
-
getNeighborList
(self)¶ Return the entire neighbor list.
Returns: Neighbor List Return type: numpy.ndarray
, shape= \(\left(N_{particles}, N_{neighbors}\right)\), dtype=numpy.uint32
-
getNeighbors
(self, unsigned int i)¶ Return the \(N\) nearest neighbors of the reference point with index \(i\).
Parameters: i (unsigned int) – index of the reference point whose neighbors will be returned
-
getNumNeighbors
(self)¶ The number of neighbors this object will find.
Returns: the number of neighbors this object will find Return type: unsigned int
-
getRMax
(self)¶ Return the current neighbor search distance guess.
Returns: nearest neighbors search radius Return type: float
-
getRsq
(self, unsigned int i)¶ Return the squared distances to the \(N\) nearest neighbors of the reference point with index \(i\).
Parameters: i (unsigned int) – index of the reference point of which to fetch the neighboring point distances Returns: squared distances to the \(N\) nearest neighbors Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
-
getRsqList
(self)¶ Return the entire Rsq values list.
Returns: Rsq list Return type: numpy.ndarray
, shape= \(\left(N_{particles}, N_{neighbors}\right)\), dtype=numpy.float32
-
getUINTMAX
(self)¶ Returns: value of C++ UINTMAX used to pad the arrays Return type: unsigned int
-
getWrappedVectors
(self)¶ Return the wrapped vectors for computed neighbors. Array padded with -1 for empty neighbors.
Returns: wrapped vectors Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
-
n_ref
¶ The number of particles this object found neighbors of.
-
num_neighbors
¶ The number of neighbors this object will find.
-
r_max
¶ Return the current neighbor search distance guess.
Returns: nearest neighbors search radius Return type: float
-
r_sq_list
¶ Return the entire Rsq values list.
Returns: Rsq list Return type: numpy.ndarray
, shape= \(\left(N_{particles}, N_{neighbors}\right)\), dtype=numpy.float32
-
setCutMode
(self, strict_cut)¶ Set mode to handle
rmax
by Nearest Neighbors.strict_cut == True
:rmax
will be strictly obeyed, and any particle which has fewer than \(N\) neighbors will have values ofUINT_MAX
assigned.strict_cut == False
:rmax
will be expanded to find the requested number of neighbors. Ifrmax
increases to the point that a cell list cannot be constructed, a warning will be raised and the neighbors already found will be returned.
Parameters: strict_cut (bool) – whether to use a strict rmax
or allow for automatic expansion
-
setRMax
(self, float rmax)¶ Update the neighbor search distance guess.
Parameters: rmax (float) – nearest neighbors search radius
-
wrapped_vectors
¶ Return the wrapped vectors for computed neighbors. Array padded with -1 for empty neighbors.
Order Module¶
The order module contains functions which compute order parameters for the whole system or individual particles.
Bond Order¶
-
class
freud.order.
BondOrder
(rmax, k, n, nBinsT, nBinsP)¶ Compute the bond order diagram for the system of particles.
Available modes of calculation:
- If
mode='bod'
(Bond Order Diagram, default): Create the 2D histogram containing the number of bonds formed through the surface of a unit sphere based on the azimuthal \(\left( \theta \right)\) and polar \(\left( \phi \right)\) angles. - If
mode='lbod'
(Local Bond Order Diagram): Create the 2D histogram containing the number of bonds formed, rotated into the local orientation of the central particle, through the surface of a unit sphere based on the azimuthal \(\left( \theta \right)\) and polar \(\left( \phi \right)\) angles. - If
mode='obcd'
(Orientation Bond Correlation Diagram): Create the 2D histogram containing the number of bonds formed, rotated by the rotation that takes the orientation of neighboring particle j to the orientation of each particle i, through the surface of a unit sphere based on the azimuthal \(\left( \theta \right)\) and polar \(\left( \phi \right)\) angles. - If
mode='oocd'
(Orientation Orientation Correlation Diagram): Create the 2D histogram containing the directors of neighboring particles (\(\hat{z}\) rotated by their quaternion), rotated into the local orientation of the central particle, through the surface of a unit sphere based on the azimuthal \(\left( \theta \right)\) and polar \(\left( \phi \right)\) angles.
Module author: Erin Teich <erteich@umich.edu>
Parameters: - r_max (float) – distance over which to calculate
- k (unsigned int) – order parameter i. to be removed
- n (unsigned int) – number of neighbors to find
- n_bins_t (unsigned int) – number of theta bins
- n_bins_p (unsigned int) – number of phi bins
-
accumulate
(self, box, ref_points, ref_orientations, points, orientations, str mode='bod', nlist=None)¶ Calculates the correlation function and adds to the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – reference points to calculate the local density - ref_orientations (
numpy.ndarray
, shape=(\(N_{particles}\), 4), dtype=numpy.float32
) – orientations to use in computation - points (
numpy.ndarray
, shape=(\(N_{particles}\), 3), dtype=numpy.float32
) – points to calculate the local density - orientations (
numpy.ndarray
, shape=(\(N_{particles}\), 4), dtype=numpy.float32
) – orientations to use in computation - mode (str) – mode to calc bond order. “bod”, “lbod”, “obcd”, and “oocd”
- nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
bond_order
¶ Bond order.
-
box
¶ Box used in the calculation.
-
compute
(self, box, ref_points, ref_orientations, points, orientations, mode='bod', nlist=None)¶ Calculates the bond order histogram. Will overwrite the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3 \right)\), dtype=numpy.float32
) – reference points to calculate the local density - ref_orientations (
numpy.ndarray
, shape= \(\left(N_{particles}, 4\right)\), dtype=numpy.float32
) – orientations to use in computation - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3 \right)\), dtype=numpy.float32
) – points to calculate the local density - orientations (
numpy.ndarray
, shape= \(\left(N_{particles}, 4 \right)\), dtype=numpy.float32
) – orientations to use in computation - mode (str) – mode to calc bond order. “bod”, “lbod”, “obcd”, and “oocd”
- nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
getBondOrder
(self)¶ Get the bond order.
Returns: bond order Return type: numpy.ndarray
, shape= \(\left(N_{\phi}, N_{\theta} \right)\), dtype=numpy.float32
-
getBox
(self)¶ Get the box used in the calculation.
Returns: freud Box Return type: freud.box.Box
-
getNBinsPhi
(self)¶ Get the number of bins in the Phi-dimension of histogram.
Returns: \(N_{\phi}\) Return type: unsigned int
-
getNBinsTheta
(self)¶ Get the number of bins in the Theta-dimension of histogram.
Returns: \(N_{\theta}\) Return type: unsigned int
-
getPhi
(self)¶ Returns: values of bin centers for Phi Return type: numpy.ndarray
, shape= \(\left(N_{\phi} \right)\), dtype=numpy.float32
-
getTheta
(self)¶ Returns: values of bin centers for Theta Return type: numpy.ndarray
, shape= \(\left(N_{\theta} \right)\), dtype=numpy.float32
-
reduceBondOrder
(self)¶ Reduces the histogram in the values over N processors to a single histogram. This is called automatically by
freud.order.BondOrder.getBondOrder()
.
-
resetBondOrder
(self)¶ resets the values of the bond order in memory
- If
Order Parameters¶
Order parameters take bond order data and interpret it in some way to quantify the degree of order in a system. This is often done through computing spherical harmonics of the bond order diagram, which are the spherical analogue of Fourier Transforms.
Cubatic Order Parameter¶
-
class
freud.order.
CubaticOrderParameter
(t_initial, t_final, scale, n_replicates, seed)¶ Compute the cubatic order parameter [Cit1] for a system of particles using simulated annealing instead of Newton-Raphson root finding.
Module author: Eric Harper <harperic@umich.edu>
Parameters: -
compute
(self, orientations)¶ Calculates the per-particle and global order parameter.
Parameters: - box (
freud.box.Box
) – simulation box - orientations (
numpy.ndarray
, shape= \(\left(N_{particles}, 4 \right)\), dtype=numpy.float32
) – orientations to calculate the order parameter
- box (
-
get_cubatic_tensor
(self)¶ Returns: Rank 4 tensor corresponding to each individual particle orientation Return type: numpy.ndarray
, shape= \(\left(3, 3, 3, 3 \right)\), dtype=numpy.float32
-
get_gen_r4_tensor
(self)¶ Returns: Rank 4 tensor corresponding to each individual particle orientation Return type: numpy.ndarray
, shape= \(\left(3, 3, 3, 3 \right)\), dtype=numpy.float32
-
get_global_tensor
(self)¶ Returns: Rank 4 tensor corresponding to each individual particle orientation Return type: numpy.ndarray
, shape= \(\left(3, 3, 3, 3 \right)\), dtype=numpy.float32
-
get_orientation
(self)¶ Returns: orientation of global orientation Return type: numpy.ndarray
, shape= \(\left(4 \right)\), dtype=numpy.float32
-
get_particle_tensor
(self)¶ Returns: Rank 4 tensor corresponding to each individual particle orientation Return type: numpy.ndarray
, shape= \(\left(N_{particles}, 3, 3, 3, 3 \right)\), dtype=numpy.float32
-
Nematic Order Parameter¶
-
class
freud.order.
NematicOrderParameter
(u)¶ Compute the nematic order parameter for a system of particles.
Module author: Jens Glaser <jsglaser@umich.edu>
New in version 0.7.0.
Parameters: u ( numpy.ndarray
, shape= \(\left(3 \right)\), dtype=numpy.float32
) – The nematic director of a single particle in the reference state (without any rotation applied)-
compute
(self, orientations)¶ Calculates the per-particle and global order parameter.
Parameters: orientations ( numpy.ndarray
, shape= \(\left(N_{particles}, 4 \right)\), dtype=numpy.float32
) – orientations to calculate the order parameter
-
get_director
(self)¶ The director (eigenvector corresponding to the order parameter).
Returns: The average nematic director Return type: numpy.ndarray
, shape= \(\left(3 \right)\), dtype=numpy.float32
-
get_nematic_order_parameter
(self)¶ The nematic order parameter.
Returns: Nematic order parameter Return type: float
-
get_nematic_tensor
(self)¶ The nematic Q tensor.
Returns: 3x3 matrix corresponding to the average particle orientation Return type: numpy.ndarray
, shape= \(\left(3, 3 \right)\), dtype=numpy.float32
-
get_particle_tensor
(self)¶ The full per-particle tensor of orientation information.
Returns: 3x3 matrix corresponding to each individual particle orientation Return type: numpy.ndarray
, shape= \(\left(N_{particles}, 3, 3 \right)\), dtype=numpy.float32
-
Hexatic Order Parameter¶
-
class
freud.order.
HexOrderParameter
(rmax, k, n)¶ Calculates the \(k\)-atic order parameter for each particle in the system.
The \(k\)-atic order parameter for a particle \(i\) and its \(n\) neighbors \(j\) is given by:
\(\psi_k \left( i \right) = \frac{1}{n} \sum_j^n e^{k i \phi_{ij}}\)
The parameter \(k\) governs the symmetry of the order parameter while the parameter \(n\) governs the number of neighbors of particle \(i\) to average over. \(\phi_{ij}\) is the angle between the vector \(r_{ij}\) and \(\left( 1,0 \right)\)
Note
2D: This calculation is defined for 2D systems only. However, particle positions are still required to be passed in as
[x, y, 0]
.Module author: Eric Harper <harperic@umich.edu>
Parameters: - rmax (float) – +/- r distance to search for neighbors
- k (unsigned int) – symmetry of order parameter (\(k=6\) is hexatic)
- n (unsigned int) – number of neighbors (\(n=k\) if \(n\) not specified)
-
box
¶ Get the box used in the calculation.
-
compute
(self, box, points, nlist=None)¶ Calculates the correlation function and adds to the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3 \right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
getBox
(self)¶ Get the box used in the calculation.
Returns: freud Box Return type: freud.box.Box
-
getK
(self)¶ Get the symmetry of the order parameter.
Returns: \(k\) Return type: unsigned int
-
getNP
(self)¶ Get the number of particles.
Returns: \(N_{particles}\) Return type: unsigned int
-
getPsi
(self)¶ Get the order parameter.
Returns: order parameter Return type: numpy.ndarray
, shape= \(\left(N_{particles} \right)\), dtype=numpy.complex64
-
k
¶ Symmetry of the order parameter.
-
num_particles
¶ Get the number of particles.
-
psi
¶ Order parameter.
Local Descriptors¶
-
class
freud.order.
LocalDescriptors
(box, nNeigh, lmax, rmax)¶ Compute a set of descriptors (a numerical “fingerprint”) of a particle’s local environment.
The resulting spherical harmonic array will be a complex-valued array of shape (num_bonds, num_sphs). Spherical harmonic calculation can be restricted to some number of nearest neighbors through the num_neighbors argument; if a particle has more bonds than this number, the last one or more rows of bond spherical harmonics for each particle will not be set.
Module author: Matthew Spellings <mspells@umich.edu>
Parameters: - num_neighbors (unsigned int) – Maximum number of neighbors to compute descriptors for
- lmax (unsigned int) – Maximum spherical harmonic \(l\) to consider
- rmax (float) – Initial guess of the maximum radius to looks for neighbors
- negative_m (bool) – True if we should also calculate \(Y_{lm}\) for negative \(m\)
-
compute
(self, box, unsigned int num_neighbors, points_ref, points=None, orientations=None, mode='neighborhood', nlist=None)¶ Calculates the local descriptors of bonds from a set of source points to a set of destination points.
Parameters: - num_neighbors – Number of neighbors to compute with or to limit to, if the neighbor list is precomputed
- points_ref (
numpy.ndarray
, shape= \(\left(N_{particles}, 3 \right)\), dtype=numpy.float32
) – source points to calculate the order parameter - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3 \right)\), dtype=numpy.float32
) – destination points to calculate the order parameter - orientations (
numpy.ndarray
, shape= \(\left(N_{particles}, 4 \right)\), dtype=numpy.float32
or None) – Orientation of each reference point - mode (str) – Orientation mode to use for environments, either ‘neighborhood’ to use the orientation of the local neighborhood, ‘particle_local’ to use the given particle orientations, or ‘global’ to not rotate environments
- nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds or ‘precomputed’ if usingcomputeNList()
-
computeNList
(self, box, points_ref, points=None)¶ Compute the neighbor list for bonds from a set of source points to a set of destination points.
Parameters: - points_ref (
numpy.ndarray
, shape= \(\left(N_{particles}, 3 \right)\), dtype=numpy.float32
) – source points to calculate the order parameter - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3 \right)\), dtype=numpy.float32
) – destination points to calculate the order parameter
- points_ref (
-
getLMax
(self)¶ Get the maximum spherical harmonic \(l\) to calculate for.
Returns: \(l\) Return type: unsigned int
-
getNP
(self)¶ Get the number of particles.
Returns: \(N_{particles}\) Return type: unsigned int
-
getNSphs
(self)¶ Get the number of neighbors.
Returns: \(N_{neighbors}\) Return type: unsigned int
-
getSph
(self)¶ Get a reference to the last computed spherical harmonic array.
Returns: order parameter Return type: numpy.ndarray
, shape= \(\left(N_{bonds}, \text{SphWidth} \right)\), dtype=numpy.complex64
-
l_max
¶ Get the maximum spherical harmonic \(l\) to calculate for.
-
num_neighbors
¶ Get the number of neighbors.
-
num_particles
¶ Get the number of particles.
-
r_max
¶ Get the cutoff radius.
-
sph
¶ A reference to the last computed spherical harmonic array.
Translational Order Parameter¶
-
class
freud.order.
TransOrderParameter
(rmax, k, n)¶ Compute the translational order parameter for each particle.
Module author: Michael Engel <engelmm@umich.edu>
Parameters: -
box
¶ Get the box used in the calculation.
-
compute
(self, box, points, nlist=None)¶ Calculates the local descriptors.
Parameters: - box (
freud.box.Box
) – simulation box - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3 \right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
d_r
¶ Get a reference to the last computed spherical harmonic array.
-
getBox
(self)¶ Get the box used in the calculation.
Returns: freud Box Return type: freud.box.Box
-
getDr
(self)¶ Get a reference to the last computed spherical harmonic array.
Returns: order parameter Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.complex64
-
getNP
(self)¶ Get the number of particles.
Returns: \(N_{particles}\) Return type: unsigned int
-
num_particles
¶ Get the number of particles.
-
Local \(Q_l\)¶
-
class
freud.order.
LocalQl
(box, rmax, l, rmin)¶ LocalQl(box, rmax, l, rmin=0)
Compute the local Steinhardt rotationally invariant \(Q_l\) [Cit4] order parameter for a set of points.
Implements the local rotationally invariant \(Q_l\) order parameter described by Steinhardt. For a particle i, we calculate the average \(Q_l\) by summing the spherical harmonics between particle \(i\) and its neighbors \(j\) in a local region: \(\overline{Q}_{lm}(i) = \frac{1}{N_b} \displaystyle\sum_{j=1}^{N_b} Y_{lm}(\theta(\vec{r}_{ij}), \phi(\vec{r}_{ij}))\)
This is then combined in a rotationally invariant fashion to remove local orientational order as follows: \(Q_l(i)=\sqrt{\frac{4\pi}{2l+1} \displaystyle\sum_{m=-l}^{l} |\overline{Q}_{lm}|^2 }\)
For more details see PJ Steinhardt (1983) (DOI: 10.1103/PhysRevB.28.784)
Added first/second shell combined average \(Q_l\) order parameter for a set of points:
- Variation of the Steinhardt \(Q_l\) order parameter
- For a particle i, we calculate the average \(Q_l\) by summing the spherical harmonics between particle i and its neighbors j and the neighbors k of neighbor j in a local region
Module author: Xiyu Du <xiyudu@umich.edu>
Parameters: - box (
freud.box.Box
) – simulation box - rmax (float) – Cutoff radius for the local order parameter. Values near first minima of the RDF are recommended
- l (unsigned int) – Spherical harmonic quantum number l. Must be a positive number
- rmin (float) – can look at only the second shell or some arbitrary RDF region
-
Ql
¶ Get a reference to the last computed \(Q_l\) for each particle. Returns NaN instead of \(Q_l\) for particles with no neighbors.
-
ave_Ql
¶ Get a reference to the last computed \(Q_l\) for each particle. Returns NaN instead of \(Q_l\) for particles with no neighbors.
-
ave_norm_Ql
¶ Get a reference to the last computed \(Q_l\) for each particle. Returns NaN instead of \(Q_l\) for particles with no neighbors.
-
box
¶ Get the box used in the calculation.
-
compute
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3 \right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
computeAve
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3 \right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
computeAveNorm
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3 \right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
computeNorm
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3 \right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
getAveQl
(self)¶ Get a reference to the last computed \(Q_l\) for each particle. Returns NaN instead of \(Q_l\) for particles with no neighbors.
Returns: order parameter Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
-
getBox
(self)¶ Get the box used in the calculation.
Returns: freud Box Return type: freud.box.Box
-
getNP
(self)¶ Get the number of particles.
Returns: \(N_p\) Return type: unsigned int
-
getQl
(self)¶ Get a reference to the last computed \(Q_l\) for each particle. Returns NaN instead of \(Q_l\) for particles with no neighbors.
Returns: order parameter Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
-
getQlAveNorm
(self)¶ Get a reference to the last computed \(Q_l\) for each particle. Returns NaN instead of \(Q_l\) for particles with no neighbors.
Returns: order parameter Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
-
getQlNorm
(self)¶ Get a reference to the last computed \(Q_l\) for each particle. Returns NaN instead of \(Q_l\) for particles with no neighbors.
Returns: order parameter Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
-
norm_Ql
¶ Get a reference to the last computed \(Q_l\) for each particle. Returns NaN instead of \(Q_l\) for particles with no neighbors.
-
num_particles
¶ Get the number of particles.
-
setBox
(self, box)¶ Reset the simulation box.
Parameters: box ( freud.box.Box
) – simulation box
Nearest Neighbors Local \(Q_l\)¶
-
class
freud.order.
LocalQlNear
(box, rmax, l, kn)¶ LocalQlNear(box, rmax, l, kn=12)
Compute the local Steinhardt rotationally invariant \(Q_l\) order parameter [Cit4] for a set of points.
Implements the local rotationally invariant \(Q_l\) order parameter described by Steinhardt. For a particle i, we calculate the average \(Q_l\) by summing the spherical harmonics between particle \(i\) and its neighbors \(j\) in a local region: \(\overline{Q}_{lm}(i) = \frac{1}{N_b} \displaystyle\sum_{j=1}^{N_b} Y_{lm}(\theta(\vec{r}_{ij}), \phi(\vec{r}_{ij}))\)
This is then combined in a rotationally invariant fashion to remove local orientational order as follows: \(Q_l(i)=\sqrt{\frac{4\pi}{2l+1} \displaystyle\sum_{m=-l}^{l} |\overline{Q}_{lm}|^2 }\)
For more details see PJ Steinhardt (1983) (DOI: 10.1103/PhysRevB.28.784)
Added first/second shell combined average \(Q_l\) order parameter for a set of points:
- Variation of the Steinhardt \(Q_l\) order parameter
- For a particle i, we calculate the average \(Q_l\) by summing the spherical harmonics between particle i and its neighbors j and the neighbors k of neighbor j in a local region
Module author: Xiyu Du <xiyudu@umich.edu>
Parameters: - box (
freud.box.Box
) – simulation box - rmax (float) – Cutoff radius for the local order parameter. Values near first minima of the RDF are recommended
- l (unsigned int) – Spherical harmonic quantum number l. Must be a positive number
- kn (unsigned int) – number of nearest neighbors. must be a positive integer
-
compute
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
computeAve
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
computeAveNorm
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
computeNorm
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
Local \(W_l\)¶
-
class
freud.order.
LocalWl
(box, rmax, l)¶ LocalWl(box, rmax, l)
Compute the local Steinhardt rotationally invariant \(W_l\) order parameter [Cit4] for a set of points.
Implements the local rotationally invariant \(W_l\) order parameter described by Steinhardt that can aid in distinguishing between FCC, HCP, and BCC.
For more details see PJ Steinhardt (1983) (DOI: 10.1103/PhysRevB.28.784)
Added first/second shell combined average \(W_l\) order parameter for a set of points:
- Variation of the Steinhardt \(W_l\) order parameter
- For a particle i, we calculate the average \(W_l\) by summing the spherical harmonics between particle i and its neighbors j and the neighbors k of neighbor j in a local region
Module author: Xiyu Du <xiyudu@umich.edu>
Parameters: - box (
freud.box.Box
) – simulation box - rmax (float) – Cutoff radius for the local order parameter. Values near first minima of the RDF are recommended
- l (unsigned int) – Spherical harmonic quantum number l. Must be a positive number
-
Ql
¶ Get a reference to the last computed \(Q_l\) for each particle. Returns NaN instead of \(Q_l\) for particles with no neighbors.
-
Wl
¶ Get a reference to the last computed \(W_l\) for each particle. Returns NaN instead of \(W_l\) for particles with no neighbors.
-
ave_Wl
¶ Get a reference to the last computed \(W_l\) for each particle. Returns NaN instead of \(W_l\) for particles with no neighbors.
-
ave_norm_Wl
¶ Get a reference to the last computed \(W_l\) for each particle. Returns NaN instead of \(W_l\) for particles with no neighbors.
-
box
¶ Get the box used in the calculation.
-
compute
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
computeAve
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
computeAveNorm
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
computeNorm
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
getAveWl
(self)¶ Get a reference to the last computed \(W_l\) for each particle. Returns NaN instead of \(W_l\) for particles with no neighbors.
Returns: order parameter Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
-
getBox
(self)¶ Get the box used in the calculation.
Returns: freud Box Return type: freud.box.Box
-
getNP
(self)¶ Get the number of particles.
Returns: \(N_{particles}\) Return type: unsigned int
-
getQl
(self)¶ Get a reference to the last computed \(Q_l\) for each particle. Returns NaN instead of \(Q_l\) for particles with no neighbors.
Returns: order parameter Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
-
getWl
(self)¶ Get a reference to the last computed \(W_l\) for each particle. Returns NaN instead of \(W_l\) for particles with no neighbors.
Returns: order parameter Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.complex64
-
getWlAveNorm
(self)¶ Get a reference to the last computed \(W_l\) for each particle. Returns NaN instead of \(W_l\) for particles with no neighbors.
Returns: order parameter Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
-
getWlNorm
(self)¶ Get a reference to the last computed \(W_l\) for each particle. Returns NaN instead of \(W_l\) for particles with no neighbors.
Returns: order parameter Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
-
norm_Wl
¶ Get a reference to the last computed \(W_l\) for each particle. Returns NaN instead of \(W_l\) for particles with no neighbors.
-
num_particles
¶ Get the number of particles.
-
setBox
(self, box)¶ Reset the simulation box.
Parameters: box ( freud.box.Box
) – simulation box
Nearest Neighbors Local \(W_l\)¶
-
class
freud.order.
LocalWlNear
(box, rmax, l, kn)¶ LocalWlNear(box, rmax, l, kn=12)
Compute the local Steinhardt rotationally invariant \(W_l\) order parameter [Cit4] for a set of points.
Implements the local rotationally invariant \(W_l\) order parameter described by Steinhardt that can aid in distinguishing between FCC, HCP, and BCC.
For more details see PJ Steinhardt (1983) (DOI: 10.1103/PhysRevB.28.784)
Added first/second shell combined average \(W_l\) order parameter for a set of points:
- Variation of the Steinhardt \(W_l\) order parameter
- For a particle i, we calculate the average \(W_l\) by summing the spherical harmonics between particle i and its neighbors j and the neighbors k of neighbor j in a local region
Module author: Xiyu Du <xiyudu@umich.edu>
Parameters: - box (
freud.box.Box
) – simulation box - rmax (float) – Cutoff radius for the local order parameter. Values near first minima of the RDF are recommended
- l (unsigned int) – Spherical harmonic quantum number l. Must be a positive number
- kn (unsigned int) – Number of nearest neighbors. Must be a positive number
-
compute
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
computeAve
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
computeAveNorm
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
computeNorm
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
Solid-Liquid Order Parameter¶
-
class
freud.order.
SolLiq
(box, rmax, Qthreshold, Sthreshold, l)¶ SolLiq(box, rmax, Qthreshold, Sthreshold, l)
Computes dot products of \(Q_{lm}\) between particles and uses these for clustering.
Module author: Richmond Newman <newmanrs@umich.edu>
Parameters: - box (
freud.box.Box
) – simulation box - rmax (float) – Cutoff radius for the local order parameter. Values near first minima of the RDF are recommended
- Qthreshold (float) – Value of dot product threshold when evaluating \(Q_{lm}^*(i) Q_{lm}(j)\) to determine if a neighbor pair is a solid-like bond. (For \(l=6\), 0.7 generally good for FCC or BCC structures)
- Sthreshold (unsigned int) – Minimum required number of adjacent solid-link bonds for a particle to be considered solid-like for clustering. (For \(l=6\), 6-8 generally good for FCC or BCC structures)
- l (unsigned int) – Choose spherical harmonic \(Q_l\). Must be positive and even.
-
Ql_dot_ij
¶ Get a reference to the number of connections per particle.
-
Ql_mi
¶ Get a reference to the last computed \(Q_{lmi}\) for each particle.
-
box
¶ Get the box used in the calculation.
-
cluster_sizes
¶ Return the sizes of all clusters.
-
clusters
¶ Get a reference to the last computed set of solid-like cluster indices for each particle.
-
compute
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
computeSolLiqNoNorm
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
computeSolLiqVariant
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
getBox
(self)¶ Get the box used in the calculation.
Returns: freud Box Return type: freud.box.Box
-
getClusterSizes
(self)¶ Return the sizes of all clusters.
Returns: largest cluster size Return type: numpy.ndarray
, shape= \(\left(N_{clusters}\right)\), dtype=numpy.uint32
-
getClusters
(self)¶ Get a reference to the last computed set of solid-like cluster indices for each particle.
Returns: clusters Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.uint32
-
getLargestClusterSize
(self)¶ Returns the largest cluster size. Must call a compute method first.
Returns: largest cluster size Return type: unsigned int
-
getNP
(self)¶ Get the number of particles.
Returns: np Return type: unsigned int
-
getNumberOfConnections
(self)¶ Get a reference to the number of connections per particle.
Returns: clusters Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.uint32
-
getQldot_ij
(self)¶ Get a reference to the qldot_ij values.
Returns: largest cluster size Return type: numpy.ndarray
, shape= \(\left(N_{clusters}\right)\), dtype=numpy.complex64
-
getQlmi
(self)¶ Get a reference to the last computed \(Q_{lmi}\) for each particle.
Returns: order parameter Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.complex64
-
largest_cluster_size
¶ Returns the largest cluster size. Must call a compute method first.
-
num_connections
¶ Get a reference to the number of connections per particle.
-
num_particles
¶ Get the number of particles.
-
setBox
(self, box)¶ Reset the simulation box.
Parameters: box ( freud.box.Box
) – simulation box
- box (
Nearest Neighbors Solid-Liquid Order Parameter¶
-
class
freud.order.
SolLiqNear
(box, rmax, Qthreshold, Sthreshold, l)¶ SolLiqNear(box, rmax, Qthreshold, Sthreshold, l, kn=12)
Computes dot products of \(Q_{lm}\) between particles and uses these for clustering.
Module author: Richmond Newman <newmanrs@umich.edu>
Parameters: - box (
freud.box.Box
) – simulation box - rmax (float) – Cutoff radius for the local order parameter. Values near first minima of the RDF are recommended
- Qthreshold (float) – Value of dot product threshold when evaluating \(Q_{lm}^*(i) Q_{lm}(j)\) to determine if a neighbor pair is a solid-like bond. (For \(l=6\), 0.7 generally good for FCC or BCC structures)
- Sthreshold (unsigned int) – Minimum required number of adjacent solid-link bonds for a particle to be considered solid-like for clustering. (For \(l=6\), 6-8 generally good for FCC or BCC structures)
- l (unsigned int) – Choose spherical harmonic \(Q_l\). Must be positive and even.
- kn (unsigned int) – Number of nearest neighbors. Must be a positive number
-
compute
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
computeSolLiqNoNorm
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
computeSolLiqVariant
(self, points, nlist=None)¶ Compute the local rotationally invariant \(Q_l\) order parameter.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the order parameter - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
- box (
Environment Matching¶
-
class
freud.order.
MatchEnv
(box, rmax, k)¶ Clusters particles according to whether their local environments match or not, according to various shape matching metrics.
Module author: Erin Teich <erteich@umich.edu>
Parameters: - box (
freud.box.Box
) – Simulation box - rmax (float) – Cutoff radius for cell list and clustering algorithm. Values near first minimum of the RDF are recommended.
- k (unsigned int) – Number of nearest neighbors taken to define the local environment of any given particle.
-
cluster
(self, points, threshold, hard_r=False, registration=False, global_search=False, env_nlist=None, nlist=None)¶ Determine clusters of particles with matching environments.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – particle positions - threshold (float) – maximum magnitude of the vector difference between two vectors, below which they are “matching”
- hard_r (bool) – If True, add all particles that fall within the threshold of m_rmaxsq to the environment
- registration (bool) – If True, first use brute force registration to orient one set of environment vectors with respect to the other set such that it minimizes the RMSD between the two sets.
- global_search (bool) – If True, do an exhaustive search wherein the environments of every single pair of particles in the simulation are compared. If False, only compare the environments of neighboring particles.
- nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find neighbors of every particle, to compare environments - env_nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find the environment of every particle
- points (
-
getClusters
(self)¶ Get a reference to the particles, indexed into clusters according to their matching local environments
Returns: clusters Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.uint32
-
getEnvironment
(self, i)¶ Returns the set of vectors defining the environment indexed by i.
Parameters: i (unsigned int) – environment index Returns: the array of vectors Return type: numpy.ndarray
, shape= \(\left(N_{neighbors}, 3\right)\), dtype=numpy.float32
-
getNP
(self)¶ Get the number of particles.
Returns: \(N_{particles}\) Return type: unsigned int
-
getNumClusters
(self)¶ Get the number of clusters.
Returns: \(N_{clusters}\) Return type: unsigned int
-
getTotEnvironment
(self)¶ Returns the entire m_Np by m_maxk by 3 matrix of all environments for all particles.
Returns: the array of vectors Return type: numpy.ndarray
, shape= \(\left(N_{particles}, N_{neighbors}, 3\right)\), dtype=numpy.float32
-
isSimilar
(self, refPoints1, refPoints2, threshold, registration=False)¶ Test if the motif provided by refPoints1 is similar to the motif provided by refPoints2.
Parameters: - refPoints1 (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – vectors that make up motif 1 - refPoints2 (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – vectors that make up motif 2 - threshold (float) – maximum magnitude of the vector difference between two vectors, below which they are considered “matching”
- registration (bool) – If true, first use brute force registration to orient one set of environment vectors with respect to the other set such that it minimizes the RMSD between the two sets.
Returns: a doublet that gives the rotated (or not) set of refPoints2, and the mapping between the vectors of refPoints1 and refPoints2 that will make them correspond to each other. empty if they do not correspond to each other.
Return type: tuple[(
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
), map[int, int]]- refPoints1 (
-
matchMotif
(self, points, refPoints, threshold, registration=False, nlist=None)¶ Determine clusters of particles that match the motif provided by refPoints.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – particle positions - refPoints (
numpy.ndarray
, shape= \(\left(N_{neighbors}, 3\right)\), dtype=numpy.float32
) – vectors that make up the motif against which we are matching - threshold (float) – maximum magnitude of the vector difference between two vectors, below which they are considered “matching”
- registration (bool) – If true, first use brute force registration to orient one set of environment vectors with respect to the other set such that it minimizes the RMSD between the two sets.
- nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- points (
-
minRMSDMotif
(self, points, refPoints, registration=False, nlist=None)¶ Rotate (if registration=True) and permute the environments of all particles to minimize their RMSD wrt the motif provided by refPoints.
Parameters: - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – particle positions - refPoints (
numpy.ndarray
, shape= \(\left(N_{neighbors}, 3\right)\), dtype=numpy.float32
) – vectors that make up the motif against which we are matching - registration (bool) – If true, first use brute force registration to orient one set of environment vectors with respect to the other set such that it minimizes the RMSD between the two sets.
- nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
Returns: vector of minimal RMSD values, one value per particle.
Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
- points (
-
minimizeRMSD
(self, refPoints1, refPoints2, registration=False)¶ Get the somewhat-optimal RMSD between the set of vectors refPoints1 and the set of vectors refPoints2.
Parameters: - refPoints1 (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – vectors that make up motif 1 - refPoints2 (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – vectors that make up motif 2 - registration (bool) – if true, first use brute force registration to orient one set of environment vectors with respect to the other set such that it minimizes the RMSD between the two sets
Returns: a triplet that gives the associated min_rmsd, rotated (or not) set of refPoints2, and the mapping between the vectors of refPoints1 and refPoints2 that somewhat minimizes the RMSD.
Return type: tuple[float, (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
), map[int, int]]- refPoints1 (
-
num_clusters
¶ Get the number of clusters.
-
num_particles
¶ Get the number of particles.
-
setBox
(self, box)¶ Reset the simulation box.
Parameters: box ( freud.box.Box
) – simulation box
-
tot_environment
¶ Returns the entire m_Np by m_maxk by 3 matrix of all environments for all particles.
- box (
Pairing¶
Note
This module is deprecated and is replaced with Bond Module.
-
class
freud.order.
Pairing2D
(rmax, k, compDotTol)¶ Compute pairs for the system of particles.
Module author: Eric Harper <harperic@umich.edu>
Parameters: -
box
¶ Get the box used in the calculation.
-
compute
(self, box, points, orientations, compOrientations, nlist=None)¶ Calculates the correlation function and adds to the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – reference points to calculate the local density - orientations (
numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
) – orientations to use in computation - compOrientations (
numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
) – possible orientations to check for bonds - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
getBox
(self)¶ Get the box used in the calculation.
Returns: freud Box Return type: freud.box.Box
-
getMatch
(self)¶ Get the match.
Returns: match Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.uint32
-
getPair
(self)¶ Get the pair.
Returns: pair Return type: numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.uint32
-
match
¶ Match.
-
pair
¶ Pair.
-
Parallel Module¶
The freud.parallel
module tries to use all available threads for
parallelization unless directed otherwise, with one exception. On the flux
and nyx clusters, freud will only use one thread unless directed otherwise.
-
parallel.
setNumThreads
(nthreads=None)¶ Set the number of threads for parallel computation.
Module author: Joshua Anderson <joaander@umich.edu>
Parameters: nthreads (int or None) – number of threads to use. If None (default), use all threads available
-
class
freud.parallel.
NumThreads
(N=None)[source]¶ Context manager for managing the number of threads to use.
Module author: Joshua Anderson <joaander@umich.edu>
Parameters: N (int or None) – Number of threads to use in this context. Defaults to None
, which will use all available threads.
PMFT Module¶
The PMFT Module allows for the calculation of the Potential of Mean Force and Torque (PMFT) [Cit2] [Cit3] in a number of different coordinate systems.
Note
The coordinate system in which the calculation is performed is not the same as the coordinate system in which particle positions and orientations should be supplied. Only certain coordinate systems are available for certain particle positions and orientations:
- 2D particle coordinates (position: [x, y, 0], orientation: \(\theta\)):
- \(X\), \(Y\)
- \(X\), \(Y\), \(\theta_2\)
- \(R\), \(\theta_1\), \(\theta_2\)
- 3D particle coordinates: \(X\), \(Y\), \(Z\)
Coordinate System: \(x\), \(y\), \(\theta_2\)¶
-
class
freud.pmft.
PMFTXYT
(x_max, y_max, n_x, n_y, n_t)¶ Computes the PMFT [Cit2] [Cit3] for a given set of points.
A given set of reference points is given around which the PCF is computed and averaged in a sea of data points. Computing the PCF results in a PCF array listing the value of the PCF at each given \(x\), \(y\), \(\theta\) listed in the x, y, and t arrays.
The values of x, y, t to compute the PCF at are controlled by x_max, y_max and n_bins_x, n_bins_y, n_bins_t parameters to the constructor. x_max, y_max determine the minimum/maximum x, y values (\(\min \left( \theta \right) = 0\), (\(\max \left( \theta \right) = 2\pi\)) at which to compute the PCF and n_bins_x, n_bins_y, n_bins_t is the number of bins in x, y, t.
Note
2D:
freud.pmft.PMFTXYT
is only defined for 2D systems. The points must be passed in as[x, y, 0]
. Failing to set z=0 will lead to undefined behavior.Module author: Eric Harper <harperic@umich.edu>
Parameters: -
PCF
¶ Get the positional correlation function.
-
PMFT
¶ Get the potential of mean force and torque.
-
T
¶ Get the array of t-values for the PCF histogram.
-
X
¶ Get the array of x-values for the PCF histogram.
-
Y
¶ Get the array of y-values for the PCF histogram.
-
accumulate
(self, box, ref_points, ref_orientations, points, orientations, nlist=None)¶ Calculates the positional correlation function and adds to the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – reference points to calculate the local density - ref_orientations (
numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
) – angles of reference points to use in calculation - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the local density - orientations (
numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
) – angles of particles to use in calculation - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
bin_counts
¶ Get the raw bin counts.
-
box
¶ Get the box used in the calculation.
-
compute
(self, box, ref_points, ref_orientations, points, orientations, nlist=None)¶ Calculates the positional correlation function for the given points. Will overwrite the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – reference points to calculate the local density - ref_orientations (
numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
) – angles of reference points to use in calculation - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the local density - orientations (
numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
) – angles of particles to use in calculation - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
getBinCounts
(self)¶ Get the raw bin counts.
Returns: Bin Counts Return type: numpy.ndarray
, shape= \(\left(N_{\theta}, N_{y}, N_{x}\right)\), dtype=numpy.uint32
-
getBox
(self)¶ Get the box used in the calculation.
Returns: freud Box Return type: freud.box.Box
-
getNBinsT
(self)¶ Get the number of bins in the t-dimension of histogram.
Returns: \(N_{\theta}\) Return type: unsigned int
-
getNBinsX
(self)¶ Get the number of bins in the x-dimension of histogram.
Returns: \(N_x\) Return type: unsigned int
-
getNBinsY
(self)¶ Get the number of bins in the y-dimension of histogram.
Returns: \(N_y\) Return type: unsigned int
-
getPCF
(self)¶ Get the positional correlation function.
Returns: PCF Return type: numpy.ndarray
, shape= \(\left(N_{\theta}, N_{y}, N_{x}\right)\), dtype=numpy.float32
-
getPMFT
(self)¶ Get the potential of mean force and torque.
Returns: PMFT Return type: numpy.ndarray
, shape= (matches PCF), dtype=numpy.float32
-
getT
(self)¶ Get the array of t-values for the PCF histogram.
Returns: bin centers of t-dimension of histogram Return type: numpy.ndarray
, shape= \(\left(N_{\theta}\right)\), dtype=numpy.float32
-
getX
(self)¶ Get the array of x-values for the PCF histogram.
Returns: bin centers of x-dimension of histogram Return type: numpy.ndarray
, shape= \(\left(N_{x}\right)\), dtype=numpy.float32
-
getY
(self)¶ Get the array of y-values for the PCF histogram.
Returns: bin centers of y-dimension of histogram Return type: numpy.ndarray
, shape= \(\left(N_{y}\right)\), dtype=numpy.float32
-
jacobian
¶ Get the Jacobian used in the PMFT.
-
n_bins_T
¶ Get the number of bins in the T-dimension of histogram.
-
n_bins_X
¶ Get the number of bins in the x-dimension of histogram.
-
n_bins_Y
¶ Get the number of bins in the y-dimension of histogram.
-
r_cut
¶ Get the r_cut value used in the cell list.
-
reducePCF
(self)¶ Reduces the histogram in the values over N processors to a single histogram. This is called automatically by
freud.pmft.PMFT.PCF()
.
-
resetPCF
(self)¶ Resets the values of the PCF histograms in memory.
-
Coordinate System: \(x\), \(y\)¶
-
class
freud.pmft.
PMFTXY2D
(x_max, y_max, n_x, n_y)¶ Computes the PMFT [Cit2] [Cit3] for a given set of points.
A given set of reference points is given around which the PCF is computed and averaged in a sea of data points. Computing the PCF results in a PCF array listing the value of the PCF at each given \(x\), \(y\) listed in the x and y arrays.
The values of x and y to compute the PCF at are controlled by x_max, y_max, n_x, and n_y parameters to the constructor. x_max and y_max determine the minimum/maximum distance at which to compute the PCF and n_x and n_y are the number of bins in x and y.
Note
2D:
freud.pmft.PMFTXY2D
is only defined for 2D systems. The points must be passed in as[x, y, 0]
. Failing to set z=0 will lead to undefined behavior.Module author: Eric Harper <harperic@umich.edu>
Parameters: -
PCF
¶ Get the positional correlation function.
-
PMFT
¶ Get the potential of mean force and torque.
-
X
¶ Get the array of x-values for the PCF histogram.
-
Y
¶ Get the array of y-values for the PCF histogram.
-
accumulate
(self, box, ref_points, ref_orientations, points, orientations, nlist=None)¶ Calculates the positional correlation function and adds to the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – reference points to calculate the local density - ref_orientations (
numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
) – orientations of reference points to use in calculation - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the local density - orientations (
numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
) – orientations of particles to use in calculation - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
bin_counts
¶ Get the raw bin counts.
-
box
¶ Get the box used in the calculation.
-
compute
(self, box, ref_points, ref_orientations, points, orientations, nlist=None)¶ Calculates the positional correlation function for the given points. Will overwrite the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – reference points to calculate the local density - ref_orientations (
numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
) – orientations of reference points to use in calculation - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the local density - orientations (
numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
) – orientations of particles to use in calculation - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
getBinCounts
(self)¶ Get the raw bin counts (non-normalized).
Returns: Bin Counts Return type: numpy.ndarray
, shape= \(\left(N_{y}, N_{x}\right)\), dtype=numpy.uint32
-
getBox
(self)¶ Get the box used in the calculation.
Returns: freud Box Return type: freud.box.Box
-
getNBinsX
(self)¶ Get the number of bins in the x-dimension of histogram.
Returns: \(N_x\) Return type: unsigned int
-
getNBinsY
(self)¶ Get the number of bins in the y-dimension of histogram.
Returns: \(N_y\) Return type: unsigned int
-
getPCF
(self)¶ Get the positional correlation function.
Returns: PCF Return type: numpy.ndarray
, shape= \(\left(N_{y}, N_{x}\right)\), dtype=numpy.float32
-
getPMFT
(self)¶ Get the potential of mean force and torque.
Returns: PMFT Return type: numpy.ndarray
, shape= (matches PCF), dtype=numpy.float32
-
getX
(self)¶ Get the array of x-values for the PCF histogram.
Returns: bin centers of x-dimension of histogram Return type: numpy.ndarray
, shape= \(\left(N_{x}\right)\), dtype=numpy.float32
-
getY
(self)¶ Get the array of y-values for the PCF histogram.
Returns: bin centers of y-dimension of histogram Return type: numpy.ndarray
, shape= \(\left(N_{y}\right)\), dtype=numpy.float32
-
jacobian
¶ Get the Jacobian used in the PMFT.
-
n_bins_X
¶ Get the number of bins in the x-dimension of histogram.
-
n_bins_Y
¶ Get the number of bins in the y-dimension of histogram.
-
r_cut
¶ Get the r_cut value used in the cell list.
-
reducePCF
(self)¶ Reduces the histogram in the values over N processors to a single histogram. This is called automatically by
freud.pmft.PMFT.PCF()
.
-
resetPCF
(self)¶ Resets the values of the PCF histograms in memory.
-
Coordinate System: \(r\), \(\theta_1\), \(\theta_2\)¶
-
class
freud.pmft.
PMFTR12
(r_max, n_r, n_t1, n_t2)¶ Computes the PMFT [Cit2] [Cit3] for a given set of points.
A given set of reference points is given around which the PCF is computed and averaged in a sea of data points. Computing the PCF results in a PCF array listing the value of the PCF at each given \(r\), \(\theta_1\), \(\theta_2\) listed in the r, t1, and t2 arrays.
The values of r, t1, t2 to compute the PCF at are controlled by r_max and nbins_r, nbins_t1, nbins_t2 parameters to the constructor. rmax determines the minimum/maximum r (\(\min \left( \theta_1 \right) = \min \left( \theta_2 \right) = 0\), (\(\max \left( \theta_1 \right) = \max \left( \theta_2 \right) = 2\pi\)) at which to compute the PCF and nbins_r, nbins_t1, nbins_t2 is the number of bins in r, t1, t2.
Note
2D:
freud.pmft.PMFTR12
is only defined for 2D systems. The points must be passed in as[x, y, 0]
. Failing to set z=0 will lead to undefined behavior.Module author: Eric Harper <harperic@umich.edu>
Parameters: - r_max (float) – maximum distance at which to compute the PMFT
- n_r (unsigned int) – number of bins in r
- n_t1 (unsigned int) – number of bins in t1
- n_t2 (unsigned int) – number of bins in t2
-
PCF
¶ Get the positional correlation function.
-
PMFT
¶ Get the potential of mean force and torque.
-
R
¶ Get the array of r-values for the PCF histogram.
Returns: bin centers of r-dimension of histogram Return type: numpy.ndarray
, shape= \(\left(N_{r}\right)\), dtype=numpy.float32
-
T1
¶ Get the array of T1-values for the PCF histogram.
-
T2
¶ Get the array of T2-values for the PCF histogram.
Returns: bin centers of T2-dimension of histogram Return type: numpy.ndarray
, shape= \(\left(N_{\theta2}\right)\), dtype=numpy.float32
-
accumulate
(self, box, ref_points, ref_orientations, points, orientations, nlist=None)¶ Calculates the positional correlation function and adds to the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – reference points to calculate the local density - ref_orientations (
numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
) – angles of reference points to use in calculation - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the local density - orientations (
numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
) – angles of particles to use in calculation - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
bin_counts
¶ Get the raw bin counts.
-
box
¶ Get the box used in the calculation.
-
compute
(self, box, ref_points, ref_orientations, points, orientations, nlist=None)¶ Calculates the positional correlation function for the given points. Will overwrite the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – reference points to calculate the local density - ref_orientations (
numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
) – angles of reference points to use in calculation - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the local density - orientations (
numpy.ndarray
, shape= \(\left(N_{particles}\right)\), dtype=numpy.float32
) – angles of particles to use in calculation - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
getBinCounts
(self)¶ Get the raw bin counts.
Returns: Bin Counts Return type: numpy.ndarray
, shape= \(\left(N_{r}, N_{\theta2}, N_{\theta1}\right)\), dtype=numpy.uint32
-
getBox
(self)¶ Get the box used in the calculation.
Returns: freud Box Return type: freud.box.Box
-
getInverseJacobian
(self)¶ Get the inverse Jacobian used in the PMFT.
Returns: Inverse Jacobian Return type: numpy.ndarray
, shape= \(\left(N_{r}, N_{\theta2}, N_{\theta1}\right)\), dtype=numpy.float32
-
getNBinsR
(self)¶ Get the number of bins in the r-dimension of histogram.
Returns: \(N_r\) Return type: unsigned int
-
getNBinsT1
(self)¶ Get the number of bins in the T1-dimension of histogram.
Returns: \(N_{\theta_1}\) Return type: unsigned int
-
getNBinsT2
(self)¶ Get the number of bins in the T2-dimension of histogram.
Returns: \(N_{\theta_2}\) Return type: unsigned int
-
getPCF
(self)¶ Get the positional correlation function.
Returns: PCF Return type: numpy.ndarray
, shape= \(\left(N_{r}, N_{\theta2}, N_{\theta1}\right)\), dtype=numpy.float32
-
getPMFT
(self)¶ Get the potential of mean force and torque.
Returns: PMFT Return type: numpy.ndarray
, shape= (matches PCF), dtype=numpy.float32
-
getR
(self)¶ Get the array of r-values for the PCF histogram.
Returns: bin centers of r-dimension of histogram Return type: numpy.ndarray
, shape= \(\left(N_{r}\right)\), dtype=numpy.float32
-
getT1
(self)¶ Get the array of T1-values for the PCF histogram.
Returns: bin centers of T1-dimension of histogram Return type: numpy.ndarray
, shape= \(\left(N_{\theta1}\right)\), dtype=numpy.float32
-
getT2
(self)¶ Get the array of T2-values for the PCF histogram.
Returns: bin centers of T2-dimension of histogram Return type: numpy.ndarray
, shape= \(\left(N_{\theta2}\right)\), dtype=numpy.float32
-
inverse_jacobian
¶ Get the inverse Jacobian used in the PMFT.
-
n_bins_T1
¶ Get the number of bins in the T1-dimension of histogram.
-
n_bins_T2
¶ Get the number of bins in the T2-dimension of histogram.
-
n_bins_r
¶ Get the number of bins in the r-dimension of histogram.
-
r_cut
¶ Get the r_cut value used in the cell list.
-
reducePCF
(self)¶ Reduces the histogram in the values over N processors to a single histogram. This is called automatically by
freud.pmft.PMFT.PCF()
.
-
resetPCF
(self)¶ Resets the values of the PCF histograms in memory.
Coordinate System: \(x\), \(y\), \(z\)¶
-
class
freud.pmft.
PMFTXYZ
(x_max, y_max, z_max, n_x, n_y, n_z)¶ Computes the PMFT [Cit2] [Cit3] for a given set of points.
A given set of reference points is given around which the PCF is computed and averaged in a sea of data points. Computing the PCF results in a PCF array listing the value of the PCF at each given \(x\), \(y\), \(z\), listed in the x, y, and z arrays.
The values of x, y, z to compute the PCF at are controlled by x_max, y_max, z_max, n_x, n_y, and n_z parameters to the constructor. x_max, y_max, and z_max determine the minimum/maximum distance at which to compute the PCF and n_x, n_y, n_z is the number of bins in x, y, z.
Note
3D:
freud.pmft.PMFTXYZ
is only defined for 3D systems. The points must be passed in as[x, y, z]
.Module author: Eric Harper <harperic@umich.edu>
Parameters: - x_max (float) – maximum x distance at which to compute the PMFT
- y_max (float) – maximum y distance at which to compute the PMFT
- z_max (float) – maximum z distance at which to compute the PMFT
- n_x (unsigned int) – number of bins in x
- n_y (unsigned int) – number of bins in y
- n_z (unsigned int) – number of bins in z
- shiftvec (list) – vector pointing from [0,0,0] to the center of the PMFT
-
PCF
¶ Get the positional correlation function.
-
PMFT
¶ Get the potential of mean force and torque.
-
X
¶ Get the array of x-values for the PCF histogram.
-
Y
¶ Get the array of y-values for the PCF histogram.
-
Z
¶ Get the array of z-values for the PCF histogram.
-
accumulate
(self, box, ref_points, ref_orientations, points, orientations, face_orientations=None, nlist=None)¶ Calculates the positional correlation function and adds to the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – reference points to calculate the local density - ref_orientations (
numpy.ndarray
, shape= \(\left(N_{particles}, 4\right)\), dtype=numpy.float32
) – orientations of reference points to use in calculation - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the local density - orientations (
numpy.ndarray
, shape= \(\left(N_{particles}, 4\right)\), dtype=numpy.float32
) – orientations of particles to use in calculation - face_orientations (
numpy.ndarray
, shape= \(\left( \left(N_{particles}, \right), N_{faces}, 4\right)\), dtype=numpy.float32
) – Optional - orientations of particle faces to account for particle symmetry. If not supplied by user, unit quaternions will be supplied. If a 2D array of shape (\(N_f\), \(4\)) or a 3D array of shape (1, \(N_f\), \(4\)) is supplied, the supplied quaternions will be broadcast for all particles.
- box (
-
bin_counts
¶ Get the raw bin counts.
-
box
¶ Get the box used in the calculation.
-
compute
(self, box, ref_points, ref_orientations, points, orientations, face_orientations, nlist=None)¶ Calculates the positional correlation function for the given points. Will overwrite the current histogram.
Parameters: - box (
freud.box.Box
) – simulation box - ref_points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – reference points to calculate the local density - ref_orientations (
numpy.ndarray
, shape= \(\left(N_{particles}, 4\right)\), dtype=numpy.float32
) – orientations of reference points to use in calculation - points (
numpy.ndarray
, shape= \(\left(N_{particles}, 3\right)\), dtype=numpy.float32
) – points to calculate the local density - orientations (
numpy.ndarray
, shape= \(\left(N_{particles}, 4\right)\), dtype=numpy.float32
) – orientations of particles to use in calculation - face_orientations (
numpy.ndarray
, shape= \(\left( \left(N_{particles}, \right), N_{faces}, 4\right)\), dtype=numpy.float32
) – orientations of particle faces to account for particle symmetry - nlist (
freud.locality.NeighborList
) –freud.locality.NeighborList
object to use to find bonds
- box (
-
getBinCounts
(self)¶ Get the raw bin counts.
Returns: Bin Counts Return type: numpy.ndarray
, shape= \(\left(N_{z}, N_{y}, N_{x}\right)\), dtype=numpy.uint32
-
getBox
(self)¶ Get the box used in the calculation.
Returns: freud Box Return type: freud.box.Box
-
getNBinsX
(self)¶ Get the number of bins in the x-dimension of histogram.
Returns: \(N_x\) Return type: unsigned int
-
getNBinsY
(self)¶ Get the number of bins in the y-dimension of histogram.
Returns: \(N_y\) Return type: unsigned int
-
getNBinsZ
(self)¶ Get the number of bins in the z-dimension of histogram.
Returns: \(N_z\) Return type: unsigned int
-
getPCF
(self)¶ Get the positional correlation function.
Returns: PCF Return type: numpy.ndarray
, shape= \(\left(N_{z}, N_{y}, N_{x}\right)\), dtype=numpy.float32
-
getPMFT
(self)¶ Get the potential of mean force and torque.
Returns: PMFT Return type: numpy.ndarray
, shape= \(\left(N_{z}, N_{y}, N_{x}\right)\), dtype=numpy.float32
-
getX
(self)¶ Get the array of x-values for the PCF histogram.
Returns: bin centers of x-dimension of histogram Return type: numpy.ndarray
, shape= \(\left(N_{x}\right)\), dtype=numpy.float32
-
getY
(self)¶ Get the array of y-values for the PCF histogram.
Returns: bin centers of y-dimension of histogram Return type: numpy.ndarray
, shape= \(\left(N_{y}\right)\), dtype=numpy.float32
-
getZ
(self)¶ Get the array of z-values for the PCF histogram.
Returns: bin centers of z-dimension of histogram Return type: numpy.ndarray
, shape= \(\left(N_{z}\right)\), dtype=numpy.float32
-
jacobian
¶ Get the Jacobian used in the PMFT.
-
n_bins_X
¶ Get the number of bins in the x-dimension of histogram.
-
n_bins_Y
¶ Get the number of bins in the y-dimension of histogram.
-
n_bins_Z
¶ Get the number of bins in the z-dimension of histogram.
-
r_cut
¶ Get the r_cut value used in the cell list.
-
reducePCF
(self)¶ Reduces the histogram in the values over N processors to a single histogram. This is called automatically by
freud.pmft.PMFTXYZ.PCF()
.
-
resetPCF
(self)¶ Resets the values of the PCF histograms in memory.
Voronoi Module¶
-
class
freud.voronoi.
Voronoi
(box, buff=0.1)[source]¶ Compute the Voronoi tessellation of a 2D or 3D system using qhull. This uses
scipy.spatial.Voronoi
, accounting for periodic boundary conditions.Module author: Benjamin Schultz <baschult@umich.edu>
Module author: Yina Geng <yinageng@umich.edu>
Module author: Mayank Agrawal <amayank@umich.edu>
Module author: Bradley Dice <bdice@bradleydice.com>
Since qhull does not support periodic boundary conditions natively, we expand the box to include a portion of the particles’ periodic images. The buffer width is given by the parameter
buff
. The computation of Voronoi tessellations and neighbors is only guaranteed to be correct ifbuff >= L/2
whereL
is the longest side of the simulation box. For dense systems with particles filling the entire simulation volume, a smaller value forbuff
is acceptable.-
compute
(positions, box=None, buff=None)[source]¶ Compute Voronoi diagram.
Parameters: - box (
freud.box.Box
) – simulation box - buff (float) – buffer width
- box (
-
computeNeighbors
(positions, box=None, buff=None, exclude_ii=True)[source]¶ Compute the neighbors of each particle based on the Voronoi tessellation. One can include neighbors from multiple Voronoi shells by specifying
numShells
ingetNeighbors()
. An example of computing neighbors from the first two Voronoi shells for a 2D mesh is shown below.Retrieve the results with
getNeighbors()
.Example:
from freud import box, voronoi import numpy as np vor = voronoi.Voronoi(box.Box(5, 5, is2D=True)) pos = np.array([[0, 0, 0], [0, 1, 0], [0, 2, 0], [1, 0, 0], [1, 1, 0], [1, 2, 0], [2, 0, 0], [2, 1, 0], [2, 2, 0]], dtype=np.float32) first_shell = vor.computeNeighbors(pos).getNeighbors(1) second_shell = vor.computeNeighbors(pos).getNeighbors(2) print('First shell:', first_shell) print('Second shell:', second_shell)
Note
Input positions must be a 3D array. For 2D, set the z value to 0.
-
computeVolumes
()[source]¶ Computes volumes (areas in 2D) of Voronoi cells.
New in version 0.8.
Must call
compute()
before this method.Retrieve the results with
getVolumes()
.
-
getNeighborList
()[source]¶ Returns a neighbor list object.
In the neighbor list, each neighbor pair has a weight value.
In 2D systems, the bond weight is the “ridge length” of the Voronoi boundary line between the neighboring particles.
In 3D systems, the bond weight is the “ridge area” of the Voronoi boundary polygon between the neighboring particles.
Returns: Neighbor list Return type: NeighborList
-
getNeighbors
(numShells)[source]¶ Get
numShells
of neighbors for each particleMust call
computeNeighbors()
before this method.Parameters: numShells (int) – number of neighbor shells
-
getVolumes
()[source]¶ Returns an array of volumes (areas in 2D) corresponding to Voronoi cells.
New in version 0.8.
Must call
computeVolumes()
before this method.If the buffer width is too small, then some polytopes may not be closed (they may have a boundary at infinity), and these polytopes’ volumes/areas are excluded from the list.
The length of the list returned by this method should be the same as the array of positions used in the
compute()
method, if all the polytopes are closed. Otherwise try using a larger buffer width.Returns: numpy.ndarray
containing Voronoi polytope volumes/areas.Return type: numpy.ndarray
, shape= \(\left(N_{cells} \right)\), dtype=numpy.float32
-
getVoronoiPolytopes
()[source]¶ Returns a list of polytope vertices corresponding to Voronoi cells.
If the buffer width is too small, then some polytopes may not be closed (they may have a boundary at infinity), and these polytopes’ vertices are excluded from the list.
The length of the list returned by this method should be the same as the array of positions used in the
compute()
method, if all the polytopes are closed. Otherwise try using a larger buffer width.Returns: List of numpy.ndarray
containing Voronoi polytope verticesReturn type: list
-
setBox
(box)[source]¶ Reset the simulation box.
Parameters: box ( freud.box.Box
) – simulation box
-
Development Guide¶
Contributions to freud are highly encouraged. The pages below offer information about freud’s design goals and how to contribute new modules.
Design Principles¶
Vision¶
The freud library is designed to be a powerful and flexible library for the analysis of simulation output. To support a variety of analysis routines, freud places few restrictions on its components. The primary requirement for an analysis routine in freud is that it should be substantially computationally intensive so as to require coding up in C++: all freud code should be composed of fast C++ routines operating on systems of particles in periodic boxes. To remain easy-to-use, all C++ modules should be wrapped in python code so they can be easily accessed from python scripts or through a python interpreter.
In order to achieve this goal, freud takes the following viewpoints:
- In order to remain as agnostic to inputs as possible, freud makes no attempt to interface directly with simulation software. Instead, freud works directly with NumPy <http://www.numpy.org/>_ arrays to retain maximum flexibility.
- For ease of maintenance, freud uses Git for version control; Bitbucket for code hosting and issue tracking; and the PEP 8 standard for code, stressing explicitly written code which is easy to read.
- To ensure correctness, freud employs unit testing using the python unittest framework. In addition, freud utilizes CircleCI for continuous integration to ensure that all of its code works correctly and that any changes or new features do not break existing functionality.
Language choices¶
The freud library is written in two languages: Python and C++. C++ allows for powerful, fast code execution while Python allows for easy, flexible use. Intel Threading Building Blocks parallelism provides further power to C++ code. The C++ code is wrapped with Cython, allowing for user interaction in Python. NumPy provides the basic data structures in freud, which are commonly used in other Python plotting libraries and packages.
Unit Tests¶
All modules should include a set of unit tests which test the correct behavior of the module. These tests should be simple and short, testing a single function each, and completing as quickly as possible (ideally < 10 sec, but times up to a minute are acceptable if justified).
Make Execution Explicit¶
While it is tempting to make your code do things “automatically”, such
as have a calculate method find all _calc
methods in a class, call
them, and add their returns to a dictionary to return to the user, it is
preferred in freud to execute code explicitly. This helps avoid issues
with debugging and undocumented behavior:
# this is bad
class SomeFreudClass(object):
def __init__(self, **kwargs):
for key in kwargs.keys:
setattr(self, key, kwargs[key])
# this is good
class SomeOtherFreudClass(object):
def __init__(self, x=None, y=None):
self.x = x
self.y = y
Code Duplication¶
When possible, code should not be duplicated. However, being explicit is more important. In freud this translates to many of the inner loops of functions being very similar:
// somewhere deep in function_a
for (int i = 0; i < n; i++)
{
vec3[float] pos_i = position[i];
for (int j = 0; j < n; j++)
{
pos_j = = position[j];
// more calls here
}
}
// somewhere deep in function_b
for (int i = 0; i < n; i++)
{
vec3[float] pos_i = position[i];
for (int j = 0; j < n; j++)
{
pos_j = = position[j];
// more calls here
}
}
While it might be possible to figure out a way to create a base C++ class all such classes inherit from, run through positions, call a calculation, and return, this would be rather complicated. Additionally, any changes to the internals of the code, and may result in performance penalties, difficulty in debugging, etc. As before, being explicit is better.
However, if you have a class which has a number of methods, each of which requires the calling of a function, this function should be written as its own method (instead of being copy-pasted into each method) as is typical in object-oriented programming.
Python vs. Cython vs. C++¶
The freud library is meant to leverage the power of C++ code imbued with parallel processing power from TBB with the ease of writing Python code. The bulk of your calculations should take place in C++, as shown in the snippet below:
# this is bad
def badHeavyLiftingInPython(positions):
# check that positions are fine
for i, pos_i in enumerate(positions):
for j, pos_j in enumerate(positions):
if i != j:
r_ij = pos_j - pos_i
...
computed_array[i] += some_val
return computed_array
# this is good
def goodHeavyLiftingInCPlusPlus(positions):
# check that positions are fine
cplusplus_heavy_function(computed_array, positions, len(pos))
return computed_array
In the C++ code, implement the heavy lifting function called above from Python:
void cplusplus_heavy_function(float* computed_array,
float* positions,
int n)
{
for (int i = 0; i < n; i++)
{
for (int j = 0; j < n; j++)
{
if (i != j)
{
r_ij = pos_j - pos_i;
...
computed_array[i] += some_val;
}
}
}
}
Some functions may be necessary to write at the Python level due to a Python library not having an equivalent C++ library, complexity of coding, etc. In this case, the code should be written in Cython and a reasonable attempt to optimize the code should be made.
Source Code Conventions¶
The guidelines below should be followed for any new code added to freud. This guide is separated into three sections, one for guidelines common to python and C++, one for python alone, and one for C++.
Both¶
Naming Conventions¶
The following conventions should apply to Python, Cython, and C++ code.
- Variable names use
lower_case_with_underscores
- Function and method names use
lowerCaseWithNoUnderscores
- Class names use
CapWords
Python example:
class FreudClass(object):
def __init__(self):
pass
def calcSomething(self, position_i, orientation_i, position_j, orientation_j):
r_ij = position_j - position_i
theta_ij = calcOrientationThing(orientation_i, orientation_j)
def calcOrientationThing(self, orientation_i, orientation_j):
...
C++ example:
class FreudCPPClass
{
FreudCPPClass()
{
}
computeSomeValue(int variable_a, float variable_b)
{
// do some things in here
}
};
Indentation¶
- Spaces, not tabs, must be used for indentation
- 4 spaces are required per level of indentation
- 4 spaces are required, not optional, for continuation lines
- There should be no whitespace at the end of lines in the file.
- Documentation comments and items broken over multiple lines should be aligned with spaces
class SomeClass
{
private:
int m_some_member; //!< Documentation for some_member
int m_some_other_member; //!< Documentation for some_other_member
};
template<class BlahBlah> void some_long_func(BlahBlah with_a_really_long_argument_list,
int b,
int c);
Formatting Long Lines¶
All code lines should be hand-wrapped so that they are no more than 79 characters long. Simply break any excessively long line of code at any natural breaking point to continue on the next line.
cout << "This is a really long message, with "
<< message.length()
<< "Characters in it:"
<< message << endl;
Try to maintain some element of beautiful symmetry in the way the line is broken. For example, the above long message is preferred over the below:
cout << "This is a really long message, with " << message.length() << "Characters in it:"
<< message << endl;
There are special rules for function definitions and/or calls:
- If the function definition (or call) cleanly fits within the character limit, leave it all on one line
int some_function(int arg1, int arg2)
- (Option 1) If the function definition (or call) goes over the limit, you may be able to fix it by simply putting the template definition on the previous line:
// go from
template<class Foo, class Bar> int some_really_long_function_name(int with_really_long, Foo argument, Bar lists)
// to
template<class Foo, class Bar>
int some_really_long_function_name(int with_really_long, Foo argument, Bar lists)
- (Option 2) If the function doesn’t have a template specifier, or splitting at that point isn’t enough, split out each argument onto a separate line and align them.
// Instead of this...
int someReallyLongFunctionName(int with_really_long_arguments, int or, int maybe, float there, char are, int just, float a, int lot, char of, int them)
// ...use this.
int someReallyLongFunctionName(int with_really_long_arguments,
int or,
int maybe,
float there,
char are,
int just,
float a,
int lot,
char of,
int them)
Python¶
Code in freud should follow PEP 8, as well as the following guidelines. Anything listed here takes precedence over PEP 8, but try to deviate as little as possible from PEP 8. When in doubt, follow these guidelines over PEP 8.
If you are unsure if your code is PEP 8 compliant, you can use autopep8 and flake8 (or similar) to automatically update and check your code.
Semicolons¶
Semicolons should not be used to mark the end of lines in Python.
Documentation Comments¶
- Python documentation uses sphinx, not doxygen
- See the sphinx documentation for more information
- Documentation should be included at the Python-level in the Cython wrapper.
- Every class, member variable, function, function parameter, macro, etc. must be documented with Python docstring comments which will be converted to documentation with sphinx.
- If you copy an existing file as a template, do not leave the existing documentation comments there. They apply to the original file, not your new one!
- The best advice that can be given is to write the documentation comments first and the actual code second. This allows one to formulate their thoughts and write out in English what the code is going to be doing. After thinking through that, writing the actual code is often much easier, plus the documentation left for future developers to read is top-notch.
- Good documentation comments are best demonstrated with an in-code example.
CPP¶
Indentation¶
- C++ code should follow Whitesmith’s style. An extended set of examples follows:
class SomeClass
{
public:
SomeClass();
int SomeMethod(int a);
private:
int m_some_member;
};
// indent function bodies
int SomeClass::SomeMethod(int a)
{
// indent loop bodies
while (condition)
{
b = a + 1;
c = b - 2;
}
// indent switch bodies and the statements inside each case
switch (b)
{
case 0:
c = 1;
break;
case 1:
c = 2;
break;
default:
c = 3;
break;
}
// indent the bodies of if statements
if (something)
{
c = 5;
b = 10;
}
else if (something_else)
{
c = 10;
b = 5;
}
else
{
c = 20;
b = 6;
}
// omitting the braces is fine if there is only one statement in a body (for loops, if, etc.)
for (int i = 0; i < 10; i++)
c = c + 1;
return c;
// the nice thing about this style is that every brace lines up perfectly with its mate
}
- TBB sections should use lambdas, not templates
void someC++Function(float some_var,
float other_var)
{
// code before parallel section
parallel_for(blocked_range<size_t>(0,n),
[=] (const blocked_range<size_t>& r)
{
// do stuff
});
Documentation Comments¶
- Documentation should be written in doxygen.
How to Add New Code¶
This document details the process of adding new code into freud.
Does my code belong in freud?¶
The freud library is not meant to simply wrap or augment external Python libraries. A good rule of thumb is if the code I plan to write does not require C++, it does not belong in freud. There are, of course, exceptions.
Create a new branch¶
You should branch your code from master
into a new branch. Do not add
new code directly into the master
branch.
Add a New Module¶
If the code you are adding is in a new module, not an existing module, you must do the following:
- Edit
cpp/CMakeLists.txt
- Add
${CMAKE_CURRENT_SOURCE_DIR}/moduleName
toinclude_directories
. - Add
moduleName/SubModule.cc
andmoduleName/SubModule.h
to theFREUD_SOURCES
inset
.
- Add
- Create
cpp/moduleName
folder - Edit
freud/__init__.py
- Add
from . import moduleName
so that your module is imported by default.
- Add
- Edit
freud/_freud.pyx
- Add
include "moduleName.pxi"
. This must be done to have freud include your Python-level code.
- Add
- Create
freud/moduleName.pxi
file- This will house the python-level code.
- If you have a .pxd file exposing C++ classes, make sure to import that:
cimport freud._moduleName as moduleName`
- Create
freud/moduleName.py
file- Make sure there is an import for each C++ class in your module:
from ._freud import MyC++Class
- Create
freud/_moduleName.pxd
- This file will expose the C++ classes in your module to python.
- Add line to
doc/source/modules.rst
- Make sure your new module is referenced in the documentation.
- Create
doc/source/moduleName.rst
Add to an Existing Module¶
To add a new class to an existing module, do the following:
- Create
cpp/moduleName/SubModule.h
andcpp/moduleName/SubModule.cc
- New classes should be grouped into paired
.h
,.cc
files. There may be a few instances where new classes could be added to an existing.h
,.cc
pairing.
- New classes should be grouped into paired
- Edit
freud/moduleName.py
file- Add a line for each C++ class in your module:
from ._freud import MyC++Class
- Expose C++ class in
freud/_moduleName.pxd
- Create Python interface in
freud/moduleName.pxi
You must include sphinx-style documentation and unit tests.
- Add extra documentation to
doc/source/moduleName.rst
- Add unit tests to
freud/tests
References and Citations¶
[Cit0] | Bokeh Development Team (2014). Bokeh: Python library for interactive visualization URL http://www.bokeh.pydata.org. |
[Cit1] | Haji-Akbari, A., & Glotzer, S. C. (2015). Strong orientational coordinates and orientational order parameters for symmetric objects. Journal of Physics A: Mathematical and Theoretical, 48. https://doi.org/10.1088/1751-8113/48/48/485201 |
[Cit2] | van Anders, G., Klotsa, D., Ahmed, N. K., Engel, M., & Glotzer, S. C. (2014). Understanding shape entropy through local dense packing. Proceedings of the National Academy of Sciences, 111(45), E4812–E4821. https://doi.org/10.1073/pnas.1418159111 |
[Cit3] | van Anders, G., Ahmed, N. K., Smith, R., Engel, M., & Glotzer, S. C. (2014). Entropically patchy particles: Engineering valence through shape entropy. ACS Nano, 8(1), 931–940. https://doi.org/10.1021/nn4057353 |
[Cit4] | Lechner, W., & Dellago, C. (2008). Accurate determination of crystal structures based on averaged local bond order parameters. Journal of Chemical Physics, 129(11). https://doi.org/10.1063/1.2977970 |
License¶
freud Open Source Software License Copyright 2010-2018 The Regents of
the University of Michigan All rights reserved.
freud may contain modifications ("Contributions") provided, and to which
copyright is held, by various Contributors who have granted The Regents of the
University of Michigan the right to modify and/or distribute such Contributions.
Redistribution and use in source and binary forms, with or without
modification, are permitted provided that the following conditions are met:
1. Redistributions of source code must retain the above copyright notice,
this list of conditions and the following disclaimer.
2. Redistributions in binary form must reproduce the above copyright notice,
this list of conditions and the following disclaimer in the documentation
and/or other materials provided with the distribution.
3. Neither the name of the copyright holder nor the names of its contributors
may be used to endorse or promote products derived from this software without
specific prior written permission.
THIS SOFTWARE IS PROVIDED BY THE COPYRIGHT HOLDERS AND CONTRIBUTORS "AS IS" AND
ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE IMPLIED
WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE ARE
DISCLAIMED. IN NO EVENT SHALL THE COPYRIGHT HOLDER OR CONTRIBUTORS BE LIABLE FOR
ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR CONSEQUENTIAL DAMAGES
(INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES;
LOSS OF USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND ON
ANY THEORY OF LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT
(INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF THIS
SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE.
Credits¶
freud Developers¶
The following people contributed to the development of freud.
Eric Harper, University of Michigan - Former lead developer
- TBB parallelism
- PMFT module
- NearestNeighbors
- RDF
- Bonding module
- Cubatic order parameter
- Hexatic order parameter
- Pairing2D
Joshua A. Anderson, University of Michigan - Creator
- Initial design and implementation
- IteratorLinkCell
- LinkCell
- Various density modules
- freud.parallel
- Indexing modules
- cluster.pxi
Matthew Spellings - Former lead developer
- Added generic neighbor list
- Enabled neighbor list usage across freud modules
- Correlation functions
- LocalDescriptors class
- interface.pxi
Erin Teich
- Wrote environment matching module
- BondOrder (with Julia Dshemuchadse)
- Angular separation (with Andrew Karas)
- Contributed to LocalQl development
- Eric Irrgang
- Authored kspace CPP code
Chrisy Du
- Authored all Steinhardt order parameters
Antonio Osorio
Vyas Ramasubramani - Lead developer
- Ensured pep8 compliance
- Added CircleCI continuous integration support
- Rewrote docs
- Fixed nematic order parameter
- Add properties for accessing class members
- Various minor bug fixes
Bradley Dice - Lead developer
- Cleaned up various docstrings
- HexOrderParameter bug fixes
- Cleaned up testing code
- Bumpversion support
- Reduced all compile warnings
- Added Python interface for box periodicity
- Added Voronoi support for neighbor lists across periodic boundaries
- Added Voronoi weights for 3D
- Added Voronoi cell volume computation
Richmond Newman
- Developed the freud box
- Solid liquid order parameter
Carl Simon Adorf
- Developed the python box module
Jens Glaser
- Wrote kspace.pxi front-end
- Nematic order parameter
Benjamin Schultz
- Wrote Voronoi module
Bryan VanSaders
Ryan Marson
Tom Grubb
Yina Geng
- Co-wrote Voronoi neighbor list module
- Add properties for accessing class members
Carolyn Phillips
- Initial design and implementation
- Package name
Ben Swerdlow
James Antonaglia
Mayank Agrawal
- Co-wrote Voronoi neighbor list module
William Zygmunt
Greg van Anders
James Proctor
Rose Cersonsky
Wenbo Shen
Andrew Karas
- Angular separation
Paul Dodd
Tim Moore
- Added optional rmin argument to density.RDF
Michael Engel
- Translational order parameter
Source code¶
Eigen (http://eigen.tuxfamily.org/) is included as a git submodule in freud. Eigen is made available under the Mozilla Public License v.2.0 (http://mozilla.org/MPL/2.0/). Its linear algebra routines are used for various tasks including the computation of eigenvalues and eigenvectors.
fsph (https://bitbucket.org/glotzer/fsph) is included as a git submodule in freud. fsph is made available under the MIT license. It is used for the calculation of spherical harmonics, which are then used in the calculation of various order parameters.