Gromacs
2020.4
|
#include "gmxpre.h"
#include "compiler.h"
#include <cmath>
#include <cstdarg>
#include <algorithm>
#include "gromacs/math/vec.h"
#include "gromacs/selection/indexutil.h"
#include "gromacs/selection/selection.h"
#include "gromacs/utility/exceptions.h"
#include "gromacs/utility/gmxassert.h"
#include "gromacs/utility/smalloc.h"
#include "gromacs/utility/stringutil.h"
#include "evaluate.h"
#include "keywords.h"
#include "mempool.h"
#include "poscalc.h"
#include "selectioncollection_impl.h"
#include "selelem.h"
#include "selmethod.h"
Selection compilation and optimization.
Classes | |
struct | t_compiler_data |
Internal data structure used by the compiler. More... | |
Typedefs | |
typedef struct t_compiler_data | t_compiler_data |
Internal data structure used by the compiler. More... | |
Enumerations | |
enum | { SEL_CDATA_FULLEVAL = 1, SEL_CDATA_STATIC = 2, SEL_CDATA_STATICEVAL = 4, SEL_CDATA_EVALMAX = 8, SEL_CDATA_MINMAXALLOC = 16, SEL_CDATA_DOMINMAX = 256, SEL_CDATA_SIMPLESUBEXPR = 32, SEL_CDATA_STATICMULTIEVALSUBEXPR = 64, SEL_CDATA_COMMONSUBEXPR = 128 } |
Compiler flags. More... | |
Functions | |
static void | print_group_info (FILE *fp, const char *name, const SelectionTreeElement &sel, gmx_ana_index_t *g) |
Helper method for printing out debug information about a min/max group. | |
void | _gmx_selelem_print_compiler_info (FILE *fp, const SelectionTreeElement &sel, int level) |
Prints a human-readable version of the internal compiler data structure. More... | |
static void | alloc_selection_data (const SelectionTreeElementPointer &sel, int isize, bool bChildEval) |
Allocates memory for storing the evaluated value of a selection element. More... | |
static void | alloc_selection_pos_data (const SelectionTreeElementPointer &sel) |
Allocates memory for storing the evaluated value of a selection element. More... | |
static void | set_evaluation_function (const SelectionTreeElementPointer &sel, gmx::sel_evalfunc eval) |
Replace the evaluation function of each element in the subtree. More... | |
static void | init_pos_keyword_defaults (SelectionTreeElement *root, const char *spost, const char *rpost, const gmx::internal::SelectionData *sel) |
Initializes default values for position keyword evaluation. More... | |
static SelectionTreeElementPointer | reverse_selelem_chain (const SelectionTreeElementPointer &root) |
Reverses the chain of selection elements starting at root . More... | |
static SelectionTreeElementPointer | remove_unused_subexpressions (SelectionTreeElementPointer root) |
Removes subexpressions that don't have any references. More... | |
static void | create_subexpression_name (const SelectionTreeElementPointer &sel, int i) |
Creates a name with a running number for a subexpression. More... | |
static SelectionTreeElementPointer | extract_item_subselections (const SelectionTreeElementPointer &sel, int *subexprn) |
Processes and extracts subexpressions from a given selection subtree. More... | |
static SelectionTreeElementPointer | extract_subexpressions (SelectionTreeElementPointer sel) |
Extracts subexpressions of the selection chain. More... | |
static void | optimize_boolean_expressions (const SelectionTreeElementPointer &sel) |
Removes redundant boolean selection elements. More... | |
static void | reorder_boolean_static_children (const SelectionTreeElementPointer &sel) |
Reorders children of boolean expressions such that static selections come first. More... | |
static void | optimize_arithmetic_expressions (const SelectionTreeElementPointer &sel) |
Processes arithmetic expressions to simplify and speed up evaluation. More... | |
static void | init_item_evalfunc (const SelectionTreeElementPointer &sel) |
Sets the evaluation functions for the selection (sub)tree. More... | |
static void | setup_memory_pooling (const SelectionTreeElementPointer &sel, gmx_sel_mempool_t *mempool) |
Sets the memory pool for selection elements that can use it. More... | |
static void | init_item_evaloutput (const SelectionTreeElementPointer &sel) |
Prepares the selection (sub)tree for evaluation. More... | |
static void | init_item_compilerdata (const SelectionTreeElementPointer &sel) |
Allocates memory for the compiler data and initializes the structure. More... | |
static void | init_item_staticeval (const SelectionTreeElementPointer &sel) |
Initializes the static evaluation flag for a selection subtree. More... | |
static void | init_item_subexpr_refcount (const SelectionTreeElementPointer &sel) |
Compute reference counts for subexpressions. More... | |
static void | init_item_subexpr_flags (const SelectionTreeElementPointer &sel) |
Initializes compiler flags for subexpressions. More... | |
static void | init_item_minmax_groups (const SelectionTreeElementPointer &sel) |
Initializes the gmin and gmax fields of the compiler data structure. More... | |
static void | initialize_evalgrps (gmx_ana_selcollection_t *sc) |
Initializes evaluation groups for root items. More... | |
static void | mark_subexpr_dynamic (const SelectionTreeElementPointer &sel, bool bDynamic) |
Marks a subtree completely dynamic or undoes such a change. More... | |
static void | release_subexpr_memory (const SelectionTreeElementPointer &sel) |
Frees memory for subexpressions that are no longer needed. More... | |
static void | make_static (const SelectionTreeElementPointer &sel) |
Makes an evaluated selection element static. More... | |
static void | process_const (gmx_sel_evaluate_t *data, const SelectionTreeElementPointer &sel, gmx_ana_index_t *g) |
Evaluates a constant expression during analyze_static(). More... | |
static void | store_param_val (const SelectionTreeElementPointer &sel) |
Sets the parameter value pointer for SEL_SUBEXPRREF params. More... | |
static void | init_method (const SelectionTreeElementPointer &sel, const gmx_mtop_t *top, int isize) |
Handles the initialization of a selection method during analyze_static() pass. More... | |
static void | evaluate_boolean_static_part (gmx_sel_evaluate_t *data, const SelectionTreeElementPointer &sel, gmx_ana_index_t *g) |
Evaluates the static part of a boolean expression. More... | |
static void | evaluate_boolean_minmax_grps (const SelectionTreeElementPointer &sel, gmx_ana_index_t *g, gmx_ana_index_t *gmin, gmx_ana_index_t *gmax) |
Evaluates the minimum and maximum groups for a boolean expression. More... | |
static void | analyze_static (gmx_sel_evaluate_t *data, const SelectionTreeElementPointer &sel, gmx_ana_index_t *g) |
Evaluates the static parts of sel and analyzes the structure. More... | |
static void | init_root_item (const SelectionTreeElementPointer &root, gmx_ana_index_t *gall) |
Initializes the evaluation group for a SEL_ROOT element. More... | |
static void | init_required_atoms (const SelectionTreeElementPointer &sel, gmx_ana_index_t *requiredAtoms) |
Finds the highest atom index required to evaluate a selection subtree. More... | |
static void | postprocess_item_subexpressions (const SelectionTreeElementPointer &sel) |
Optimizes subexpression evaluation. More... | |
static void | init_item_comg (const SelectionTreeElementPointer &sel, gmx::PositionCalculationCollection *pcc, e_poscalc_t type, int flags) |
Initializes COM/COG calculation for method expressions that require it. More... | |
static void | free_item_compilerdata (const SelectionTreeElementPointer &sel) |
Frees the allocated compiler data recursively. More... | |
typedef struct t_compiler_data t_compiler_data |
Internal data structure used by the compiler.
anonymous enum |
Compiler flags.
Enumerator | |
---|---|
SEL_CDATA_FULLEVAL |
Whether a subexpression needs to evaluated for all atoms. This flag is set for SEL_SUBEXPR elements that are used to evaluate non-atom-valued selection method parameters, as well as those that are used directly as values of selections. |
SEL_CDATA_STATIC |
Whether the whole subexpression should be treated as static. This flag is always false if SEL_DYNAMIC is set for the element, but it is also false for static elements within common subexpressions. |
SEL_CDATA_STATICEVAL |
Whether the subexpression will always be evaluated in the same group. |
SEL_CDATA_EVALMAX |
Whether the compiler evaluation routine should return the maximal selection. |
SEL_CDATA_MINMAXALLOC |
Whether memory has been allocated for |
SEL_CDATA_DOMINMAX |
Whether to update |
SEL_CDATA_SIMPLESUBEXPR |
Whether the subexpression uses simple pass evaluation functions. |
SEL_CDATA_STATICMULTIEVALSUBEXPR |
Whether a static subexpression needs to support multiple evaluations. This flag may only be set on SEL_SUBEXPR elements that also have SEL_CDATA_SIMPLESUBEXPR. |
SEL_CDATA_COMMONSUBEXPR |
Whether this expression is a part of a common subexpression. |
void _gmx_selelem_print_compiler_info | ( | FILE * | fp, |
const SelectionTreeElement & | sel, | ||
int | level | ||
) |
Prints a human-readable version of the internal compiler data structure.
[in] | fp | File handle to receive the output. |
[in] | sel | Selection element to print. |
[in] | level | Indentation level, starting from zero. |
|
static |
Allocates memory for storing the evaluated value of a selection element.
sel | Selection element to initialize | |
[in] | isize | Maximum evaluation group size. |
[in] | bChildEval | true if children have already been processed. |
If called more than once, memory is (re)allocated to ensure that the maximum of the isize
values can be stored.
Allocation of POS_VALUE selection elements is a special case, and is handled by alloc_selection_pos_data().
|
static |
Allocates memory for storing the evaluated value of a selection element.
sel | Selection element to initialize. |
Allocation of POS_VALUE selection elements is a special case, and is handled by this function instead of by alloc_selection_data().
|
static |
Evaluates the static parts of sel
and analyzes the structure.
[in] | data | Evaluation data. |
[in,out] | sel | Selection currently being evaluated. |
[in] | g | Group for which sel should be evaluated. |
This function is used as the replacement for the gmx::SelectionTreeElement::evaluate function pointer. It does the single most complex task in the compiler: after all elements have been processed, the gmin
and gmax
fields of t_compiler_data
have been properly initialized, enough memory has been allocated for storing the value of each expression, and the static parts of the expressions have been evaluated. The above is exactly true only for elements other than subexpressions: another pass is required for subexpressions that are referred to more than once and whose evaluation group is not known in advance.
|
static |
Creates a name with a running number for a subexpression.
[in,out] | sel | The subexpression to be named. |
[in] | i | Running number for the subexpression. |
The name of the selection becomes "SubExpr N", where N is i
; Memory is allocated for the name and the name is stored both as the name of the subexpression element and as gmx::SelectionTreeElement::u::cgrp::name; the latter is freed by _gmx_selelem_free().
|
static |
Evaluates the minimum and maximum groups for a boolean expression.
[in] | sel | SEL_BOOLEAN element currently being evaluated. |
[in] | g | Group for which sel has been evaluated. |
[out] | gmin | Largest subset of the possible values of sel . |
[out] | gmax | Smallest superset of the possible values of sel . |
This is a helper function for analyze_static() that is called for dynamic SEL_BOOLEAN elements after they have been evaluated. It uses the minimum and maximum groups of the children to calculate the minimum and maximum groups for sel
, and also updates the static part of sel
(which is in the first child) if the children give cause for this.
This function may allocate some extra memory for gmin
and gmax
, but as these groups are freed at the end of analyze_static() (which is reached shortly after this function returns), this should not be a major problem.
|
static |
Evaluates the static part of a boolean expression.
[in] | data | Evaluation data. |
[in,out] | sel | Boolean selection element whose children should be processed. |
[in] | g | The evaluation group. |
reorder_item_static_children() should have been called.
|
static |
Processes and extracts subexpressions from a given selection subtree.
sel | Root of the subtree to process. |
subexprn | Pointer to a subexpression counter. |
This function finds recursively all SEL_SUBEXPRREF elements below the given root element and ensures that their children are within SEL_SUBEXPR elements. It also creates a chain of SEL_ROOT elements that contain the subexpression as their children and returns the first of these root elements.
|
static |
Extracts subexpressions of the selection chain.
sel | First selection in the whole selection chain. |
Finds all the subexpressions (and their subexpressions) in the selection chain starting from sel
and creates SEL_SUBEXPR elements for them. SEL_ROOT elements are also created for each subexpression and inserted into the selection chain before the expressions that refer to them.
|
static |
Frees the allocated compiler data recursively.
sel | Root of the selection subtree to process. |
Frees the data allocated for the compilation process.
|
static |
Initializes COM/COG calculation for method expressions that require it.
sel | Selection subtree to process. | |
[in,out] | pcc | Position calculation collection to use. |
[in] | type | Default position calculation type. |
[in] | flags | Flags for default position calculation. |
Searches recursively through the selection tree for dynamic SEL_EXPRESSION elements that define the gmx_ana_selmethod_t::pupdate
function. For each such element found, position calculation is initialized for the maximal evaluation group. The type of the calculation is determined by type
and flags
. No calculation is initialized if type
equals POS_ATOM and the method also defines the gmx_ana_selmethod_t::update
method.
|
static |
Allocates memory for the compiler data and initializes the structure.
sel | Root of the selection subtree to process. |
|
static |
Sets the evaluation functions for the selection (sub)tree.
[in,out] | sel | Root of the selection subtree to process. |
This function sets the evaluation function (gmx::SelectionTreeElement::evaluate) for the selection elements.
|
static |
Prepares the selection (sub)tree for evaluation.
[in,out] | sel | Root of the selection subtree to prepare. |
It also allocates memory for the sel->v.u.g
or sel->v.u.p
structure if required.
|
static |
Initializes the gmin and gmax fields of the compiler data structure.
sel | Root of the selection subtree to process. |
|
static |
Initializes the static evaluation flag for a selection subtree.
[in,out] | sel | Root of the selection subtree to process. |
Sets the bStaticEval
in the compiler data structure: for any element for which the evaluation group may depend on the trajectory frame, the flag is cleared.
reorder_boolean_static_children() should have been called.
|
static |
Initializes compiler flags for subexpressions.
sel | Root of the selection subtree to process. |
|
static |
Compute reference counts for subexpressions.
sel | Root of the selection subtree to process. |
|
static |
Handles the initialization of a selection method during analyze_static() pass.
[in,out] | sel | Selection element to process. |
[in] | top | Topology structure. |
[in] | isize | Size of the evaluation group for the element. |
Calls sel_initfunc() (and possibly sel_outinitfunc()) to initialize the method. If no SPAR_ATOMVAL parameters are present, multiple initialization is prevented by using SEL_METHODINIT and SEL_OUTINIT flags.
|
static |
Initializes default values for position keyword evaluation.
[in,out] | root | Root of the element tree to initialize. |
[in] | spost | Default output position type. |
[in] | rpost | Default reference position type. |
[in] | sel | Selection that the element evaluates the positions for, or NULL if the element is an internal element. |
|
static |
Finds the highest atom index required to evaluate a selection subtree.
[in] | sel | Root of the selection subtree to process. |
[in,out] | requiredAtoms | The atoms required to evaluate the subtree. The existing group is only added to, so multiple calls with the same parameter will compute the union over several subtrees. |
For evaluation that starts from a SEL_ROOT element with a fixed group, children will never extend the evaluation group except for method parameter evaluation (which have their own root element), so it is sufficient to check the root. However, children of SEL_EXPRESSION elements (i.e., the method parameters) may have been independently evaluated to a static group that no longer has a separate root, so those need to be checked as well.
Position calculations are not considered here, but are analyzed through the position calculation collection in the main compilation method.
|
static |
Initializes the evaluation group for a SEL_ROOT element.
root | Root element to initialize. | |
[in] | gall | Group of all atoms. |
Checks whether it is necessary to evaluate anything through the root element, and either clears the evaluation function or initializes the evaluation group.
|
static |
Initializes evaluation groups for root items.
[in,out] | sc | Selection collection data. |
The evaluation group of each SEL_ROOT element corresponding to a selection in sc
is set to NULL. The evaluation group for SEL_ROOT elements corresponding to subexpressions that need full evaluation is set to sc->gall
.
|
static |
Makes an evaluated selection element static.
sel | Selection element to make static. |
The evaluated value becomes the value of the static element. The element type is changed to SEL_CONST and the children are deleted.
|
static |
Marks a subtree completely dynamic or undoes such a change.
sel | Selection subtree to mark. | |
[in] | bDynamic | If true, the bStatic flag of the whole selection subtree is cleared. If false, the flag is restored to using SEL_DYNAMIC. |
Does not descend into parameters of methods unless the parameters are evaluated for each atom.
|
static |
Processes arithmetic expressions to simplify and speed up evaluation.
sel | Root of the selection subtree to process. |
Currently, this function only converts integer constants to reals within arithmetic expressions.
|
static |
Removes redundant boolean selection elements.
sel | Root of the selection subtree to optimize. |
This function merges similar boolean operations (e.g., (A or B) or C becomes a single OR operation with three operands).
|
static |
Optimizes subexpression evaluation.
sel | Root of the selection subtree to process. |
Optimizes away some unnecessary evaluation of subexpressions that are only referenced once.
|
static |
Evaluates a constant expression during analyze_static().
[in] | data | Evaluation data. |
[in,out] | sel | Selection to process. |
[in] | g | The evaluation group. |
|
static |
Frees memory for subexpressions that are no longer needed.
sel | Selection subtree to check. |
Checks whether the subtree rooted at sel
refers to any SEL_SUBEXPR elements that are not referred to by anything else except their own root element. If such elements are found, all memory allocated for them is freed except the actual element. The element is left because otherwise a dangling pointer would be left at the root element, which is not traversed by this function. Later compilation passes remove the stub elements.
|
static |
Removes subexpressions that don't have any references.
root | First selection in the whole selection chain. |
The elements are processed in reverse order to correctly detect subexpressions only referred to by other subexpressions.
|
static |
Reorders children of boolean expressions such that static selections come first.
sel | Root of the selection subtree to reorder. |
The relative order of static expressions does not change. The same is true for the dynamic expressions.
|
static |
Reverses the chain of selection elements starting at root
.
root | First selection in the whole selection chain. |
|
static |
Replace the evaluation function of each element in the subtree.
sel | Root of the selection subtree to process. | |
[in] | eval | The new evaluation function. |
|
static |
Sets the memory pool for selection elements that can use it.
sel | Root of the selection subtree to process. | |
[in] | mempool | Memory pool to use. |
|
static |
Sets the parameter value pointer for SEL_SUBEXPRREF params.
[in,out] | sel | Selection to process. |
Copies the value pointer of sel
to sel->u.param
if one is present and should receive the value from the compiler (most parameter values are handled during parsing). If sel
is not of type SEL_SUBEXPRREF, or if sel->u.param
is NULL, the function does nothing. Also, if the sel->u.param
does not have SPAR_VARNUM or SPAR_ATOMVAL, the function returns immediately.