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 classes in selection.h.
39 * \author Teemu Murtola <teemu.murtola@gmail.com>
40 * \ingroup module_selection
44 #include "selection.h"
48 #include "gromacs/selection/nbsearch.h"
49 #include "gromacs/selection/position.h"
50 #include "gromacs/topology/mtop_lookup.h"
51 #include "gromacs/topology/topology.h"
52 #include "gromacs/utility/exceptions.h"
53 #include "gromacs/utility/gmxassert.h"
54 #include "gromacs/utility/stringutil.h"
55 #include "gromacs/utility/textwriter.h"
66 /********************************************************************
70 SelectionData::SelectionData(SelectionTreeElement
*elem
,
72 : name_(elem
->name()), selectionText_(selstr
),
73 rootElement_(*elem
), coveredFractionType_(CFRAC_NONE
),
74 coveredFraction_(1.0), averageCoveredFraction_(1.0),
75 bDynamic_(false), bDynamicCoveredFraction_(false)
77 if (elem
->child
->type
== SEL_CONST
)
79 // TODO: This is not exception-safe if any called function throws.
80 gmx_ana_pos_copy(&rawPositions_
, elem
->child
->v
.u
.p
, true);
84 SelectionTreeElementPointer child
= elem
->child
;
85 child
->flags
&= ~SEL_ALLOCVAL
;
86 _gmx_selvalue_setstore(&child
->v
, &rawPositions_
);
87 /* We should also skip any modifiers to determine the dynamic
89 while (child
->type
== SEL_MODIFIER
)
96 if (child
->type
== SEL_SUBEXPRREF
)
99 /* Because most subexpression elements are created
100 * during compilation, we need to check for them
103 if (child
->type
== SEL_SUBEXPR
)
105 child
= child
->child
;
111 /* For variable references, we should skip the
112 * SEL_SUBEXPRREF and SEL_SUBEXPR elements. */
113 if (child
->type
== SEL_SUBEXPRREF
)
115 child
= child
->child
->child
;
117 bDynamic_
= (child
->child
->flags
& SEL_DYNAMIC
);
120 initCoveredFraction(CFRAC_NONE
);
124 SelectionData::~SelectionData()
130 SelectionData::initCoveredFraction(e_coverfrac_t type
)
132 coveredFractionType_
= type
;
133 if (type
== CFRAC_NONE
)
135 bDynamicCoveredFraction_
= false;
137 else if (!_gmx_selelem_can_estimate_cover(rootElement()))
139 coveredFractionType_
= CFRAC_NONE
;
140 bDynamicCoveredFraction_
= false;
144 bDynamicCoveredFraction_
= true;
146 coveredFraction_
= bDynamicCoveredFraction_
? 0.0 : 1.0;
147 averageCoveredFraction_
= coveredFraction_
;
148 return type
== CFRAC_NONE
|| coveredFractionType_
!= CFRAC_NONE
;
155 * Helper function to compute total masses and charges for positions.
157 * \param[in] top Topology to take atom masses from.
158 * \param[in] pos Positions to compute masses and charges for.
159 * \param[out] masses Output masses.
160 * \param[out] charges Output charges.
162 * Does not throw if enough space has been reserved for the output vectors.
164 void computeMassesAndCharges(const gmx_mtop_t
*top
, const gmx_ana_pos_t
&pos
,
165 std::vector
<real
> *masses
,
166 std::vector
<real
> *charges
)
168 GMX_ASSERT(top
!= NULL
, "Should not have been called with NULL topology");
172 for (int b
= 0; b
< pos
.count(); ++b
)
176 for (int i
= pos
.m
.mapb
.index
[b
]; i
< pos
.m
.mapb
.index
[b
+1]; ++i
)
178 const int index
= pos
.m
.mapb
.a
[i
];
179 const t_atom
&atom
= mtopGetAtomParameters(top
, index
, &molb
);
183 masses
->push_back(mass
);
184 charges
->push_back(charge
);
191 SelectionData::hasSortedAtomIndices() const
194 gmx_ana_index_set(&g
, rawPositions_
.m
.mapb
.nra
, rawPositions_
.m
.mapb
.a
, -1);
195 return gmx_ana_index_check_sorted(&g
);
199 SelectionData::refreshName()
201 rootElement_
.fillNameIfMissing(selectionText_
.c_str());
202 name_
= rootElement_
.name();
206 SelectionData::initializeMassesAndCharges(const gmx_mtop_t
*top
)
208 GMX_ASSERT(posMass_
.empty() && posCharge_
.empty(),
209 "Should not be called more than once");
210 posMass_
.reserve(posCount());
211 posCharge_
.reserve(posCount());
214 posMass_
.resize(posCount(), 1.0);
215 posCharge_
.resize(posCount(), 0.0);
219 computeMassesAndCharges(top
, rawPositions_
, &posMass_
, &posCharge_
);
225 SelectionData::refreshMassesAndCharges(const gmx_mtop_t
*top
)
227 if (top
!= nullptr && isDynamic() && !hasFlag(efSelection_DynamicMask
))
229 computeMassesAndCharges(top
, rawPositions_
, &posMass_
, &posCharge_
);
235 SelectionData::updateCoveredFractionForFrame()
237 if (isCoveredFractionDynamic())
239 real cfrac
= _gmx_selelem_estimate_coverfrac(rootElement());
240 coveredFraction_
= cfrac
;
241 averageCoveredFraction_
+= cfrac
;
247 SelectionData::computeAverageCoveredFraction(int nframes
)
249 if (isCoveredFractionDynamic() && nframes
> 0)
251 averageCoveredFraction_
/= nframes
;
257 SelectionData::restoreOriginalPositions(const gmx_mtop_t
*top
)
261 gmx_ana_pos_t
&p
= rawPositions_
;
262 gmx_ana_indexmap_update(&p
.m
, rootElement().v
.u
.g
,
263 hasFlag(gmx::efSelection_DynamicMask
));
264 refreshMassesAndCharges(top
);
268 } // namespace internal
270 /********************************************************************
274 Selection::operator AnalysisNeighborhoodPositions() const
276 AnalysisNeighborhoodPositions
pos(data().rawPositions_
.x
,
277 data().rawPositions_
.count());
280 pos
.exclusionIds(atomIndices());
287 Selection::setOriginalId(int i
, int id
)
289 data().rawPositions_
.m
.mapid
[i
] = id
;
290 data().rawPositions_
.m
.orgid
[i
] = id
;
295 Selection::initOriginalIdsToGroup(const gmx_mtop_t
*top
, e_index_t type
)
299 return gmx_ana_indexmap_init_orgid_group(&data().rawPositions_
.m
, top
, type
);
301 catch (const InconsistentInputError
&)
303 GMX_ASSERT(type
== INDEX_RES
|| type
== INDEX_MOL
,
304 "Expected that only grouping by residue/molecule would fail");
305 std::string message
=
306 formatString("Cannot group selection '%s' into %s, because some "
307 "positions have atoms from more than one such group.",
308 name(), type
== INDEX_MOL
? "molecules" : "residues");
309 GMX_THROW(InconsistentInputError(message
));
315 Selection::printInfo(FILE *fp
) const
317 fprintf(fp
, "\"%s\" (%d position%s, %d atom%s%s)", name(),
318 posCount(), posCount() == 1 ? "" : "s",
319 atomCount(), atomCount() == 1 ? "" : "s",
320 isDynamic() ? ", dynamic" : "");
326 Selection::printDebugInfo(FILE *fp
, int nmaxind
) const
328 const gmx_ana_pos_t
&p
= data().rawPositions_
;
332 fprintf(fp
, " Group ");
334 gmx_ana_index_set(&g
, p
.m
.mapb
.nra
, p
.m
.mapb
.a
, 0);
335 TextWriter
writer(fp
);
336 gmx_ana_index_dump(&writer
, &g
, nmaxind
);
338 fprintf(fp
, " Block (size=%d):", p
.m
.mapb
.nr
);
341 fprintf(fp
, " (null)");
346 if (nmaxind
>= 0 && n
> nmaxind
)
350 for (int i
= 0; i
<= n
; ++i
)
352 fprintf(fp
, " %d", p
.m
.mapb
.index
[i
]);
362 if (nmaxind
>= 0 && n
> nmaxind
)
366 fprintf(fp
, " RefId:");
369 fprintf(fp
, " (null)");
373 for (int i
= 0; i
< n
; ++i
)
375 fprintf(fp
, " %d", p
.m
.refid
[i
]);
384 fprintf(fp
, " MapId:");
387 fprintf(fp
, " (null)");
391 for (int i
= 0; i
< n
; ++i
)
393 fprintf(fp
, " %d", p
.m
.mapid
[i
]);
404 /********************************************************************
408 SelectionPosition::operator AnalysisNeighborhoodPositions() const
410 AnalysisNeighborhoodPositions
pos(sel_
->rawPositions_
.x
,
411 sel_
->rawPositions_
.count());
412 if (sel_
->hasOnlyAtoms())
414 // TODO: Move atomIndices() such that it can be reused here as well.
415 pos
.exclusionIds(constArrayRefFromArray
<int>(sel_
->rawPositions_
.m
.mapb
.a
,
416 sel_
->rawPositions_
.m
.mapb
.nra
));
418 return pos
.selectSingleFromArray(i_
);