3 * This source code is part of
7 * GROningen MAchine for Chemical Simulations
9 * Written by David van der Spoel, Erik Lindahl, Berk Hess, and others.
10 * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
11 * Copyright (c) 2001-2009, The GROMACS development team,
12 * check out http://www.gromacs.org for more information.
14 * This program is free software; you can redistribute it and/or
15 * modify it under the terms of the GNU General Public License
16 * as published by the Free Software Foundation; either version 2
17 * of the License, or (at your option) any later version.
19 * If you want to redistribute modifications, please consider that
20 * scientific software is very special. Version control is crucial -
21 * bugs must be traceable. We will be happy to consider code for
22 * inclusion in the official distribution, but derived work must not
23 * be called official GROMACS. Details are found in the README & COPYING
24 * files - if they are missing, get the official version at www.gromacs.org.
26 * To help us fund GROMACS development, we humbly ask that you cite
27 * the papers on the package - you can find them in the top README file.
29 * For more info, check our website at http://www.gromacs.org
33 * Implementation of functions in selparam.h.
44 #include <selmethod.h>
47 #include "parsetree.h"
52 * \param[in] name Name of the parameter to search.
53 * \param[in] nparam Number of parameters in the \p param array.
54 * \param[in] param Parameter array to search.
55 * \returns Pointer to the parameter in the \p param
56 * or NULL if no parameter with name \p name was found.
58 * The comparison is case-sensitive.
61 gmx_ana_selparam_find(const char *name
, int nparam
, gmx_ana_selparam_t
*param
)
69 /* Find the first non-null parameter */
71 while (i
< nparam
&& param
[i
].name
== NULL
)
75 /* Process the special case of a NULL parameter */
78 return (i
== 0) ? NULL
: ¶m
[i
-1];
80 for ( ; i
< nparam
; ++i
)
82 if (!strcmp(param
[i
].name
, name
))
86 /* Check for 'no' prefix on boolean parameters */
87 if (param
[i
].val
.type
== NO_VALUE
88 && strlen(name
) > 2 && name
[0] == 'n' && name
[1] == 'o'
89 && !strcmp(param
[i
].name
, name
+2))
98 * Does a type conversion on a \c t_selexpr_value.
100 * \param[in,out] value Value to convert.
101 * \param[in] type Type to convert to.
102 * \param[in] scanner Scanner data structure.
103 * \returns 0 on success, a non-zero value on error.
106 convert_value(t_selexpr_value
*value
, e_selvalue_t type
, void *scanner
)
108 if (value
->type
== type
|| type
== NO_VALUE
)
114 /* Conversion from atom selection to position using default
115 * reference positions. */
116 if (value
->type
== GROUP_VALUE
&& type
== POS_VALUE
)
119 _gmx_sel_init_position(value
->u
.expr
, NULL
, FALSE
, scanner
);
120 if (value
->u
.expr
== NULL
)
131 /* Integers to floating point are easy */
132 if (value
->type
== INT_VALUE
&& type
== REAL_VALUE
)
134 value
->u
.r
.r1
= (real
)value
->u
.i
.i1
;
135 value
->u
.r
.r2
= (real
)value
->u
.i
.i2
;
139 /* Reals that are integer-valued can also be converted */
140 if (value
->type
== REAL_VALUE
&& type
== INT_VALUE
141 && gmx_within_tol(value
->u
.r
.r1
, (int)value
->u
.r
.r1
, GMX_REAL_EPS
)
142 && gmx_within_tol(value
->u
.r
.r2
, (int)value
->u
.r
.r2
, GMX_REAL_EPS
))
144 value
->u
.i
.i1
= (int)value
->u
.r
.r1
;
145 value
->u
.i
.i2
= (int)value
->u
.r
.r2
;
154 * Does a type conversion on a list of values.
156 * \param[in,out] value Values to convert.
157 * \param[in] type Type to convert to.
158 * \param[in] scanner Scanner data structure.
159 * \returns 0 on success, a non-zero value on error.
162 convert_values(t_selexpr_value
*values
, e_selvalue_t type
, void *scanner
)
164 t_selexpr_value
*value
;
171 rc1
= convert_value(value
, type
, scanner
);
172 if (rc1
!= 0 && rc
== 0)
178 /* FIXME: More informative error messages */
183 * Comparison function for sorting integer ranges.
185 * \param[in] a Pointer to the first range.
186 * \param[in] b Pointer to the second range.
187 * \returns -1, 0, or 1 depending on the relative order of \p a and \p b.
189 * The ranges are primarily sorted based on their starting point, and
190 * secondarily based on length (longer ranges come first).
193 cmp_int_range(const void *a
, const void *b
)
195 if (((int *)a
)[0] < ((int *)b
)[0])
199 if (((int *)a
)[0] > ((int *)b
)[0])
203 if (((int *)a
)[1] > ((int *)b
)[1])
211 * Comparison function for sorting real ranges.
213 * \param[in] a Pointer to the first range.
214 * \param[in] b Pointer to the second range.
215 * \returns -1, 0, or 1 depending on the relative order of \p a and \p b.
217 * The ranges are primarily sorted based on their starting point, and
218 * secondarily based on length (longer ranges come first).
221 cmp_real_range(const void *a
, const void *b
)
223 if (((real
*)a
)[0] < ((real
*)b
)[0])
227 if (((real
*)a
)[0] > ((real
*)b
)[0])
231 if (((real
*)a
)[1] > ((real
*)b
)[1])
239 * Parses the values for a parameter that takes integer or real ranges.
241 * \param[in] nval Number of values in \p values.
242 * \param[in] values Pointer to the list of values.
243 * \param param Parameter to parse.
244 * \returns TRUE if the values were parsed successfully, FALSE otherwise.
247 parse_values_range(int nval
, t_selexpr_value
*values
, gmx_ana_selparam_t
*param
)
249 t_selexpr_value
*value
;
254 param
->flags
&= ~SPAR_DYNAMIC
;
255 if (param
->val
.type
!= INT_VALUE
&& param
->val
.type
!= REAL_VALUE
)
257 gmx_bug("internal error");
262 if (param
->val
.type
== INT_VALUE
)
276 _gmx_selparser_error("expressions not supported within range parameters");
279 if (value
->type
!= param
->val
.type
)
281 gmx_bug("internal error");
284 if (param
->val
.type
== INT_VALUE
)
286 /* Make sure the input range is in increasing order */
287 if (value
->u
.i
.i1
> value
->u
.i
.i2
)
289 int tmp
= value
->u
.i
.i1
;
290 value
->u
.i
.i1
= value
->u
.i
.i2
;
293 /* Check if the new range overlaps or extends the previous one */
294 if (i
> 0 && value
->u
.i
.i1
<= idata
[i
-1]+1 && value
->u
.i
.i2
>= idata
[i
-2]-1)
296 idata
[i
-2] = min(idata
[i
-2], value
->u
.i
.i1
);
297 idata
[i
-1] = max(idata
[i
-1], value
->u
.i
.i2
);
301 idata
[i
++] = value
->u
.i
.i1
;
302 idata
[i
++] = value
->u
.i
.i2
;
307 /* Make sure the input range is in increasing order */
308 if (value
->u
.r
.r1
> value
->u
.r
.r2
)
310 real tmp
= value
->u
.r
.r1
;
311 value
->u
.r
.r1
= value
->u
.r
.r2
;
314 /* Check if the new range overlaps or extends the previous one */
315 if (i
> 0 && value
->u
.r
.r1
<= rdata
[i
-1] && value
->u
.r
.r2
>= rdata
[i
-2])
317 rdata
[i
-2] = min(rdata
[i
-2], value
->u
.r
.r1
);
318 rdata
[i
-1] = max(rdata
[i
-1], value
->u
.r
.r2
);
322 rdata
[i
++] = value
->u
.r
.r1
;
323 rdata
[i
++] = value
->u
.r
.r2
;
329 /* Sort the ranges and merge consequent ones */
330 if (param
->val
.type
== INT_VALUE
)
332 qsort(idata
, n
, 2*sizeof(int), &cmp_int_range
);
333 for (i
= j
= 2; i
< 2*n
; i
+= 2)
335 if (idata
[j
-1]+1 >= idata
[i
])
337 if (idata
[i
+1] > idata
[j
-1])
339 idata
[j
-1] = idata
[i
+1];
345 idata
[j
+1] = idata
[i
+1];
352 qsort(rdata
, n
, 2*sizeof(real
), &cmp_real_range
);
353 for (i
= j
= 2; i
< 2*n
; i
+= 2)
355 if (rdata
[j
-1]+1 >= rdata
[i
])
357 if (rdata
[i
+1] > rdata
[j
-1])
359 rdata
[j
-1] = rdata
[i
+1];
365 rdata
[j
+1] = rdata
[i
+1];
371 /* Store the values */
372 if (param
->flags
& SPAR_VARNUM
)
375 if (param
->val
.type
== INT_VALUE
)
378 _gmx_selvalue_setstore_alloc(¶m
->val
, idata
, j
);
383 _gmx_selvalue_setstore_alloc(¶m
->val
, rdata
, j
);
388 if (n
!= param
->val
.nr
)
390 _gmx_selparser_error("the value of parameter '%s' should consist of exactly one range",
396 if (param
->val
.type
== INT_VALUE
)
398 memcpy(param
->val
.u
.i
, idata
, 2*n
*sizeof(int));
403 memcpy(param
->val
.u
.r
, rdata
, 2*n
*sizeof(real
));
409 *param
->nvalptr
= param
->val
.nr
;
411 param
->nvalptr
= NULL
;
417 * Parses the values for a parameter that takes a variable number of values.
419 * \param[in] nval Number of values in \p values.
420 * \param[in] values Pointer to the list of values.
421 * \param param Parameter to parse.
422 * \returns TRUE if the values were parsed successfully, FALSE otherwise.
424 * For integer ranges, the sequence of numbers from the first to second value
425 * is stored, each as a separate value.
428 parse_values_varnum(int nval
, t_selexpr_value
*values
, gmx_ana_selparam_t
*param
)
430 t_selexpr_value
*value
;
433 param
->flags
&= ~SPAR_DYNAMIC
;
434 /* Update nval if there are integer ranges. */
435 if (param
->val
.type
== INT_VALUE
)
440 if (value
->type
== INT_VALUE
&& !value
->bExpr
)
442 nval
+= abs(value
->u
.i
.i2
- value
->u
.i
.i1
);
448 /* Check that the value type is actually implemented */
449 if (param
->val
.type
!= INT_VALUE
&& param
->val
.type
!= REAL_VALUE
450 && param
->val
.type
!= STR_VALUE
&& param
->val
.type
!= POS_VALUE
)
452 gmx_bug("internal error");
456 /* Reserve appropriate amount of memory */
457 if (param
->val
.type
== POS_VALUE
)
459 gmx_ana_pos_reserve(param
->val
.u
.p
, nval
, 0);
460 gmx_ana_indexmap_init(¶m
->val
.u
.p
->m
, NULL
, NULL
, INDEX_UNKNOWN
);
464 _gmx_selvalue_reserve(¶m
->val
, nval
);
473 _gmx_selparser_error("expressions not supported within value lists");
476 if (value
->type
!= param
->val
.type
)
478 gmx_bug("internal error");
481 switch (param
->val
.type
)
484 if (value
->u
.i
.i1
<= value
->u
.i
.i2
)
486 for (j
= value
->u
.i
.i1
; j
<= value
->u
.i
.i2
; ++j
)
488 param
->val
.u
.i
[i
++] = j
;
493 for (j
= value
->u
.i
.i1
; j
>= value
->u
.i
.i2
; --j
)
495 param
->val
.u
.i
[i
++] = j
;
500 if (value
->u
.r
.r1
!= value
->u
.r
.r2
)
502 _gmx_selparser_error("real ranges not supported for parameter '%s'", param
->name
);
505 param
->val
.u
.r
[i
++] = value
->u
.r
.r1
;
507 case STR_VALUE
: param
->val
.u
.s
[i
++] = strdup(value
->u
.s
); break;
508 case POS_VALUE
: copy_rvec(value
->u
.x
, param
->val
.u
.p
->x
[i
++]); break;
509 default: /* Should not be reached */
510 gmx_bug("internal error");
518 *param
->nvalptr
= param
->val
.nr
;
520 param
->nvalptr
= NULL
;
526 * Adds a new subexpression reference to a selection element.
528 * \param[in,out] root Root element to which the subexpression is added.
529 * \param[in] param Parameter for which this expression is a value.
530 * \param[in] expr Expression to add.
531 * \returns The created child element.
533 * Creates a new \ref SEL_SUBEXPRREF element and adds it into the child
535 * If \p expr is already a \ref SEL_SUBEXPRREF, it is used as it is.
536 * \ref SEL_ALLOCVAL is cleared for the returned element.
539 add_child(t_selelem
*root
, gmx_ana_selparam_t
*param
, t_selelem
*expr
)
541 gmx_ana_selparam_t
*ps
;
546 if (root
->type
!= SEL_EXPRESSION
&& root
->type
!= SEL_MODIFIER
)
548 gmx_bug("unsupported root element for selection parameter parser");
551 ps
= root
->u
.expr
.method
->param
;
553 /* Create a subexpression reference element if necessary */
554 if (expr
->type
== SEL_SUBEXPRREF
)
560 child
= _gmx_selelem_create(SEL_SUBEXPRREF
);
565 _gmx_selelem_set_vtype(child
, expr
->v
.type
);
568 /* Setup the child element */
569 child
->flags
&= ~SEL_ALLOCVAL
;
570 child
->u
.param
= param
;
571 if (child
->v
.type
!= param
->val
.type
)
573 _gmx_selparser_error("invalid expression value for parameter '%s'",
577 rc
= _gmx_selelem_update_flags(child
);
582 if ((child
->flags
& SEL_DYNAMIC
) && !(param
->flags
& SPAR_DYNAMIC
))
584 _gmx_selparser_error("parameter '%s' does not support dynamic values",
588 if (!(child
->flags
& SEL_DYNAMIC
))
590 param
->flags
&= ~SPAR_DYNAMIC
;
592 /* Put the child element in the correct place */
593 if (!root
->child
|| n
< root
->child
->u
.param
- ps
)
595 child
->next
= root
->child
;
603 while (prev
->next
&& prev
->next
->u
.param
- ps
>= n
)
607 child
->next
= prev
->next
;
615 _gmx_selelem_free(child
);
621 * Parses an expression value for a parameter that takes a variable number of values.
623 * \param[in] nval Number of values in \p values.
624 * \param[in] values Pointer to the list of values.
625 * \param param Parameter to parse.
626 * \param root Selection element to which child expressions are added.
627 * \returns TRUE if the values were parsed successfully, FALSE otherwise.
630 parse_values_varnum_expr(int nval
, t_selexpr_value
*values
,
631 gmx_ana_selparam_t
*param
, t_selelem
*root
)
633 t_selexpr_value
*value
;
637 if (nval
!= 1 || !values
->bExpr
)
639 gmx_bug("internal error");
644 child
= add_child(root
, param
, value
->u
.expr
);
645 value
->u
.expr
= NULL
;
651 /* Process single-valued expressions */
652 /* TODO: We should also handle SEL_SINGLEVAL expressions here */
653 if (child
->v
.type
== POS_VALUE
|| child
->v
.type
== GROUP_VALUE
)
655 /* Set the value storage */
656 _gmx_selvalue_setstore(&child
->v
, param
->val
.u
.ptr
);
660 *param
->nvalptr
= param
->val
.nr
;
662 param
->nvalptr
= NULL
;
666 if (!(child
->flags
& SEL_VARNUMVAL
))
668 _gmx_selparser_error("invalid expression value for parameter '%s'",
674 *param
->nvalptr
= param
->val
.nr
;
675 /* Rest of the initialization is done during compilation in
682 * Initializes the storage of an expression value.
684 * \param[in,out] sel Selection element that evaluates the value.
685 * \param[in] param Parameter to receive the value.
686 * \param[in] i The value of \p sel evaluates the value \p i for
689 * Initializes the data pointer of \p sel such that the result is stored
690 * as the value \p i of \p param.
691 * This function is used internally by parse_values_std().
694 set_expr_value_store(t_selelem
*sel
, gmx_ana_selparam_t
*param
, int i
)
696 if (sel
->v
.type
!= GROUP_VALUE
&& !(sel
->flags
& SEL_SINGLEVAL
))
698 _gmx_selparser_error("invalid expression value for parameter '%s'",
704 case INT_VALUE
: sel
->v
.u
.i
= ¶m
->val
.u
.i
[i
]; break;
705 case REAL_VALUE
: sel
->v
.u
.r
= ¶m
->val
.u
.r
[i
]; break;
706 case STR_VALUE
: sel
->v
.u
.s
= ¶m
->val
.u
.s
[i
]; break;
707 case POS_VALUE
: sel
->v
.u
.p
= ¶m
->val
.u
.p
[i
]; break;
708 case GROUP_VALUE
: sel
->v
.u
.g
= ¶m
->val
.u
.g
[i
]; break;
710 gmx_bug("internal error");
718 * Parses the values for a parameter that takes a constant number of values.
720 * \param[in] nval Number of values in \p values.
721 * \param[in] values Pointer to the list of values.
722 * \param param Parameter to parse.
723 * \param root Selection element to which child expressions are added.
724 * \returns TRUE if the values were parsed successfully, FALSE otherwise.
726 * For integer ranges, the sequence of numbers from the first to second value
727 * is stored, each as a separate value.
730 parse_values_std(int nval
, t_selexpr_value
*values
, gmx_ana_selparam_t
*param
,
733 t_selexpr_value
*value
;
738 /* Handle atom-valued parameters */
739 if (param
->flags
& SPAR_ATOMVAL
)
743 _gmx_selparser_error("extra values for parameter '%s'", param
->name
);
749 child
= add_child(root
, param
, value
->u
.expr
);
750 value
->u
.expr
= NULL
;
755 if (child
->v
.type
!= GROUP_VALUE
&& (child
->flags
& SEL_ATOMVAL
))
757 /* Rest of the initialization is done during compilation in
759 /* TODO: Positions are not correctly handled */
763 *param
->nvalptr
= -1;
767 param
->flags
&= ~SPAR_ATOMVAL
;
773 param
->nvalptr
= NULL
;
774 if (param
->val
.type
== INT_VALUE
|| param
->val
.type
== REAL_VALUE
775 || param
->val
.type
== STR_VALUE
)
777 _gmx_selvalue_reserve(¶m
->val
, 1);
779 return set_expr_value_store(child
, param
, 0);
781 /* If we reach here, proceed with normal parameter handling */
783 if (param
->val
.type
== INT_VALUE
|| param
->val
.type
== REAL_VALUE
784 || param
->val
.type
== STR_VALUE
)
786 _gmx_selvalue_reserve(¶m
->val
, 1);
788 param
->flags
&= ~SPAR_ATOMVAL
;
789 param
->flags
&= ~SPAR_DYNAMIC
;
795 while (value
&& i
< param
->val
.nr
)
797 if (value
->type
!= param
->val
.type
)
799 _gmx_selparser_error("incorrect value for parameter '%s' skipped", param
->name
);
805 child
= add_child(root
, param
, value
->u
.expr
);
806 /* Clear the expression from the value once it is stored */
807 value
->u
.expr
= NULL
;
808 /* Check that the expression is valid */
813 if (!set_expr_value_store(child
, param
, i
))
817 if (child
->flags
& SEL_DYNAMIC
)
824 /* Value is not an expression */
828 if (value
->u
.i
.i1
<= value
->u
.i
.i2
)
830 for (j
= value
->u
.i
.i1
; j
<= value
->u
.i
.i2
&& i
< param
->val
.nr
; ++j
)
832 param
->val
.u
.i
[i
++] = j
;
834 if (j
!= value
->u
.i
.i2
+ 1)
836 _gmx_selparser_error("extra values for parameter '%s' skipped", param
->name
);
841 for (j
= value
->u
.i
.i1
; j
>= value
->u
.i
.i2
&& i
< param
->val
.nr
; --j
)
843 param
->val
.u
.i
[i
++] = j
;
845 if (j
!= value
->u
.i
.i2
- 1)
847 _gmx_selparser_error("extra values for parameter '%s' skipped", param
->name
);
853 if (value
->u
.r
.r1
!= value
->u
.r
.r2
)
855 _gmx_selparser_error("real ranges not supported for parameter '%s'", param
->name
);
858 param
->val
.u
.r
[i
] = value
->u
.r
.r1
;
861 param
->val
.u
.s
[i
] = strdup(value
->u
.s
);
864 gmx_ana_pos_init_const(¶m
->val
.u
.p
[i
], value
->u
.x
);
868 gmx_bug("internal error");
877 _gmx_selparser_error("extra values for parameter '%s'", param
->name
);
880 if (i
< param
->val
.nr
)
882 _gmx_selparser_error("not enough values for parameter '%s'", param
->name
);
887 param
->flags
&= ~SPAR_DYNAMIC
;
891 *param
->nvalptr
= param
->val
.nr
;
893 param
->nvalptr
= NULL
;
899 * Parses the values for a boolean parameter.
901 * \param[in] name Name by which the parameter was given.
902 * \param[in] nval Number of values in \p values.
903 * \param[in] values Pointer to the list of values.
904 * \param param Parameter to parse.
905 * \returns TRUE if the values were parsed successfully, FALSE otherwise.
908 parse_values_bool(const char *name
, int nval
, t_selexpr_value
*values
, gmx_ana_selparam_t
*param
)
913 if (param
->val
.type
!= NO_VALUE
)
915 gmx_bug("internal error");
918 if (nval
> 1 || (values
&& values
->type
!= INT_VALUE
))
920 _gmx_selparser_error("boolean parameter '%s' takes only a yes/no/on/off/0/1 value", param
->name
);
925 /* Check if the parameter name is given with a 'no' prefix */
927 if (len
> 2 && name
[0] == 'n' && name
[1] == 'o'
928 && strncmp(name
+2, param
->name
, len
-2) == 0)
932 if (bSetNo
&& nval
> 0)
934 _gmx_selparser_error("boolean parameter 'no%s' should not have a value", param
->name
);
937 if (values
&& values
->u
.i
.i1
== 0)
942 *param
->val
.u
.b
= bSetNo
? FALSE
: TRUE
;
947 * Parses the values for an enumeration parameter.
949 * \param[in] nval Number of values in \p values.
950 * \param[in] values Pointer to the list of values.
951 * \param param Parameter to parse.
952 * \returns TRUE if the values were parsed successfully, FALSE otherwise.
955 parse_values_enum(int nval
, t_selexpr_value
*values
, gmx_ana_selparam_t
*param
)
961 _gmx_selparser_error("a single value is required for parameter '%s'", param
->name
);
964 if (values
->type
!= STR_VALUE
|| param
->val
.type
!= STR_VALUE
)
966 gmx_bug("internal error");
971 _gmx_selparser_error("expression value for enumerated parameter '%s' not supported", param
->name
);
975 len
= strlen(values
->u
.s
);
978 while (param
->val
.u
.s
[i
] != NULL
)
980 if (strncmp(values
->u
.s
, param
->val
.u
.s
[i
], len
) == 0)
982 /* Check if there is a duplicate match */
985 _gmx_selparser_error("ambiguous value for parameter '%s'", param
->name
);
994 _gmx_selparser_error("invalid value for parameter '%s'", param
->name
);
997 param
->val
.u
.s
[0] = param
->val
.u
.s
[match
];
1002 * Replaces constant expressions with their values.
1004 * \param[in,out] values First element in the value list to process.
1007 convert_const_values(t_selexpr_value
*values
)
1009 t_selexpr_value
*val
;
1014 if (val
->bExpr
&& val
->u
.expr
->v
.type
!= GROUP_VALUE
&&
1015 val
->u
.expr
->type
== SEL_CONST
)
1017 t_selelem
*expr
= val
->u
.expr
;
1019 switch (expr
->v
.type
)
1022 val
->u
.i
.i1
= val
->u
.i
.i2
= expr
->v
.u
.i
[0];
1025 val
->u
.r
.r1
= val
->u
.r
.r2
= expr
->v
.u
.r
[0];
1028 copy_rvec(expr
->v
.u
.p
->x
[0], val
->u
.x
);
1031 gmx_bug("internal error");
1034 _gmx_selelem_free(expr
);
1041 * \param pparams List of parameters from the selection parser.
1042 * \param[in] nparam Number of parameters in \p params.
1043 * \param params Array of parameters to parse.
1044 * \param root Selection element to which child expressions are added.
1045 * \param[in] scanner Scanner data structure.
1046 * \returns TRUE if the parameters were parsed successfully, FALSE otherwise.
1048 * Initializes the \p params array based on the parameters in \p pparams.
1049 * See the documentation of \c gmx_ana_selparam_t for different options
1050 * available for parsing.
1052 * The list \p pparams and any associated values are freed after the parameters
1053 * have been processed, no matter is there was an error or not.
1056 _gmx_sel_parse_params(t_selexpr_param
*pparams
, int nparam
, gmx_ana_selparam_t
*params
,
1057 t_selelem
*root
, void *scanner
)
1059 t_selexpr_param
*pparam
;
1060 gmx_ana_selparam_t
*oparam
;
1064 /* Check that the value pointers of SPAR_VARNUM parameters are NULL and
1065 * that they are not NULL for other parameters */
1067 for (i
= 0; i
< nparam
; ++i
)
1069 if (params
[i
].val
.type
!= POS_VALUE
&& (params
[i
].flags
& (SPAR_VARNUM
| SPAR_ATOMVAL
)))
1071 if (params
[i
].val
.u
.ptr
!= NULL
)
1073 _gmx_selparser_error("warning: value pointer of parameter '%s' is not NULL\n"
1074 " although it should be for SPAR_VARNUM and SPAR_ATOMVAL parameters\n",
1077 if ((params
[i
].flags
& SPAR_VARNUM
)
1078 && (params
[i
].flags
& SPAR_DYNAMIC
) && !params
[i
].nvalptr
)
1080 _gmx_selparser_error("error: nvalptr of parameter '%s' is NULL\n"
1081 " but both SPAR_VARNUM and SPAR_DYNAMIC are specified\n",
1088 if (params
[i
].val
.u
.ptr
== NULL
)
1090 _gmx_selparser_error("error: value pointer of parameter '%s' is NULL\n",
1098 _gmx_selexpr_free_params(pparams
);
1101 /* Parse the parameters */
1106 /* Find the parameter and make some checks */
1107 if (pparam
->name
!= NULL
)
1110 oparam
= gmx_ana_selparam_find(pparam
->name
, nparam
, params
);
1114 oparam
= ¶ms
[i
];
1115 if (oparam
->name
!= NULL
)
1118 _gmx_selparser_error("too many NULL parameters provided");
1126 _gmx_selparser_error("all NULL parameters should appear in the beginning of the list");
1128 pparam
= pparam
->next
;
1133 _gmx_selparser_error("unknown parameter '%s' skipped", pparam
->name
);
1137 if (oparam
->flags
& SPAR_SET
)
1139 _gmx_selparser_error("parameter '%s' set multiple times, extra values skipped", pparam
->name
);
1143 oparam
->flags
|= SPAR_SET
;
1144 /* Process the values for the parameter */
1145 convert_const_values(pparam
->value
);
1146 if (convert_values(pparam
->value
, oparam
->val
.type
, scanner
) != 0)
1148 _gmx_selparser_error("invalid value for parameter '%s'", pparam
->name
);
1152 if (oparam
->val
.type
== NO_VALUE
)
1154 rc
= parse_values_bool(pparam
->name
, pparam
->nval
, pparam
->value
, oparam
);
1156 else if (oparam
->flags
& SPAR_RANGES
)
1158 rc
= parse_values_range(pparam
->nval
, pparam
->value
, oparam
);
1160 else if (oparam
->flags
& SPAR_VARNUM
)
1162 if (pparam
->nval
== 1 && pparam
->value
->bExpr
)
1164 rc
= parse_values_varnum_expr(pparam
->nval
, pparam
->value
, oparam
, root
);
1168 rc
= parse_values_varnum(pparam
->nval
, pparam
->value
, oparam
);
1171 else if (oparam
->flags
& SPAR_ENUMVAL
)
1173 rc
= parse_values_enum(pparam
->nval
, pparam
->value
, oparam
);
1177 rc
= parse_values_std(pparam
->nval
, pparam
->value
, oparam
, root
);
1183 /* Advance to the next parameter */
1185 pparam
= pparam
->next
;
1187 /* Check that all required parameters are present */
1188 for (i
= 0; i
< nparam
; ++i
)
1190 if (!(params
[i
].flags
& SPAR_OPTIONAL
) && !(params
[i
].flags
& SPAR_SET
))
1192 _gmx_selparser_error("required parameter '%s' not specified", params
[i
].name
);
1197 _gmx_selexpr_free_params(pparams
);