2 * This file is part of the GROMACS molecular simulation package.
4 * Copyright (c) 2009,2010,2011,2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
5 * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
6 * and including many others, as listed in the AUTHORS file in the
7 * top-level source directory and at http://www.gromacs.org.
9 * GROMACS is free software; you can redistribute it and/or
10 * modify it under the terms of the GNU Lesser General Public License
11 * as published by the Free Software Foundation; either version 2.1
12 * of the License, or (at your option) any later version.
14 * GROMACS is distributed in the hope that it will be useful,
15 * but WITHOUT ANY WARRANTY; without even the implied warranty of
16 * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
17 * Lesser General Public License for more details.
19 * You should have received a copy of the GNU Lesser General Public
20 * License along with GROMACS; if not, see
21 * http://www.gnu.org/licenses, or write to the Free Software Foundation,
22 * Inc., 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA.
24 * If you want to redistribute modifications to GROMACS, please
25 * consider that scientific software is very special. Version
26 * control is crucial - bugs must be traceable. We will be happy to
27 * consider code for inclusion in the official distribution, but
28 * derived work must not be called official GROMACS. Details are found
29 * in the README & COPYING files - if they are missing, get the
30 * official version at http://www.gromacs.org.
32 * To help us fund GROMACS development, we humbly ask that you cite
33 * the research papers on the package. Check out http://www.gromacs.org.
37 * Implements simple keyword selection methods.
39 * \author Teemu Murtola <teemu.murtola@gmail.com>
40 * \ingroup module_selection
46 #include "gromacs/selection/position.h"
47 #include "gromacs/topology/mtop_lookup.h"
48 #include "gromacs/topology/topology.h"
49 #include "gromacs/utility/arraysize.h"
50 #include "gromacs/utility/exceptions.h"
51 #include "gromacs/utility/gmxassert.h"
53 #include "selmethod.h"
55 /** Evaluates the \p all selection keyword. */
57 evaluate_all(const gmx::SelMethodEvalContext
&context
,
58 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void *data
);
59 /** Evaluates the \p none selection keyword. */
61 evaluate_none(const gmx::SelMethodEvalContext
&context
,
62 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void *data
);
63 /** Evaluates the \p atomnr selection keyword. */
65 evaluate_atomnr(const gmx::SelMethodEvalContext
&context
,
66 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void *data
);
67 /** Evaluates the \p resnr selection keyword. */
69 evaluate_resnr(const gmx::SelMethodEvalContext
&context
,
70 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void *data
);
71 /** Evaluates the \p resindex selection keyword. */
73 evaluate_resindex(const gmx::SelMethodEvalContext
&context
,
74 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void *data
);
76 * Checks whether molecule information is present in the topology.
78 * \param[in] top Topology structure.
79 * \param npar Not used.
80 * \param param Not used.
81 * \param data Not used.
82 * \returns 0 if molecule info is present in the topology, -1 otherwise.
84 * If molecule information is not found, also prints an error message.
87 check_molecules(const gmx_mtop_t
*top
, int npar
, gmx_ana_selparam_t
*param
, void *data
);
88 /** Evaluates the \p molindex selection keyword. */
90 evaluate_molindex(const gmx::SelMethodEvalContext
&context
,
91 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void *data
);
92 /** Evaluates the \p atomname selection keyword. */
94 evaluate_atomname(const gmx::SelMethodEvalContext
&context
,
95 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void *data
);
96 /** Evaluates the \p pdbatomname selection keyword. */
98 evaluate_pdbatomname(const gmx::SelMethodEvalContext
&context
,
99 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void *data
);
101 * Checks whether atom types are present in the topology.
103 * \param[in] top Topology structure.
104 * \param npar Not used.
105 * \param param Not used.
106 * \param data Not used.
109 check_atomtype(const gmx_mtop_t
*top
, int npar
, gmx_ana_selparam_t
*param
, void *data
);
110 /** Evaluates the \p atomtype selection keyword. */
112 evaluate_atomtype(const gmx::SelMethodEvalContext
&context
,
113 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void *data
);
114 /** Evaluates the \p insertcode selection keyword. */
116 evaluate_insertcode(const gmx::SelMethodEvalContext
&context
,
117 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void *data
);
118 /** Evaluates the \p chain selection keyword. */
120 evaluate_chain(const gmx::SelMethodEvalContext
&context
,
121 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void *data
);
122 /** Evaluates the \p mass selection keyword. */
124 evaluate_mass(const gmx::SelMethodEvalContext
&context
,
125 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void *data
);
127 * Checks whether charges are present in the topology.
129 * \param[in] top Topology structure.
130 * \param npar Not used.
131 * \param param Not used.
132 * \param data Not used.
135 check_charge(const gmx_mtop_t
*top
, int npar
, gmx_ana_selparam_t
*param
, void *data
);
136 /** Evaluates the \p charge selection keyword. */
138 evaluate_charge(const gmx::SelMethodEvalContext
&context
,
139 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void *data
);
141 * Checks whether PDB info is present in the topology.
143 * \param[in] top Topology structure.
144 * \param npar Not used.
145 * \param param Not used.
146 * \param data Not used.
147 * \returns 0 if PDB info is present in the topology, -1 otherwise.
149 * If PDB info is not found, also prints an error message.
152 check_pdbinfo(const gmx_mtop_t
*top
, int npar
, gmx_ana_selparam_t
*param
, void *data
);
153 /** Evaluates the \p altloc selection keyword. */
155 evaluate_altloc(const gmx::SelMethodEvalContext
&context
,
156 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void *data
);
157 /** Evaluates the \p occupancy selection keyword. */
159 evaluate_occupancy(const gmx::SelMethodEvalContext
&context
,
160 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void *data
);
161 /** Evaluates the \p betafactor selection keyword. */
163 evaluate_betafactor(const gmx::SelMethodEvalContext
&context
,
164 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void *data
);
165 /** Evaluates the \p resname selection keyword. */
167 evaluate_resname(const gmx::SelMethodEvalContext
&context
,
168 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void *data
);
170 /** Evaluates the \p x selection keyword. */
172 evaluate_x(const gmx::SelMethodEvalContext
&context
,
173 gmx_ana_pos_t
*pos
, gmx_ana_selvalue_t
*out
, void *data
);
174 /** Evaluates the \p y selection keyword. */
176 evaluate_y(const gmx::SelMethodEvalContext
&context
,
177 gmx_ana_pos_t
*pos
, gmx_ana_selvalue_t
*out
, void *data
);
178 /** Evaluates the \p z selection keyword. */
180 evaluate_z(const gmx::SelMethodEvalContext
&context
,
181 gmx_ana_pos_t
*pos
, gmx_ana_selvalue_t
*out
, void *data
);
183 //! Help title for atom name selection keywords.
184 static const char helptitle_atomname
[] = "Selecting atoms by name";
185 //! Help text for atom name selection keywords.
186 static const char *const help_atomname
[] = {
194 "These keywords select atoms by name. [TT]name[tt] selects atoms using",
195 "the GROMACS atom naming convention.",
196 "For input formats other than PDB, the atom names are matched exactly",
197 "as they appear in the input file. For PDB files, 4 character atom names",
198 "that start with a digit are matched after moving the digit to the end",
199 "(e.g., to match 3HG2 from a PDB file, use [TT]name HG23[tt]).",
200 "[TT]pdbname[tt] can only be used with a PDB input file, and selects",
201 "atoms based on the exact name given in the input file, without the",
202 "transformation described above.[PAR]",
204 "[TT]atomname[tt] and [TT]pdbatomname[tt] are synonyms for the above two",
208 //! Help title for residue index selection keywords.
209 static const char helptitle_resindex
[] = "Selecting atoms by residue number";
210 //! Help text for residue index selection keywords.
211 static const char *const help_resindex
[] = {
219 "[TT]resnr[tt] selects atoms using the residue numbering in the input",
220 "file. [TT]resid[tt] is synonym for this keyword for VMD compatibility.",
222 "[TT]resindex N[tt] selects the [TT]N[tt]th residue starting from the",
223 "beginning of the input file. This is useful for uniquely identifying",
224 "residues if there are duplicate numbers in the input file (e.g., in",
226 "[TT]residue[tt] is a synonym for [TT]resindex[tt]. This allows",
227 "[TT]same residue as[tt] to work as expected."
230 /** Selection method data for \p all selection keyword. */
231 gmx_ana_selmethod_t sm_all
= {
232 "all", GROUP_VALUE
, 0,
244 /** Selection method data for \p none selection keyword. */
245 gmx_ana_selmethod_t sm_none
= {
246 "none", GROUP_VALUE
, 0,
258 /** Selection method data for \p atomnr selection keyword. */
259 gmx_ana_selmethod_t sm_atomnr
= {
260 "atomnr", INT_VALUE
, 0,
272 /** Selection method data for \p resnr selection keyword. */
273 gmx_ana_selmethod_t sm_resnr
= {
274 "resnr", INT_VALUE
, SMETH_REQTOP
,
284 {nullptr, helptitle_resindex
, asize(help_resindex
), help_resindex
}
287 /** Selection method data for \p resindex selection keyword. */
288 gmx_ana_selmethod_t sm_resindex
= {
289 "resindex", INT_VALUE
, SMETH_REQTOP
,
299 {nullptr, helptitle_resindex
, asize(help_resindex
), help_resindex
}
302 /** Selection method data for \p molindex selection keyword. */
303 gmx_ana_selmethod_t sm_molindex
= {
304 "molindex", INT_VALUE
, SMETH_REQTOP
,
316 /** Selection method data for \p atomname selection keyword. */
317 gmx_ana_selmethod_t sm_atomname
= {
318 "atomname", STR_VALUE
, SMETH_REQTOP
,
328 {nullptr, helptitle_atomname
, asize(help_atomname
), help_atomname
}
331 /** Selection method data for \p pdbatomname selection keyword. */
332 gmx_ana_selmethod_t sm_pdbatomname
= {
333 "pdbatomname", STR_VALUE
, SMETH_REQTOP
,
341 &evaluate_pdbatomname
,
343 {nullptr, helptitle_atomname
, asize(help_atomname
), help_atomname
}
346 /** Selection method data for \p atomtype selection keyword. */
347 gmx_ana_selmethod_t sm_atomtype
= {
348 "atomtype", STR_VALUE
, SMETH_REQTOP
,
360 /** Selection method data for \p resname selection keyword. */
361 gmx_ana_selmethod_t sm_resname
= {
362 "resname", STR_VALUE
, SMETH_REQTOP
,
374 /** Selection method data for \p chain selection keyword. */
375 gmx_ana_selmethod_t sm_insertcode
= {
376 "insertcode", STR_VALUE
, SMETH_REQTOP
| SMETH_CHARVAL
,
384 &evaluate_insertcode
,
388 /** Selection method data for \p chain selection keyword. */
389 gmx_ana_selmethod_t sm_chain
= {
390 "chain", STR_VALUE
, SMETH_REQTOP
| SMETH_CHARVAL
,
402 /** Selection method data for \p mass selection keyword. */
403 gmx_ana_selmethod_t sm_mass
= {
404 "mass", REAL_VALUE
, SMETH_REQMASS
,
416 /** Selection method data for \p charge selection keyword. */
417 gmx_ana_selmethod_t sm_charge
= {
418 "charge", REAL_VALUE
, SMETH_REQTOP
,
430 /** Selection method data for \p chain selection keyword. */
431 gmx_ana_selmethod_t sm_altloc
= {
432 "altloc", STR_VALUE
, SMETH_REQTOP
| SMETH_CHARVAL
,
444 /** Selection method data for \p occupancy selection keyword. */
445 gmx_ana_selmethod_t sm_occupancy
= {
446 "occupancy", REAL_VALUE
, SMETH_REQTOP
,
458 /** Selection method data for \p betafactor selection keyword. */
459 gmx_ana_selmethod_t sm_betafactor
= {
460 "betafactor", REAL_VALUE
, SMETH_REQTOP
,
468 &evaluate_betafactor
,
472 /** Selection method data for \p x selection keyword. */
473 gmx_ana_selmethod_t sm_x
= {
474 "x", REAL_VALUE
, SMETH_DYNAMIC
,
486 /** Selection method data for \p y selection keyword. */
487 gmx_ana_selmethod_t sm_y
= {
488 "y", REAL_VALUE
, SMETH_DYNAMIC
,
500 /** Selection method data for \p z selection keyword. */
501 gmx_ana_selmethod_t sm_z
= {
502 "z", REAL_VALUE
, SMETH_DYNAMIC
,
515 * See sel_updatefunc() for description of the parameters.
516 * \p data is not used.
518 * Copies \p g to \p out->u.g.
521 evaluate_all(const gmx::SelMethodEvalContext
& /*context*/,
522 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void * /* data */)
524 gmx_ana_index_copy(out
->u
.g
, g
, false);
528 * See sel_updatefunc() for description of the parameters.
529 * \p data is not used.
531 * Returns an empty \p out->u.g.
534 evaluate_none(const gmx::SelMethodEvalContext
& /*context*/,
535 gmx_ana_index_t
* /* g */, gmx_ana_selvalue_t
*out
, void * /* data */)
541 * See sel_updatefunc() for description of the parameters.
542 * \p data is not used.
544 * Returns the indices for each atom in \p out->u.i.
547 evaluate_atomnr(const gmx::SelMethodEvalContext
& /*context*/,
548 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void * /* data */)
553 for (i
= 0; i
< g
->isize
; ++i
)
555 out
->u
.i
[i
] = g
->index
[i
] + 1;
560 * See sel_updatefunc() for description of the parameters.
561 * \p data is not used.
563 * Returns the residue numbers for each atom in \p out->u.i.
566 evaluate_resnr(const gmx::SelMethodEvalContext
&context
,
567 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void * /* data */)
571 for (int i
= 0; i
< g
->isize
; ++i
)
573 mtopGetAtomAndResidueName(context
.top
, g
->index
[i
], &molb
,
574 nullptr, &out
->u
.i
[i
], nullptr, nullptr);
579 * See sel_updatefunc() for description of the parameters.
580 * \p data is not used.
582 * Returns the residue indices for each atom in \p out->u.i.
585 evaluate_resindex(const gmx::SelMethodEvalContext
&context
,
586 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void * /* data */)
590 for (int i
= 0; i
< g
->isize
; ++i
)
593 mtopGetAtomAndResidueName(context
.top
, g
->index
[i
], &molb
,
594 nullptr, nullptr, nullptr, &resind
);
595 out
->u
.i
[i
] = resind
+ 1;
600 check_molecules(const gmx_mtop_t
*top
, int /* npar */, gmx_ana_selparam_t
* /* param */, void * /* data */)
604 bOk
= (top
!= nullptr && top
->mols
.nr
> 0);
607 GMX_THROW(gmx::InconsistentInputError("Molecule information not available in topology"));
612 * See sel_updatefunc() for description of the parameters.
613 * \p data is not used.
615 * Returns the molecule indices for each atom in \p out->u.i.
618 evaluate_molindex(const gmx::SelMethodEvalContext
&context
,
619 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void * /* data */)
624 for (i
= j
= 0; i
< g
->isize
; ++i
)
626 while (context
.top
->mols
.index
[j
+ 1] <= g
->index
[i
])
635 * See sel_updatefunc() for description of the parameters.
636 * \p data is not used.
638 * Returns the atom name for each atom in \p out->u.s.
641 evaluate_atomname(const gmx::SelMethodEvalContext
&context
,
642 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void * /* data */)
646 for (int i
= 0; i
< g
->isize
; ++i
)
648 const char *atom_name
;
649 mtopGetAtomAndResidueName(context
.top
, g
->index
[i
], &molb
,
650 &atom_name
, nullptr, nullptr, nullptr);
651 out
->u
.s
[i
] = const_cast<char *>(atom_name
);
656 * See sel_updatefunc() for description of the parameters.
657 * \p data is not used.
659 * Returns the PDB atom name for each atom in \p out->u.s.
662 evaluate_pdbatomname(const gmx::SelMethodEvalContext
&context
,
663 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void * /* data */)
667 for (int i
= 0; i
< g
->isize
; ++i
)
669 const char *s
= mtopGetAtomPdbInfo(context
.top
, g
->index
[i
], &molb
).atomnm
;
670 while (std::isspace(*s
))
674 out
->u
.s
[i
] = const_cast<char *>(s
);
679 check_atomtype(const gmx_mtop_t
*top
, int /* npar */, gmx_ana_selparam_t
* /* param */, void * /* data */)
681 if (!gmx_mtop_has_atomtypes(top
))
683 GMX_THROW(gmx::InconsistentInputError("Atom types not available in topology"));
688 * See sel_updatefunc() for description of the parameters.
689 * \p data is not used.
691 * Returns the atom type for each atom in \p out->u.s.
692 * Segfaults if atom types are not found in the topology.
695 evaluate_atomtype(const gmx::SelMethodEvalContext
&context
,
696 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void * /* data */)
700 for (int i
= 0; i
< g
->isize
; ++i
)
702 int atomIndexInMolecule
;
703 mtopGetMolblockIndex(context
.top
, g
->index
[i
], &molb
,
704 nullptr, &atomIndexInMolecule
);
705 const gmx_moltype_t
&moltype
= context
.top
->moltype
[context
.top
->molblock
[molb
].type
];
706 out
->u
.s
[i
] = *moltype
.atoms
.atomtype
[atomIndexInMolecule
];
711 * See sel_updatefunc() for description of the parameters.
712 * \p data is not used.
714 * Returns the residue name for each atom in \p out->u.s.
717 evaluate_resname(const gmx::SelMethodEvalContext
&context
,
718 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void * /* data */)
722 for (int i
= 0; i
< g
->isize
; ++i
)
724 out
->u
.s
[i
] = *mtopGetResidueInfo(context
.top
, g
->index
[i
], &molb
).name
;
729 * See sel_updatefunc() for description of the parameters.
730 * \p data is not used.
732 * Returns the insertion code for each atom in \p out->u.s.
735 evaluate_insertcode(const gmx::SelMethodEvalContext
&context
,
736 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void * /* data */)
740 for (int i
= 0; i
< g
->isize
; ++i
)
742 out
->u
.s
[i
][0] = mtopGetResidueInfo(context
.top
, g
->index
[i
], &molb
).ic
;
747 * See sel_updatefunc() for description of the parameters.
748 * \p data is not used.
750 * Returns the chain for each atom in \p out->u.s.
753 evaluate_chain(const gmx::SelMethodEvalContext
&context
,
754 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void * /* data */)
758 for (int i
= 0; i
< g
->isize
; ++i
)
760 out
->u
.s
[i
][0] = mtopGetResidueInfo(context
.top
, g
->index
[i
], &molb
).chainid
;
765 * See sel_updatefunc() for description of the parameters.
766 * \p data is not used.
768 * Returns the mass for each atom in \p out->u.r.
771 evaluate_mass(const gmx::SelMethodEvalContext
&context
,
772 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void * /* data */)
774 GMX_RELEASE_ASSERT(gmx_mtop_has_masses(context
.top
),
775 "Masses not available for evaluation");
778 for (int i
= 0; i
< g
->isize
; ++i
)
780 out
->u
.r
[i
] = mtopGetAtomMass(context
.top
, g
->index
[i
], &molb
);
786 check_charge(const gmx_mtop_t
*top
, int /* npar */, gmx_ana_selparam_t
* /* param */, void * /* data */)
788 if (!gmx_mtop_has_charges(top
))
790 GMX_THROW(gmx::InconsistentInputError("Charges not available in topology"));
795 * See sel_updatefunc() for description of the parameters.
796 * \p data is not used.
798 * Returns the charge for each atom in \p out->u.r.
801 evaluate_charge(const gmx::SelMethodEvalContext
&context
,
802 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void * /* data */)
806 for (int i
= 0; i
< g
->isize
; ++i
)
808 out
->u
.r
[i
] = mtopGetAtomParameters(context
.top
, g
->index
[i
], &molb
).q
;
813 check_pdbinfo(const gmx_mtop_t
*top
, int /* npar */, gmx_ana_selparam_t
* /* param */, void * /* data */)
815 if (!gmx_mtop_has_pdbinfo(top
))
817 GMX_THROW(gmx::InconsistentInputError("PDB info not available in topology"));
822 * See sel_updatefunc() for description of the parameters.
823 * \p data is not used.
825 * Returns the alternate location identifier for each atom in \p out->u.s.
828 evaluate_altloc(const gmx::SelMethodEvalContext
&context
,
829 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void * /* data */)
833 for (int i
= 0; i
< g
->isize
; ++i
)
835 out
->u
.s
[i
][0] = mtopGetAtomPdbInfo(context
.top
, g
->index
[i
], &molb
).altloc
;
840 * See sel_updatefunc() for description of the parameters.
841 * \p data is not used.
843 * Returns the occupancy numbers for each atom in \p out->u.r.
844 * Segfaults if PDB info is not found in the topology.
847 evaluate_occupancy(const gmx::SelMethodEvalContext
&context
,
848 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void * /* data */)
852 for (int i
= 0; i
< g
->isize
; ++i
)
854 out
->u
.r
[i
] = mtopGetAtomPdbInfo(context
.top
, g
->index
[i
], &molb
).occup
;
859 * See sel_updatefunc() for description of the parameters.
860 * \p data is not used.
862 * Returns the B-factors for each atom in \p out->u.r.
863 * Segfaults if PDB info is not found in the topology.
866 evaluate_betafactor(const gmx::SelMethodEvalContext
&context
,
867 gmx_ana_index_t
*g
, gmx_ana_selvalue_t
*out
, void * /* data */)
871 for (int i
= 0; i
< g
->isize
; ++i
)
873 out
->u
.r
[i
] = mtopGetAtomPdbInfo(context
.top
, g
->index
[i
], &molb
).bfac
;
878 * Internal utility function for position keyword evaluation.
880 * \param[out] out Output array.
881 * \param[in] pos Position data to use instead of atomic coordinates.
882 * \param[in] d Coordinate index to evaluate (\p XX, \p YY or \p ZZ).
884 * This function is used internally by evaluate_x(), evaluate_y() and
885 * evaluate_z() to do the actual evaluation.
888 evaluate_coord(real out
[], gmx_ana_pos_t
*pos
, int d
)
890 for (int i
= 0; i
< pos
->count(); ++i
)
892 out
[i
] = pos
->x
[i
][d
];
894 // TODO: Make this more efficient by directly extracting the coordinates
895 // from the frame coordinates for atomic positions instead of going through
896 // a position calculation.
900 * See sel_updatefunc_pos() for description of the parameters.
901 * \p data is not used.
903 * Returns the \p x coordinate for each position in \p out->u.r.
906 evaluate_x(const gmx::SelMethodEvalContext
& /*context*/,
907 gmx_ana_pos_t
*pos
, gmx_ana_selvalue_t
*out
, void * /*data*/)
909 out
->nr
= pos
->count();
910 evaluate_coord(out
->u
.r
, pos
, XX
);
914 * See sel_updatefunc() for description of the parameters.
915 * \p data is not used.
917 * Returns the \p y coordinate for each position in \p out->u.r.
920 evaluate_y(const gmx::SelMethodEvalContext
& /*context*/,
921 gmx_ana_pos_t
*pos
, gmx_ana_selvalue_t
*out
, void * /*data*/)
923 out
->nr
= pos
->count();
924 evaluate_coord(out
->u
.r
, pos
, YY
);
928 * See sel_updatefunc() for description of the parameters.
929 * \p data is not used.
931 * Returns the \p z coordinate for each position in \p out->u.r.
934 evaluate_z(const gmx::SelMethodEvalContext
& /*context*/,
935 gmx_ana_pos_t
*pos
, gmx_ana_selvalue_t
*out
, void * /*data*/)
937 out
->nr
= pos
->count();
938 evaluate_coord(out
->u
.r
, pos
, ZZ
);