File tree Expand file tree Collapse file tree 20 files changed +40
-37
lines changed Expand file tree Collapse file tree 20 files changed +40
-37
lines changed Original file line number Diff line number Diff line change 2626
2727Read DL Poly_ format coordinate files
2828
29- .. _Poly: http ://www.stfc.ac.uk/SCD/research/app/ccg/ software/DL_POLY/44516.aspx
29+ .. _Poly: https ://www.sc. stfc.ac.uk/software/type/computational-materials-and-molecular-science/?searchquery=dl_poly
3030"""
3131import numpy as np
3232
Original file line number Diff line number Diff line change 9696
9797
9898.. _Gromacs: http://www.gromacs.org
99- .. _GRO: http ://manual.gromacs.org/current/online/gro .html
99+ .. _GRO: https ://manual.gromacs.org/current/reference-manual/file-formats .html#gro
100100.. _GRO format: http://chembytes.wikidot.com/g-grofile
101101
102102"""
Original file line number Diff line number Diff line change 3636to be different to the one that was set at the first time step. No check on
3737changes in particle identity or topology is currently implemented.
3838
39- .. _`HOOMD-blue`: http ://codeblue. umich.edu/hoomd-blue/index.html
39+ .. _`HOOMD-blue`: https ://glotzerlab.engin. umich.edu/hoomd-blue/
4040
4141Classes
4242-------
Original file line number Diff line number Diff line change 180180.. _`H5PY`: http://docs.h5py.org/
181181.. _`parallel h5py docs`: https://docs.h5py.org/en/stable/mpi.html
182182.. _`mpi4py`: https://mpi4py.readthedocs.io/en/stable/index.html
183- .. _`Build MPI from sources`: https://mpi4py.readthedocs.io /en/stable/appendix.html#building-mpi-from-sources
184- .. _`Build HDF5 from sources`: https://support.hdfgroup .org/ftp/HDF5/current/src/unpacked/release_docs/INSTALL_parallel
183+ .. _`Build MPI from sources`: https://docs.open-mpi.org /en/v5.0.x/installing-open-mpi/downloading.html
184+ .. _`Build HDF5 from sources`: https://docs.h5py .org/en/latest/mpi.html
185185.. _`Install mpi4py`: https://mpi4py.readthedocs.io/en/stable/install.html#requirements
186186.. _`Build h5py from sources`: https://docs.h5py.org/en/stable/mpi.html#building-against-parallel-hdf5
187187.. _`H5MD notation`: https://nongnu.org/h5md/modules/units.html
Original file line number Diff line number Diff line change 2727
2828Read coordinates in Amber_ coordinate/restart file (suffix "inpcrd").
2929
30- .. _Amber: http ://ambermd.org/formats.html#restart
30+ .. _Amber: https ://ambermd.org/FileFormats.php
3131
3232
3333Classes
Original file line number Diff line number Diff line change 3737.. autoclass:: MMTFReader
3838 :members:
3939
40- .. _MMTF: https://mmtf .rcsb.org/
40+ .. _MMTF: https://www .rcsb.org/news/feature/65a1af31c76ca3abcc925d0c
4141
4242"""
4343import warnings
Original file line number Diff line number Diff line change 3333available in this case).
3434
3535.. _PDBQT:
36- http ://autodock.scripps.edu/faqs-help/faq/what-is-the-format-of-a-pdbqt-file
36+ https ://autodock.scripps.edu/wp-content/uploads/sites/56/2021/10/AutoDock4.2.6_UserGuide.pdf
3737.. _AutoDock:
3838 http://autodock.scripps.edu/
3939"""
@@ -198,8 +198,7 @@ class PDBQTWriter(base.WriterBase):
198198 """PDBQT writer that implements a subset of the PDB_ 3.2 standard and the PDBQT_ spec.
199199
200200 .. _PDB: http://www.wwpdb.org/documentation/file-format-content/format32/v3.2.html
201- .. _PDBQT: http://autodock.scripps.edu/faqs-help/faq/what-is-the-format-of-a-pdbqt-file
202-
201+ .. _PDBQT: https://autodock.scripps.edu/wp-content/uploads/sites/56/2021/10/AutoDock4.2.6_UserGuide.pdf
203202
204203 .. versionchanged:: 2.6.0
205204 Files are now written in `wt` mode, and keep extensions, allowing
Original file line number Diff line number Diff line change 100100In all cases the `dimensions` attribute will be set to `None`.
101101
102102
103- .. _PQR: https://apbs-pdb2pqr .readthedocs.io/en/latest/formats/pqr.html
104- .. _APBS: https://apbs-pdb2pqr .readthedocs.io/en/latest/apbs/index.html
105- .. _PDB2PQR: https://apbs- pdb2pqr.readthedocs.io/en/latest/pdb2pqr/index.html
103+ .. _PQR: https://apbs.readthedocs.io/en/latest/formats/pqr.html
104+ .. _APBS: https://apbs.readthedocs.io/en/latest/
105+ .. _PDB2PQR: https://pdb2pqr.readthedocs.io/en/latest/
106106.. _PDB: http://www.wwpdb.org/documentation/file-format
107107"""
108108import itertools
@@ -117,7 +117,7 @@ class PQRReader(base.SingleFrameReaderBase):
117117 """Read a PQR_ file into MDAnalysis.
118118
119119 .. _PQR:
120- https://apbs-pdb2pqr .readthedocs.io/en/latest/formats/pqr.html
120+ https://apbs.readthedocs.io/en/latest/formats/pqr.html
121121
122122 .. versionchanged:: 0.11.0
123123 Frames now 0-based instead of 1-based
Original file line number Diff line number Diff line change 115115.. Links
116116
117117.. _AMBER: http://ambermd.org
118- .. _AMBER TRJ format: http ://ambermd.org/formats.html #trajectory
118+ .. _AMBER TRJ format: https ://ambermd.org/FileFormats.php #trajectory
119119.. The formats page was archived as
120120.. http://www.webcitation.org/query?url=http%3A%2F%2Fambermd.org%2Fformats.html&date=2018-02-11
121- .. Use the archived version if the original disappears. [orbeckst]
121+ .. Use the archived version if the original (https://ambermd.org/FileFormats.php#trajectory) disappears. [orbeckst]
122122.. _AMBER netcdf format: http://ambermd.org/netcdf/nctraj.xhtml
123123.. The formats page was archived as
124124.. http://www.webcitation.org/query?url=http%3A%2F%2Fambermd.org%2Fnetcdf%2Fnctraj.xhtml&date=2018-02-11
@@ -166,7 +166,7 @@ class TRJReader(base.ReaderBase):
166166 be set by passing the `dt` keyword argument to the constructor; it
167167 is assumed to be in ps. The default value is 1 ps.
168168
169- .. _AMBER TRJ format: http ://ambermd.org/formats.html #trajectory
169+ .. _AMBER TRJ format: https ://ambermd.org/FileFormats.php #trajectory
170170
171171 .. versionchanged:: 0.11.0
172172 Frames now 0-based instead of 1-based.
Original file line number Diff line number Diff line change 3232the machine hardware architecture, MDAnalysis *always* reads and writes TRZ
3333trajectories in *little-endian* byte order.
3434
35- .. _IBIsCO: http ://www.theo.chemie.tu-darmstadt.de/ibisco/IBISCO.html
36- .. _YASP: http ://www.theo.chemie.tu-darmstadt.de/group/services/yaspdoc/yaspdoc.html
35+ .. _IBIsCO: https ://onlinelibrary.wiley.com/doi/full/10.1002/jcc.21717
36+ .. _YASP: https ://www.sciencedirect.com/science/article/abs/pii/0010465593901442
3737
3838Classes
3939-------
You can’t perform that action at this time.
0 commit comments