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 gmx::PositionCalculationCollection and functions in poscalc.h.
40 * There is probably some room for optimization in the calculation of
41 * positions with bases.
42 * In particular, the current implementation may do a lot of unnecessary
44 * The interface would need to be changed to make it possible to use the
45 * same output positions for several calculations.
48 * The current algorithm for setting up base calculations could be improved
49 * in cases when there are calculations that cannot use a common base but
50 * still overlap partially (e.g., with three calculations A, B, and C
51 * such that A could use both B and C as a base, but B and C cannot use the
53 * Setting up the bases in an optimal manner in every possible situation can
54 * be quite difficult unless several bases are allowed for one calculation,
55 * but better heuristics could probably be implemented.
56 * For best results, the setup should probably be postponed (at least
57 * partially) to gmx_ana_poscalc_init_eval().
59 * \author Teemu Murtola <teemu.murtola@gmail.com>
60 * \ingroup module_selection
71 #include "gromacs/math/vec.h"
72 #include "gromacs/selection/indexutil.h"
73 #include "gromacs/selection/position.h"
74 #include "gromacs/trajectory/trajectoryframe.h"
75 #include "gromacs/utility/arrayref.h"
76 #include "gromacs/utility/exceptions.h"
77 #include "gromacs/utility/gmxassert.h"
78 #include "gromacs/utility/smalloc.h"
80 #include "centerofmass.h"
86 * Private implementation class for PositionCalculationCollection.
88 * \ingroup module_selection
90 class PositionCalculationCollection::Impl
97 * Inserts a position calculation structure into its collection.
99 * \param pc Data structure to insert.
100 * \param before Data structure before which to insert
101 * (NULL = insert at end).
103 * Inserts \p pc to its collection before \p before.
104 * If \p before is NULL, \p pc is appended to the list.
106 void insertCalculation(gmx_ana_poscalc_t
*pc
, gmx_ana_poscalc_t
*before
);
108 * Removes a position calculation structure from its collection.
110 * \param pc Data structure to remove.
112 * Removes \p pc from its collection.
114 void removeCalculation(gmx_ana_poscalc_t
*pc
);
116 /*! \copydoc PositionCalculationCollection::createCalculation()
118 * This method contains the actual implementation of the similarly
119 * named method in the parent class.
121 gmx_ana_poscalc_t
*createCalculation(e_poscalc_t type
, int flags
);
124 * Maps given topology indices into frame indices.
126 * Only one position calculation at a time needs to access this (and
127 * there are also other thread-unsafe constructs here), so a temporary
128 * array is used to avoid repeated memory allocation.
130 ConstArrayRef
<int> getFrameIndices(int size
, int index
[])
132 if (mapToFrameAtoms_
.empty())
134 return constArrayRefFromArray(index
, size
);
136 tmpFrameAtoms_
.resize(size
);
137 for (int i
= 0; i
< size
; ++i
)
139 const int ii
= index
[i
];
140 GMX_ASSERT(ii
>= 0 && ii
<= static_cast<int>(mapToFrameAtoms_
.size())
141 && mapToFrameAtoms_
[ii
] != -1,
142 "Invalid input atom index");
143 tmpFrameAtoms_
[i
] = mapToFrameAtoms_
[ii
];
145 return tmpFrameAtoms_
;
151 * Can be NULL if none of the calculations require topology data or if
152 * setTopology() has not been called.
154 const gmx_mtop_t
*top_
;
155 //! Pointer to the first data structure.
156 gmx_ana_poscalc_t
*first_
;
157 //! Pointer to the last data structure.
158 gmx_ana_poscalc_t
*last_
;
159 //! Whether the collection has been initialized for evaluation.
161 //! Mapping from topology atoms to frame atoms (one index for each topology atom).
162 std::vector
<int> mapToFrameAtoms_
;
163 //! Working array for updating positions.
164 std::vector
<int> tmpFrameAtoms_
;
170 * Data structure for position calculation.
172 struct gmx_ana_poscalc_t
175 * Type of calculation.
177 * This field may differ from the type requested by the user, because
178 * it is changed internally to the most effective calculation.
179 * For example, if the user requests a COM calculation for residues
180 * consisting of single atoms, it is simply set to POS_ATOM.
181 * To provide a consistent interface to the user, the field \p itype
182 * should be used when information should be given out.
186 * Flags for calculation options.
188 * See \ref poscalc_flags "documentation of the flags".
193 * Type for the created indices.
195 * This field always agrees with the type that the user requested, but
196 * may differ from \p type.
200 * Block data for the calculation.
204 * Mapping from the blocks to the blocks of \p sbase.
206 * If \p sbase is NULL, this field is also.
210 * Maximum evaluation group.
212 gmx_ana_index_t gmax
;
214 /** Position storage for calculations that are used as a base. */
217 /** true if the positions have been evaluated for the current frame. */
220 * Base position data for this calculation.
222 * If not NULL, the centers required by this calculation have
223 * already been calculated in \p sbase.
224 * The structure pointed by \p sbase is always a static calculation.
226 gmx_ana_poscalc_t
*sbase
;
227 /** Next structure in the linked list of calculations. */
228 gmx_ana_poscalc_t
*next
;
229 /** Previous structure in the linked list of calculations. */
230 gmx_ana_poscalc_t
*prev
;
231 /** Number of references to this structure. */
233 /** Collection this calculation belongs to. */
234 gmx::PositionCalculationCollection::Impl
*coll
;
237 const char * const gmx::PositionCalculationCollection::typeEnumValues
[] = {
239 "res_com", "res_cog",
240 "mol_com", "mol_cog",
241 "whole_res_com", "whole_res_cog",
242 "whole_mol_com", "whole_mol_cog",
243 "part_res_com", "part_res_cog",
244 "part_mol_com", "part_mol_cog",
245 "dyn_res_com", "dyn_res_cog",
246 "dyn_mol_com", "dyn_mol_cog",
251 * Returns the partition type for a given position type.
253 * \param [in] type \c e_poscalc_t value to convert.
254 * \returns Corresponding \c e_indet_t.
257 index_type_for_poscalc(e_poscalc_t type
)
261 case POS_ATOM
: return INDEX_ATOM
;
262 case POS_RES
: return INDEX_RES
;
263 case POS_MOL
: return INDEX_MOL
;
264 case POS_ALL
: return INDEX_ALL
;
265 case POS_ALL_PBC
: return INDEX_ALL
;
267 return INDEX_UNKNOWN
;
276 //! Helper function for determining required topology information.
277 PositionCalculationCollection::RequiredTopologyInfo
278 requiredTopologyInfo(e_poscalc_t type
, int flags
)
280 if (type
!= POS_ATOM
)
282 if ((flags
& POS_MASS
) || (flags
& POS_FORCES
))
284 return PositionCalculationCollection::RequiredTopologyInfo::TopologyAndMasses
;
286 if (type
== POS_RES
|| type
== POS_MOL
)
288 return PositionCalculationCollection::RequiredTopologyInfo::Topology
;
291 return PositionCalculationCollection::RequiredTopologyInfo::None
;
298 PositionCalculationCollection::typeFromEnum(const char *post
,
299 e_poscalc_t
*type
, int *flags
)
304 *flags
&= ~(POS_MASS
| POS_COMPLMAX
| POS_COMPLWHOLE
);
308 /* Process the prefix */
309 const char *ptr
= post
;
312 *flags
&= ~POS_COMPLMAX
;
313 *flags
|= POS_COMPLWHOLE
;
316 else if (post
[0] == 'p')
318 *flags
&= ~POS_COMPLWHOLE
;
319 *flags
|= POS_COMPLMAX
;
322 else if (post
[0] == 'd')
324 *flags
&= ~(POS_COMPLMAX
| POS_COMPLWHOLE
);
332 else if (ptr
[0] == 'm')
338 GMX_THROW(InternalError("Unknown position calculation type"));
342 GMX_THROW(InternalError("Unknown position calculation type"));
348 else if (ptr
[6] == 'g')
354 GMX_THROW(InternalError("Unknown position calculation type"));
359 PositionCalculationCollection::RequiredTopologyInfo
360 PositionCalculationCollection::requiredTopologyInfoForType(const char *post
,
364 int flags
= (forces
? POS_FORCES
: 0);
365 PositionCalculationCollection::typeFromEnum(post
, &type
, &flags
);
366 return requiredTopologyInfo(type
, flags
);
369 /********************************************************************
370 * PositionCalculationCollection::Impl
373 PositionCalculationCollection::Impl::Impl()
374 : top_(nullptr), first_(nullptr), last_(nullptr), bInit_(false)
378 PositionCalculationCollection::Impl::~Impl()
380 // Loop backwards, because there can be internal references in that are
381 // correctly handled by this direction.
382 while (last_
!= nullptr)
384 GMX_ASSERT(last_
->refcount
== 1,
385 "Dangling references to position calculations");
386 gmx_ana_poscalc_free(last_
);
391 PositionCalculationCollection::Impl::insertCalculation(gmx_ana_poscalc_t
*pc
,
392 gmx_ana_poscalc_t
*before
)
394 GMX_RELEASE_ASSERT(pc
->coll
== this, "Inconsistent collections");
395 if (before
== nullptr)
399 if (last_
!= nullptr)
407 pc
->prev
= before
->prev
;
411 before
->prev
->next
= pc
;
415 if (pc
->prev
== nullptr)
422 PositionCalculationCollection::Impl::removeCalculation(gmx_ana_poscalc_t
*pc
)
424 GMX_RELEASE_ASSERT(pc
->coll
== this, "Inconsistent collections");
425 if (pc
->prev
!= nullptr)
427 pc
->prev
->next
= pc
->next
;
429 else if (pc
== first_
)
433 if (pc
->next
!= nullptr)
435 pc
->next
->prev
= pc
->prev
;
437 else if (pc
== last_
)
441 pc
->prev
= pc
->next
= nullptr;
445 PositionCalculationCollection::Impl::createCalculation(e_poscalc_t type
, int flags
)
447 gmx_ana_poscalc_t
*pc
;
451 pc
->itype
= index_type_for_poscalc(type
);
452 gmx_ana_poscalc_set_flags(pc
, flags
);
455 insertCalculation(pc
, nullptr);
460 /********************************************************************
461 * PositionCalculationCollection
464 PositionCalculationCollection::PositionCalculationCollection()
469 PositionCalculationCollection::~PositionCalculationCollection()
474 PositionCalculationCollection::setTopology(const gmx_mtop_t
*top
)
480 PositionCalculationCollection::printTree(FILE *fp
) const
482 gmx_ana_poscalc_t
*pc
;
485 fprintf(fp
, "Position calculations:\n");
490 fprintf(fp
, "%2d ", i
);
493 case POS_ATOM
: fprintf(fp
, "ATOM"); break;
494 case POS_RES
: fprintf(fp
, "RES"); break;
495 case POS_MOL
: fprintf(fp
, "MOL"); break;
496 case POS_ALL
: fprintf(fp
, "ALL"); break;
497 case POS_ALL_PBC
: fprintf(fp
, "ALL_PBC"); break;
499 if (pc
->itype
!= index_type_for_poscalc(pc
->type
))
504 case INDEX_UNKNOWN
: fprintf(fp
, "???"); break;
505 case INDEX_ATOM
: fprintf(fp
, "ATOM"); break;
506 case INDEX_RES
: fprintf(fp
, "RES"); break;
507 case INDEX_MOL
: fprintf(fp
, "MOL"); break;
508 case INDEX_ALL
: fprintf(fp
, "ALL"); break;
512 fprintf(fp
, " flg=");
513 if (pc
->flags
& POS_MASS
)
517 if (pc
->flags
& POS_DYNAMIC
)
521 if (pc
->flags
& POS_MASKONLY
)
525 if (pc
->flags
& POS_COMPLMAX
)
529 if (pc
->flags
& POS_COMPLWHOLE
)
537 fprintf(fp
, " nr=%d nra=%d", pc
->b
.nr
, pc
->b
.nra
);
538 fprintf(fp
, " refc=%d", pc
->refcount
);
540 if (pc
->gmax
.nalloc_index
> 0)
542 fprintf(fp
, " Group: ");
543 if (pc
->gmax
.isize
> 20)
545 fprintf(fp
, " %d atoms", pc
->gmax
.isize
);
549 for (j
= 0; j
< pc
->gmax
.isize
; ++j
)
551 fprintf(fp
, " %d", pc
->gmax
.index
[j
] + 1);
556 if (pc
->b
.nalloc_a
> 0)
558 fprintf(fp
, " Atoms: ");
561 fprintf(fp
, " %d atoms", pc
->b
.nra
);
565 for (j
= 0; j
< pc
->b
.nra
; ++j
)
567 fprintf(fp
, " %d", pc
->b
.a
[j
] + 1);
572 if (pc
->b
.nalloc_index
> 0)
574 fprintf(fp
, " Blocks:");
577 fprintf(fp
, " %d pcs", pc
->b
.nr
);
581 for (j
= 0; j
<= pc
->b
.nr
; ++j
)
583 fprintf(fp
, " %d", pc
->b
.index
[j
]);
590 gmx_ana_poscalc_t
*base
;
592 fprintf(fp
, " Base: ");
594 base
= impl_
->first_
;
595 while (base
&& base
!= pc
->sbase
)
600 fprintf(fp
, "%d", j
);
601 if (pc
->baseid
&& pc
->b
.nr
<= 20)
604 for (j
= 0; j
< pc
->b
.nr
; ++j
)
606 fprintf(fp
, " %d", pc
->baseid
[j
]+1);
617 PositionCalculationCollection::createCalculation(e_poscalc_t type
, int flags
)
619 return impl_
->createCalculation(type
, flags
);
623 PositionCalculationCollection::createCalculationFromEnum(const char *post
, int flags
)
627 typeFromEnum(post
, &type
, &cflags
);
628 return impl_
->createCalculation(type
, cflags
);
631 void PositionCalculationCollection::getRequiredAtoms(gmx_ana_index_t
*out
) const
633 gmx_ana_poscalc_t
*pc
= impl_
->first_
;
636 // Calculations with a base just copy positions from the base, so
637 // those do not need to be considered in the check.
641 gmx_ana_index_set(&g
, pc
->b
.nra
, pc
->b
.a
, 0);
642 gmx_ana_index_union_unsorted(out
, out
, &g
);
648 void PositionCalculationCollection::initEvaluation()
654 gmx_ana_poscalc_t
*pc
= impl_
->first_
;
657 /* Initialize position storage for base calculations */
660 gmx_ana_poscalc_init_pos(pc
, pc
->p
);
662 /* Construct the mapping of the base positions */
667 snew(pc
->baseid
, pc
->b
.nr
);
668 for (bi
= bj
= 0; bi
< pc
->b
.nr
; ++bi
, ++bj
)
670 while (pc
->sbase
->b
.a
[pc
->sbase
->b
.index
[bj
]] != pc
->b
.a
[pc
->b
.index
[bi
]])
677 /* Free the block data for dynamic calculations */
678 if (pc
->flags
& POS_DYNAMIC
)
680 if (pc
->b
.nalloc_index
> 0)
683 pc
->b
.nalloc_index
= 0;
685 if (pc
->b
.nalloc_a
> 0)
693 impl_
->bInit_
= true;
696 void PositionCalculationCollection::initFrame(const t_trxframe
*fr
)
702 /* Clear the evaluation flags */
703 gmx_ana_poscalc_t
*pc
= impl_
->first_
;
709 if (fr
->bIndex
&& fr
->natoms
> 0)
711 const int highestAtom
= *std::max_element(fr
->index
, fr
->index
+ fr
->natoms
);
712 impl_
->mapToFrameAtoms_
.resize(highestAtom
+ 1);
713 std::fill(impl_
->mapToFrameAtoms_
.begin(), impl_
->mapToFrameAtoms_
.end(), -1);
714 for (int i
= 0; i
< fr
->natoms
; ++i
)
716 impl_
->mapToFrameAtoms_
[fr
->index
[i
]] = i
;
721 impl_
->mapToFrameAtoms_
.clear();
728 * Initializes position calculation using the maximum possible input index.
730 * \param[in,out] pc Position calculation data structure.
731 * \param[in] g Maximum index group for the calculation.
732 * \param[in] bBase Whether \p pc will be used as a base or not.
734 * \p bBase affects on how the \p pc->gmax field is initialized.
737 set_poscalc_maxindex(gmx_ana_poscalc_t
*pc
, gmx_ana_index_t
*g
, bool bBase
)
739 const gmx_mtop_t
*top
= pc
->coll
->top_
;
740 gmx_ana_index_make_block(&pc
->b
, top
, g
, pc
->itype
, pc
->flags
& POS_COMPLWHOLE
);
741 /* Set the type to POS_ATOM if the calculation in fact is such. */
742 if (pc
->b
.nr
== pc
->b
.nra
)
745 pc
->flags
&= ~(POS_MASS
| POS_COMPLMAX
| POS_COMPLWHOLE
);
747 /* Set the POS_COMPLWHOLE flag if the calculation in fact always uses
748 * complete residues and molecules. */
749 if (!(pc
->flags
& POS_COMPLWHOLE
)
750 && (!(pc
->flags
& POS_DYNAMIC
) || (pc
->flags
& POS_COMPLMAX
))
751 && (pc
->type
== POS_RES
|| pc
->type
== POS_MOL
)
752 && gmx_ana_index_has_complete_elems(g
, pc
->itype
, top
))
754 pc
->flags
&= ~POS_COMPLMAX
;
755 pc
->flags
|= POS_COMPLWHOLE
;
757 /* Setup the gmax field */
758 if ((pc
->flags
& POS_COMPLWHOLE
) && !bBase
&& pc
->b
.nra
> g
->isize
)
760 gmx_ana_index_copy(&pc
->gmax
, g
, true);
764 gmx_ana_index_set(&pc
->gmax
, pc
->b
.nra
, pc
->b
.a
, 0);
769 * Checks whether a position calculation should use a base at all.
771 * \param[in] pc Position calculation data to check.
772 * \returns true if \p pc can use a base and gets some benefit out of it,
776 can_use_base(gmx_ana_poscalc_t
*pc
)
778 /* For atoms, it should be faster to do a simple copy, so don't use a
780 if (pc
->type
== POS_ATOM
)
784 /* For dynamic selections that do not use completion, it is not possible
786 if ((pc
->type
== POS_RES
|| pc
->type
== POS_MOL
)
787 && (pc
->flags
& POS_DYNAMIC
) && !(pc
->flags
& (POS_COMPLMAX
| POS_COMPLWHOLE
)))
791 /* Dynamic calculations for a single position cannot use a base. */
792 if ((pc
->type
== POS_ALL
|| pc
->type
== POS_ALL_PBC
)
793 && (pc
->flags
& POS_DYNAMIC
))
801 * Checks whether two position calculations should use a common base.
803 * \param[in] pc1 Calculation 1 to check for.
804 * \param[in] pc2 Calculation 2 to check for.
805 * \param[in] g1 Index group structure that contains the atoms from
807 * \param[in,out] g Working space, should have enough allocated memory to
808 * contain the intersection of the atoms in \p pc1 and \p pc2.
809 * \returns true if the two calculations should be merged to use a common
810 * base, false otherwise.
813 should_merge(gmx_ana_poscalc_t
*pc1
, gmx_ana_poscalc_t
*pc2
,
814 gmx_ana_index_t
*g1
, gmx_ana_index_t
*g
)
818 /* Do not merge calculations with different mass weighting. */
819 if ((pc1
->flags
& POS_MASS
) != (pc2
->flags
& POS_MASS
))
823 /* Avoid messing up complete calculations. */
824 if ((pc1
->flags
& POS_COMPLWHOLE
) != (pc2
->flags
& POS_COMPLWHOLE
))
828 /* Find the overlap between the calculations. */
829 gmx_ana_index_set(&g2
, pc2
->b
.nra
, pc2
->b
.a
, 0);
830 gmx_ana_index_intersection(g
, g1
, &g2
);
831 /* Do not merge if there is no overlap. */
836 /* Full completion calculations always match if the type is correct. */
837 if ((pc1
->flags
& POS_COMPLWHOLE
) && (pc2
->flags
& POS_COMPLWHOLE
)
838 && pc1
->type
== pc2
->type
)
842 /* The calculations also match if the intersection consists of full
844 if (gmx_ana_index_has_full_ablocks(g
, &pc1
->b
)
845 && gmx_ana_index_has_full_ablocks(g
, &pc2
->b
))
853 * Creates a static base for position calculation.
855 * \param pc Data structure to copy.
856 * \returns Pointer to a newly allocated base for \p pc.
858 * Creates and returns a deep copy of \p pc, but clears the
859 * \ref POS_DYNAMIC and \ref POS_MASKONLY flags.
860 * The newly created structure is set as the base (\c gmx_ana_poscalc_t::sbase)
861 * of \p pc and inserted in the collection before \p pc.
863 static gmx_ana_poscalc_t
*
864 create_simple_base(gmx_ana_poscalc_t
*pc
)
866 gmx_ana_poscalc_t
*base
;
869 flags
= pc
->flags
& ~(POS_DYNAMIC
| POS_MASKONLY
);
870 base
= pc
->coll
->createCalculation(pc
->type
, flags
);
871 set_poscalc_maxindex(base
, &pc
->gmax
, true);
873 base
->p
= new gmx_ana_pos_t();
876 pc
->coll
->removeCalculation(base
);
877 pc
->coll
->insertCalculation(base
, pc
);
883 * Merges a calculation into another calculation such that the new calculation
884 * can be used as a base.
886 * \param[in,out] base Base calculation to merge to.
887 * \param[in,out] pc Position calculation to merge to \p base.
889 * After the call, \p base can be used as a base for \p pc (or any calculation
890 * that used it as a base).
891 * It is assumed that any overlap between \p base and \p pc is in complete
892 * blocks, i.e., that the merge is possible.
895 merge_to_base(gmx_ana_poscalc_t
*base
, gmx_ana_poscalc_t
*pc
)
897 gmx_ana_index_t gp
, gb
, g
;
901 base
->flags
|= pc
->flags
& (POS_VELOCITIES
| POS_FORCES
);
902 gmx_ana_index_set(&gp
, pc
->b
.nra
, pc
->b
.a
, 0);
903 gmx_ana_index_set(&gb
, base
->b
.nra
, base
->b
.a
, 0);
904 isize
= gmx_ana_index_difference_size(&gp
, &gb
);
907 gmx_ana_index_clear(&g
);
908 gmx_ana_index_reserve(&g
, base
->b
.nra
+ isize
);
909 /* Find the new blocks */
910 gmx_ana_index_difference(&g
, &gp
, &gb
);
911 /* Count the blocks in g */
915 while (pc
->b
.a
[pc
->b
.index
[bi
]] != g
.index
[i
])
919 i
+= pc
->b
.index
[bi
+1] - pc
->b
.index
[bi
];
923 /* Merge the atoms into a temporary structure */
924 gmx_ana_index_merge(&g
, &gb
, &g
);
925 /* Merge the blocks */
926 srenew(base
->b
.index
, base
->b
.nr
+ bnr
+ 1);
930 bo
= base
->b
.nr
+ bnr
- 1;
931 base
->b
.index
[bo
+1] = i
+ 1;
934 if (bi
< 0 || base
->b
.a
[base
->b
.index
[bi
+1]-1] != g
.index
[i
])
936 i
-= pc
->b
.index
[bj
+1] - pc
->b
.index
[bj
];
941 if (bj
>= 0 && pc
->b
.a
[pc
->b
.index
[bj
+1]-1] == g
.index
[i
])
945 i
-= base
->b
.index
[bi
+1] - base
->b
.index
[bi
];
948 base
->b
.index
[bo
] = i
+ 1;
952 base
->b
.nalloc_index
+= bnr
;
954 base
->b
.nra
= g
.isize
;
956 base
->b
.nalloc_a
= g
.isize
;
957 /* Refresh the gmax field */
958 gmx_ana_index_set(&base
->gmax
, base
->b
.nra
, base
->b
.a
, 0);
963 * Merges two bases into one.
965 * \param[in,out] tbase Base calculation to merge to.
966 * \param[in] mbase Base calculation to merge to \p tbase.
968 * After the call, \p mbase has been freed and \p tbase is used as the base
969 * for all calculations that previously had \p mbase as their base.
970 * It is assumed that any overlap between \p tbase and \p mbase is in complete
971 * blocks, i.e., that the merge is possible.
974 merge_bases(gmx_ana_poscalc_t
*tbase
, gmx_ana_poscalc_t
*mbase
)
976 gmx_ana_poscalc_t
*pc
;
978 merge_to_base(tbase
, mbase
);
979 mbase
->coll
->removeCalculation(mbase
);
980 /* Set tbase as the base for all calculations that had mbase */
981 pc
= tbase
->coll
->first_
;
984 if (pc
->sbase
== mbase
)
993 gmx_ana_poscalc_free(mbase
);
997 * Setups the static base calculation for a position calculation.
999 * \param[in,out] pc Position calculation to setup the base for.
1002 setup_base(gmx_ana_poscalc_t
*pc
)
1004 gmx_ana_poscalc_t
*base
, *pbase
, *next
;
1005 gmx_ana_index_t gp
, g
;
1007 /* Exit immediately if pc should not have a base. */
1008 if (!can_use_base(pc
))
1013 gmx_ana_index_set(&gp
, pc
->b
.nra
, pc
->b
.a
, 0);
1014 gmx_ana_index_clear(&g
);
1015 gmx_ana_index_reserve(&g
, pc
->b
.nra
);
1017 base
= pc
->coll
->first_
;
1020 /* Save the next calculation so that we can safely delete base */
1022 /* Skip pc, calculations that already have a base (we should match the
1023 * base instead), as well as calculations that should not have a base.
1024 * If the above conditions are met, check whether we should do a
1027 if (base
!= pc
&& !base
->sbase
&& can_use_base(base
)
1028 && should_merge(pbase
, base
, &gp
, &g
))
1030 /* Check whether this is the first base found */
1033 /* Create a real base if one is not present */
1036 pbase
= create_simple_base(base
);
1042 /* Make it a base for pc as well */
1043 merge_to_base(pbase
, pc
);
1047 else /* This was not the first base */
1051 /* If it is not a real base, just make the new base as
1052 * the base for it as well. */
1053 merge_to_base(pbase
, base
);
1054 base
->sbase
= pbase
;
1059 /* If base is a real base, merge it with the new base
1061 merge_bases(pbase
, base
);
1064 gmx_ana_index_set(&gp
, pbase
->b
.nra
, pbase
->b
.a
, 0);
1065 gmx_ana_index_reserve(&g
, pc
->b
.nra
);
1067 /* Proceed to the next unchecked calculation */
1071 gmx_ana_index_deinit(&g
);
1073 /* If no base was found, create one if one is required */
1074 if (!pc
->sbase
&& (pc
->flags
& POS_DYNAMIC
)
1075 && (pc
->flags
& (POS_COMPLMAX
| POS_COMPLWHOLE
)))
1077 create_simple_base(pc
);
1082 * \param[in,out] pc Position calculation data structure.
1083 * \param[in] flags New flags.
1085 * \p flags are added to the old flags.
1086 * If calculation type is \ref POS_ATOM, \ref POS_MASS is automatically
1088 * If both \ref POS_DYNAMIC and \ref POS_MASKONLY are provided,
1089 * \ref POS_DYNAMIC is cleared.
1090 * If calculation type is not \ref POS_RES or \ref POS_MOL,
1091 * \ref POS_COMPLMAX and \ref POS_COMPLWHOLE are automatically cleared.
1094 gmx_ana_poscalc_set_flags(gmx_ana_poscalc_t
*pc
, int flags
)
1096 if (pc
->type
== POS_ATOM
)
1100 if (flags
& POS_MASKONLY
)
1102 flags
&= ~POS_DYNAMIC
;
1104 if (pc
->type
!= POS_RES
&& pc
->type
!= POS_MOL
)
1106 flags
&= ~(POS_COMPLMAX
| POS_COMPLWHOLE
);
1112 * \param[in,out] pc Position calculation data structure.
1113 * \param[in] g Maximum index group for the calculation.
1115 * Subsequent calls to gmx_ana_poscalc_update() should use only subsets of
1116 * \p g for evaluation.
1118 * The topology should have been set for the collection of which \p pc is
1122 gmx_ana_poscalc_set_maxindex(gmx_ana_poscalc_t
*pc
, gmx_ana_index_t
*g
)
1124 set_poscalc_maxindex(pc
, g
, false);
1129 * \param[in] pc Position calculation data structure.
1130 * \param[out] p Output positions.
1132 * Calls to gmx_ana_poscalc_update() using \p pc should use only positions
1133 * initialized with this function.
1134 * The \c p->g pointer is initialized to point to an internal group that
1135 * contains the maximum index group set with gmx_ana_poscalc_set_maxindex().
1138 gmx_ana_poscalc_init_pos(gmx_ana_poscalc_t
*pc
, gmx_ana_pos_t
*p
)
1140 gmx_ana_indexmap_init(&p
->m
, &pc
->gmax
, pc
->coll
->top_
, pc
->itype
);
1141 /* Only do the static optimization when there is no completion */
1142 if (!(pc
->flags
& POS_DYNAMIC
) && pc
->b
.nra
== pc
->gmax
.isize
)
1144 gmx_ana_indexmap_set_static(&p
->m
, &pc
->b
);
1146 gmx_ana_pos_reserve(p
, p
->m
.mapb
.nr
, -1);
1147 if (pc
->flags
& POS_VELOCITIES
)
1149 gmx_ana_pos_reserve_velocities(p
);
1151 if (pc
->flags
& POS_FORCES
)
1153 gmx_ana_pos_reserve_forces(p
);
1158 * \param pc Position calculation data to be freed.
1160 * The \p pc pointer is invalid after the call.
1163 gmx_ana_poscalc_free(gmx_ana_poscalc_t
*pc
)
1171 if (pc
->refcount
> 0)
1176 pc
->coll
->removeCalculation(pc
);
1177 if (pc
->b
.nalloc_index
> 0)
1181 if (pc
->b
.nalloc_a
> 0)
1185 if (pc
->flags
& POS_COMPLWHOLE
)
1187 gmx_ana_index_deinit(&pc
->gmax
);
1192 gmx_ana_poscalc_free(pc
->sbase
);
1198 gmx::PositionCalculationCollection::RequiredTopologyInfo
1199 gmx_ana_poscalc_required_topology_info(gmx_ana_poscalc_t
*pc
)
1201 return gmx::requiredTopologyInfo(pc
->type
, pc
->flags
);
1205 * \param[in] pc Position calculation data.
1206 * \param[in,out] p Output positions, initialized previously with
1207 * gmx_ana_poscalc_init_pos() using \p pc.
1208 * \param[in] g Index group to use for the update.
1209 * \param[in] fr Current frame.
1210 * \param[in] pbc PBC data, or NULL if no PBC should be used.
1212 * gmx_ana_poscalc_init_frame() should be called for each frame before calling
1216 gmx_ana_poscalc_update(gmx_ana_poscalc_t
*pc
, gmx_ana_pos_t
*p
,
1217 gmx_ana_index_t
*g
, t_trxframe
*fr
, const t_pbc
*pbc
)
1221 if (pc
->bEval
== true && !(pc
->flags
& POS_MASKONLY
))
1227 gmx_ana_poscalc_update(pc
->sbase
, nullptr, nullptr, fr
, pbc
);
1238 /* Update the index map */
1239 if (pc
->flags
& POS_DYNAMIC
)
1241 gmx_ana_indexmap_update(&p
->m
, g
, false);
1243 else if (pc
->flags
& POS_MASKONLY
)
1245 gmx_ana_indexmap_update(&p
->m
, g
, true);
1251 if (!(pc
->flags
& POS_DYNAMIC
))
1256 /* Evaluate the positions */
1259 /* TODO: It might be faster to evaluate the positions within this
1260 * loop instead of in the beginning. */
1261 if (pc
->flags
& POS_DYNAMIC
)
1263 for (bi
= 0; bi
< p
->count(); ++bi
)
1265 bj
= pc
->baseid
[p
->m
.refid
[bi
]];
1266 copy_rvec(pc
->sbase
->p
->x
[bj
], p
->x
[bi
]);
1270 for (bi
= 0; bi
< p
->count(); ++bi
)
1272 bj
= pc
->baseid
[p
->m
.refid
[bi
]];
1273 copy_rvec(pc
->sbase
->p
->v
[bj
], p
->v
[bi
]);
1278 for (bi
= 0; bi
< p
->count(); ++bi
)
1280 bj
= pc
->baseid
[p
->m
.refid
[bi
]];
1281 copy_rvec(pc
->sbase
->p
->f
[bj
], p
->f
[bi
]);
1287 for (bi
= 0; bi
< p
->count(); ++bi
)
1289 bj
= pc
->baseid
[bi
];
1290 copy_rvec(pc
->sbase
->p
->x
[bj
], p
->x
[bi
]);
1294 for (bi
= 0; bi
< p
->count(); ++bi
)
1296 bj
= pc
->baseid
[bi
];
1297 copy_rvec(pc
->sbase
->p
->v
[bj
], p
->v
[bi
]);
1302 for (bi
= 0; bi
< p
->count(); ++bi
)
1304 bj
= pc
->baseid
[bi
];
1305 copy_rvec(pc
->sbase
->p
->f
[bj
], p
->f
[bi
]);
1310 else /* pc->sbase is NULL */
1312 if (pc
->flags
& POS_DYNAMIC
)
1314 pc
->b
.nr
= p
->m
.mapb
.nr
;
1315 pc
->b
.index
= p
->m
.mapb
.index
;
1316 pc
->b
.nra
= g
->isize
;
1319 if (p
->v
&& !fr
->bV
)
1321 for (i
= 0; i
< pc
->b
.nra
; ++i
)
1323 clear_rvec(p
->v
[i
]);
1326 if (p
->f
&& !fr
->bF
)
1328 for (i
= 0; i
< pc
->b
.nra
; ++i
)
1330 clear_rvec(p
->f
[i
]);
1333 gmx::ConstArrayRef
<int> index
= pc
->coll
->getFrameIndices(pc
->b
.nra
, pc
->b
.a
);
1334 const gmx_mtop_t
*top
= pc
->coll
->top_
;
1335 const bool bMass
= pc
->flags
& POS_MASS
;
1339 for (i
= 0; i
< pc
->b
.nra
; ++i
)
1341 copy_rvec(fr
->x
[index
[i
]], p
->x
[i
]);
1345 for (i
= 0; i
< pc
->b
.nra
; ++i
)
1347 copy_rvec(fr
->v
[index
[i
]], p
->v
[i
]);
1352 for (i
= 0; i
< pc
->b
.nra
; ++i
)
1354 copy_rvec(fr
->f
[index
[i
]], p
->f
[i
]);
1359 gmx_calc_comg(top
, fr
->x
, index
.size(), index
.data(), bMass
, p
->x
[0]);
1362 gmx_calc_comg(top
, fr
->v
, index
.size(), index
.data(), bMass
, p
->v
[0]);
1366 gmx_calc_comg_f(top
, fr
->f
, index
.size(), index
.data(), bMass
, p
->f
[0]);
1370 gmx_calc_comg_pbc(top
, fr
->x
, pbc
, index
.size(), index
.data(), bMass
, p
->x
[0]);
1373 gmx_calc_comg(top
, fr
->v
, index
.size(), index
.data(), bMass
, p
->v
[0]);
1377 gmx_calc_comg_f(top
, fr
->f
, index
.size(), index
.data(), bMass
, p
->f
[0]);
1381 // TODO: It would probably be better to do this without the type casts.
1382 gmx_calc_comg_block(top
, fr
->x
, reinterpret_cast<t_block
*>(&pc
->b
),
1383 index
.data(), bMass
, p
->x
);
1386 gmx_calc_comg_block(top
, fr
->v
, reinterpret_cast<t_block
*>(&pc
->b
),
1387 index
.data(), bMass
, p
->v
);
1391 gmx_calc_comg_f_block(top
, fr
->f
, reinterpret_cast<t_block
*>(&pc
->b
),
1392 index
.data(), bMass
, p
->f
);