pntool-developers Mailing List for A Concurrency Tool Suite (Page 8)
Brought to you by:
compaqdrew,
miordache
You can subscribe to this list here.
2009 |
Jan
|
Feb
|
Mar
|
Apr
|
May
|
Jun
(69) |
Jul
(86) |
Aug
(33) |
Sep
|
Oct
|
Nov
|
Dec
|
---|---|---|---|---|---|---|---|---|---|---|---|---|
2011 |
Jan
|
Feb
|
Mar
|
Apr
(3) |
May
(3) |
Jun
(1) |
Jul
(10) |
Aug
(2) |
Sep
(1) |
Oct
|
Nov
|
Dec
|
2012 |
Jan
|
Feb
|
Mar
|
Apr
|
May
|
Jun
|
Jul
|
Aug
(2) |
Sep
|
Oct
|
Nov
|
Dec
|
From: <Ste...@us...> - 2009-06-22 22:13:42
|
Revision: 93 http://pntool.svn.sourceforge.net/pntool/?rev=93&view=rev Author: StephenCamp Date: 2009-06-22 22:12:37 +0000 (Mon, 22 Jun 2009) Log Message: ----------- Changed private subroutines declarations in ilpadm.c, isadm.c, linenf.c, msplit.c, nltrans.c to 'static' to hide the routines from each other when linking. Fixed a bug in nltrans: linear programming problem constraint types were inverted. Extended functionality of the StructuredIO test functions: added support for an array-of-arrays type. pn2eacpn.c is PARTIALLY tested. The test script, test-pn2eacpn.txt, does not yet contain complete tests. test-pn2eacpn, the test routine for pn2eacpn, is functional. Modified Paths: -------------- spnbox/ilpadm.c spnbox/isadm.c spnbox/linenf.c spnbox/msplit.c spnbox/nltrans.c spnbox/pn2acpn.c spnbox/spnbox.h spnbox/tests/StructuredIO.c spnbox/tests/test-nltrans.txt spnbox/tests/test-pn2acpn.mak Added Paths: ----------- spnbox/pn2eacpn.c spnbox/tests/test-pn2eacpn.c spnbox/tests/test-pn2eacpn.mak spnbox/tests/test-pn2eacpn.txt Property Changed: ---------------- spnbox/tests/ Modified: spnbox/ilpadm.c =================================================================== --- spnbox/ilpadm.c 2009-06-21 19:27:39 UTC (rev 92) +++ spnbox/ilpadm.c 2009-06-22 22:12:37 UTC (rev 93) @@ -4,7 +4,7 @@ #include "matrixmath.h" #include "MemoryManager.h" -void disp(char* beginning, char* parameter, char* end, int i, int p, int verbose); +static void disp(char* beginning, char* parameter, char* end, int i, int p, int verbose); ilpadm_r ilpadm(matrix* L, int* b, matrix* D, int TucCount, int* Tuc, int TuoCount, int* Tuo, int* m0, int verbose) { Modified: spnbox/isadm.c =================================================================== --- spnbox/isadm.c 2009-06-21 19:27:39 UTC (rev 92) +++ spnbox/isadm.c 2009-06-22 22:12:37 UTC (rev 93) @@ -5,11 +5,11 @@ /*CheckParam checks most of the parameters passed to isadm to make sure they are valid and returns the number of constraints or zero for bad parameters. It displays all necessary error messages if bad parameters are encountered.*/ -int CheckParam(matrix* Dm, matrix* Dp, matrix* L, matrix* F, matrix* C); +static int CheckParam(matrix* Dm, matrix* Dp, matrix* L, matrix* F, matrix* C); /*StructuralAnalysis does the actual analysis to determine constraint admissibility. It returns v as an array of integers.*/ -int* StructuralAnalysis(matrix* D, matrix* L, matrix* F, matrix* C, int TucCount, int* Tuc, int TuoCount, int* Tuo); +static int* StructuralAnalysis(matrix* D, matrix* L, matrix* F, matrix* C, int TucCount, int* Tuc, int TuoCount, int* Tuo); int* isadm(matrix* Dm, matrix* Dp, matrix* L, int* b, int* m0, matrix* F, matrix* C, int TucCount, int* Tuc, int TuoCount, int* Tuo) { Modified: spnbox/linenf.c =================================================================== --- spnbox/linenf.c 2009-06-21 19:27:39 UTC (rev 92) +++ spnbox/linenf.c 2009-06-22 22:12:37 UTC (rev 93) @@ -5,7 +5,7 @@ #include "matrixmath.h" -typedef struct InitTransformedNet_r + typedef struct InitTransformedNet_r { int RowsAddedC; int* CColumns; @@ -16,35 +16,35 @@ /*This function does some basic checking to make sure parameters are as they should be. It returns the number of constraints or -1 in case any parameters are invalid.*/ -int CheckParams(matrix* Dm, matrix* Dp, matrix* L, int* b, int* m0, matrix* F, matrix* C); +static int CheckParams(matrix* Dm, matrix* Dp, matrix* L, int* b, int* m0, matrix* F, matrix* C); /*This function checks to see if the constraint row specified by Row is inadmissible. It returns a logic 1 if the constraint is inadmissible and a 0 otherwise.*/ -int Inadmissible(int Row, matrix* D, matrix* L, matrix* F, matrix* C, int TucCount, int* Tuc, int TuoCount, int* Tuo); +static int Inadmissible(int Row, matrix* D, matrix* L, matrix* F, matrix* C, int TucCount, int* Tuc, int TuoCount, int* Tuo); /*InitTransformedNet counts how many rows and columns will need to be added to the i/o matrices of the Petri net to account for the new constraints being added, alloces the space, and pre-copies the existing i/o matrices into the appropriate places in the new ones.*/ -InitTransformedNet_r InitTransformedNet(int Row, MemoryManager* memory, matrix* Dm, matrix* Dp, matrix* OldDm, matrix* OldDp, matrix* F, matrix* C, int TucCount, int* Tuc); +static InitTransformedNet_r InitTransformedNet(int Row, MemoryManager* memory, matrix* Dm, matrix* Dp, matrix* OldDm, matrix* OldDp, matrix* F, matrix* C, int TucCount, int* Tuc); /*TransformC2L transforms the C constraints into marking constraints which it adds to the current marking constraint row. It adds new places to the Petri net for the new constraints to refer to, and establishes a few transition/place links.*/ -void TransformC2L(int Row, matrix* C, matrix* LRow, matrix* Dp, int FirstDRow); +static void TransformC2L(int Row, matrix* C, matrix* LRow, matrix* Dp, int FirstDRow); /*TransformF2L transforms the F constraints into marking constraints which it adds to the current marking constraint row. It adds new places to the Petri net for the new constraints to refer to, and establishes a few transition/place links.*/ -void TransformF2L(int Row, matrix* F, matrix* LRow, matrix* Dm, matrix* Dp, int TucCount, int* Tuc, int StartRow, int StartCol); +static void TransformF2L(int Row, matrix* F, matrix* LRow, matrix* Dm, matrix* Dp, int TucCount, int* Tuc, int StartRow, int StartCol); /*FindInSet returns the index of the integer find in the array pointed to by set. If find is not found, -1 is returned.*/ -int FindInSet(int find, int* set, int SetSize); +static int FindInSet(int find, int* set, int SetSize); /*CollapseNet takes the results of enforcing (and transformation, if it was done) the current constraint row and collapses it back into the Petri net that will be returned. It also copies transformed constraints to the structure to be returned.*/ -void CollapseNet(int ConstraintRow, linenf_r *Enforced, InitTransformedNet_r *Transform, linenf_r *Final, int Places, int Transitions); +static void CollapseNet(int ConstraintRow, linenf_r *Enforced, InitTransformedNet_r *Transform, linenf_r *Final, int Places, int Transitions); linenf_r linenf(matrix* Dm, matrix* Dp, matrix* L, int* b, int* m0, matrix* F, matrix* C, int TucCount, int* Tuc, int TuoCount, int* Tuo) { Modified: spnbox/msplit.c =================================================================== --- spnbox/msplit.c 2009-06-21 19:27:39 UTC (rev 92) +++ spnbox/msplit.c 2009-06-22 22:12:37 UTC (rev 93) @@ -6,26 +6,26 @@ matrices for the given transition, based on the current number of transitions and places and the number of transitions that are being added.*/ -void ModifyD(msplit_r* Ret, int Places, int Transitions, int NewTransitions, int Transition); +static void ModifyD(msplit_r* Ret, int Places, int Transitions, int NewTransitions, int Transition); /*ModifyTD fills out the elements of array of dead-transition arrays for the current transition.*/ -void ModifyTD(msplit_r* Ret, int Transition, int NewTransitions, int TDCount); +static void ModifyTD(msplit_r* Ret, int Transition, int NewTransitions, int TDCount); /*ModifyML0 modifies ML0 for the current transition.*/ -void ModifyML0(msplit_r* Ret, int* ipl, int ipCount, int* dpl, int MColCount, int L0ColCount, int Transition, int NewTransitions); +static void ModifyML0(msplit_r* Ret, int* ipl, int ipCount, int* dpl, int MColCount, int L0ColCount, int Transition, int NewTransitions); /*AllocateTransition space allocates space for and initializes some of the data that will be returned.*/ -void AllocateTransitionSpace(msplit_r* Ret, matrix* Dm, matrix* Dp, int* mask, matrix* M, matrix* L0, matrix* L, int** TD, int* TDCount, int* ipl, int ipCount); +static void AllocateTransitionSpace(msplit_r* Ret, matrix* Dm, matrix* Dp, int* mask, matrix* M, matrix* L0, matrix* L, int** TD, int* TDCount, int* ipl, int ipCount); /*CountNewTransitions returns an integer corresponding to the number of places and transitions that will need to be added to split the given transition.*/ -int CountNewTransitions(matrix* Dm, int Transition); +static int CountNewTransitions(matrix* Dm, int Transition); /*CheckParams checks the validity of the parameters and initializes some of them to default values.*/ -int CheckParams(MemoryManager* mem, matrix* Dm, matrix* Dp, int** mask, matrix* M, matrix* L0, matrix* L, int** ipl, int* ipCount, int** dpl, int* dpCount, int*** TD, int** TDCount); +static int CheckParams(MemoryManager* mem, matrix* Dm, matrix* Dp, int** mask, matrix* M, matrix* L0, matrix* L, int** ipl, int* ipCount, int** dpl, int* dpCount, int*** TD, int** TDCount); msplit_r msplit(matrix* Dm, matrix* Dp, int* mask, matrix* M, matrix* L0, matrix* L, int* ipl, int ipCount, int* dpl, int dpCount, int** TD, int* TDCount) { Modified: spnbox/nltrans.c =================================================================== --- spnbox/nltrans.c 2009-06-21 19:27:39 UTC (rev 92) +++ spnbox/nltrans.c 2009-06-22 22:12:37 UTC (rev 93) @@ -1,8 +1,8 @@ #include "MemoryManager.h" #include "spnbox.h" -int CheckParams(matrix* D, int** URT, int* urtCount); -int BuildIntegerProblem(MemoryManager* mem, matrix* D, int* URT, int urtCount, matrix* M, double** F, double** B, short int** IntList, short int** ctype); +static int CheckParams(matrix* D, int** URT, int* urtCount); +static int BuildIntegerProblem(MemoryManager* mem, matrix* D, int* URT, int urtCount, matrix* M, double** F, double** B, short int** IntList, short int** ctype); nltrans_r nltrans(matrix* D, int* UnraisableTransitions, int urtCount) { @@ -143,28 +143,13 @@ (*B) = mcalloc(mem, Constraints, sizeof(double)); (*B)[Constraints - 1] = 1.0; - /*The intlist should be ones for all but the items corresponding to already - unraisable transitions.*/ + /*The intlist should be zeros - nothing should be constrained as an integer.*/ (*IntList) = mcalloc(mem, Vars, sizeof(short int)); - for (i = 0; i < Vars; i++) - { - //See if the current intlist element corresponds to a URT. - for (j = 0; j < urtCount; j++) - { - if (i == URT[j]) break; - } - /*If it does not, set the current element to 1.*/ - if (urtCount && j == urtCount) - { - (*IntList)[i] = 1; - } - } - /*All constraints but the last are >=. The last is an equality.*/ + + /*All constraints but the last are =. The last is >=*/ (*ctype) = mcalloc(mem, Constraints, sizeof(short int)); - for (i = 0; i < Constraints - 1; i++) - { - (*ctype)[i] = 1; - } + (*ctype)[Constraints - 1] = 1; + /*The return value is the number of variables that will be used for cov.*/ return NumberOfColumns(*D); } Modified: spnbox/pn2acpn.c =================================================================== --- spnbox/pn2acpn.c 2009-06-21 19:27:39 UTC (rev 92) +++ spnbox/pn2acpn.c 2009-06-22 22:12:37 UTC (rev 93) @@ -3,19 +3,19 @@ #include "matrixmath.h" /*Subroutine declarations. See subroutine implementation for descriptions.*/ -void AddPlaces(pn2acpn_r* result, matrix* Dm, int Transition, int* Qflag, int QLength, int* ipl, int ipCount, int* dpl, int dpCount); +static void AddPlaces(pn2acpn_r* result, matrix* Dm, int Transition, int* Qflag, int QLength, int* ipl, int ipCount, int* dpl, int dpCount); -int GetQPlace(matrix* U, int Pair, int* Qflag, int* mask, pn2acpn_r* result); +static int GetQPlace(matrix* U, int Pair, int* Qflag, int* mask, pn2acpn_r* result); -matrix GetU(int* cardbt, pn2acpn_r* result, int Transition, int OriginalPlaces); +static matrix GetU(int* cardbt, pn2acpn_r* result, int Transition, int OriginalPlaces); -int InitParts(MemoryManager* mem, pn2acpn_r* result, int** cardbt, int** cardbtx, int** Qflag, matrix* Dm, matrix* Dp, matrix* MX, matrix* L0); +static int InitParts(MemoryManager* mem, pn2acpn_r* result, int** cardbt, int** cardbtx, int** Qflag, matrix* Dm, matrix* Dp, matrix* MX, matrix* L0); -int CheckParams(MemoryManager* mem, matrix* Dm, matrix* Dp, int** Mask, matrix* MX, matrix* L0, matrix* L, int **ipl, int *ipCount, int **dpl, int *dpCount); +static int CheckParams(MemoryManager* mem, matrix* Dm, matrix* Dp, int** Mask, matrix* MX, matrix* L0, matrix* L, int **ipl, int *ipCount, int **dpl, int *dpCount); -int CheckParams(MemoryManager* mem, matrix* Dm, matrix* Dp, int** Mask, matrix* MX, matrix* L0, matrix* L, int **ipl, int *ipCount, int **dpl, int *dpCount); +static int CheckParams(MemoryManager* mem, matrix* Dm, matrix* Dp, int** Mask, matrix* MX, matrix* L0, matrix* L, int **ipl, int *ipCount, int **dpl, int *dpCount); -void FinalizeResult(pn2acpn_r* result, matrix* L, matrix* Dm, int* ipl, int ipCount); +static void FinalizeResult(pn2acpn_r* result, matrix* L, matrix* Dm, int* ipl, int ipCount); /*The function itself. pn2acpn transforms a Petri net to an asymmetric choice Petri net*/ Added: spnbox/pn2eacpn.c =================================================================== --- spnbox/pn2eacpn.c (rev 0) +++ spnbox/pn2eacpn.c 2009-06-22 22:12:37 UTC (rev 93) @@ -0,0 +1,754 @@ +#include "MemoryManager.h" +#include "spnbox.h" +#include "matrixmath.h" + +/*Subroutine declarations. See subroutine implementation for descriptions.*/ +static void AddPlaces(pn2eacpn_r* result, matrix* Dm, int Transition, int* Qflag, int QLength, int* ipl, int ipCount, int* dpl, int dpCount); + +static int GetQPlace(matrix* U, int Pair, int* Qflag, int* mask, pn2eacpn_r* result); + +static matrix GetU(int* cardbt, pn2eacpn_r* result, int Transition, int **TD, int *TDCount); + +static int InitParts(MemoryManager* mem, pn2eacpn_r* result, int** cardbt, int** cardbtx, int** Qflag, matrix* Dm, matrix* Dp, matrix* MX, matrix* L0, int** TD, int *TDCount); + +static int CheckParams(MemoryManager* mem, matrix* Dm, matrix* Dp, int** Mask, matrix* MX, matrix* L0, matrix* L, int **ipl, int *ipCount, int **dpl, int *dpCount, int*** TD, int** TDCount); + +static void FinalizeResult(pn2eacpn_r* result, matrix* L, matrix* Dm, int* ipl, int ipCount); + +static int ProcessPlace(int Transition, int Place, matrix* Dm, matrix* Dp, int** TD, int* TDCount); + +/*The function itself. pn2acpn transforms a Petri net to an asymmetric choice +Petri net*/ +pn2eacpn_r pn2eacpn(matrix* Dm, matrix* Dp, int* Mask, matrix* MX, matrix* L0, matrix* L, int *ipl, int ipCount, int* dpl, int dpCount, int** TD, int* TDCount) +{ + int Transition, Transitions, Places, i, j, x; + int *cardbt, *cardbtx, *Qflag; + MemoryManager mem; + matrix U; + pn2eacpn_r result; + + /*Initialize the value to be returned to an error value.*/ + memset(&result, 0, sizeof(pn2eacpn_r)); + + /*Initialize the memory manager.*/ + mem = CreateMemoryManager(10, 5, 0, 0); + + if (! CheckParams(&mem, Dm, Dp, &Mask, MX, L0, L, &ipl, &ipCount, &dpl, &dpCount, &TD, &TDCount)) + { + return result; + } + Places = NumberOfRows(*Dm); + Transitions = NumberOfColumns(*Dm); + + /*Initialize parts of the return value and the flag matrices cardbt and + cardbtx. This function returns the index of the first transition which should + be processed.*/ + Transition = InitParts(&mem, &result, &cardbt, &cardbtx, &Qflag, Dm, Dp, MX, L0, TD, TDCount); + + /*Loop until there are no more transitions to be processed. This will be when + Transition has been set to -1 by either of the functions responsible for + finding the next transition to be processed.*/ + while (Transition >= 0) + { + + cardbtx[Transition] = 0; + /*Get U, a 2xn matrix each column of which contains a pair of place + indices for which a particular relationship holds.*/ + U = GetU(cardbt, &result, Transition, TD, TDCount); + + /*Iterate through each of the place pairs. From each pair we will develop + the index of a single place, for which we will set the Q-flag and with + which we will make an alteration to the cardbtx flag array.*/ + /*The Q-flag array defaults to all cleared.*/ + memset(Qflag, 0, sizeof(int) * Places); + for (i = 0; i < NumberOfColumns(U); i++) + { + /*Get the index of some particular place algorithmically.*/ + if ((x = GetQPlace(&U, i, Qflag, Mask, &result)) >= 0) + { + /*Set the corresponding q flag.*/ + Qflag[x] = 1; + /*We OR cardbtx with cardbt AND the place from Dm*/ + for (j = 0; j < NumberOfColumns(*Dm); j++) + { + cardbtx[j] = cardbtx[j] || (cardbt[j] && GetMatrixEl(Dm, x, j)); + } + } + } + /*Free the memory allocated for the U vector now that we don't need it + anymore.*/ + DeallocateMatrix(&U); + /*Fill in the new places and transitions we reserved memory for above. Fill + in the unraisable transition arrays for the new transitions.*/ + AddPlaces(&result, Dm, Transition, Qflag, Places, ipl, ipCount, dpl, dpCount); + /*Clear the current element of cardbtx in case it was reset some how.*/ + cardbtx[Transition] = 0; + /*Find the next transition to be processed. This will be the first one with + a set cardbtx flag. The next transition number defaults to -1 to indicate + that there are no more transitions to be processed.*/ + Transition = -1; + for (i = 0; i < Transitions; i++) + { + if (cardbtx[i]) + { + Transition = i; + break; + } + } + } + /*Finalize the result structure; fill in the last few values.*/ + FinalizeResult(&result, L, Dm, ipl, ipCount); + FreeMemory(&mem); + return result; +} + + +/************************************************** + Subroutines +**************************************************/ +/* +FinalizeResult takes the result structure and fills in values that are not +computed during the main processing loop: the incidence matrix Df, the new +marking constraint matrix Lf, and the new independent place list iplf. +*/ +void FinalizeResult(pn2eacpn_r* result, matrix* L, matrix* Dm, int* ipl, int ipCount) +{ + int places, oldplaces, i, place, newplaces; + /*Fill the incidence matrix.*/ + result->Df = SubtractMatrix(&result->Dpf, &result->Dmf, (matrix*) 2); + + oldplaces = NumberOfRows(*Dm); + places = NumberOfRows(result->Df); + newplaces = places - oldplaces; + + /*The new L matrix should be the same as the old with columns of zeros added + for all the new places.*/ + if (L) + { + AllocateMatrixType(2, &result->LF, NumberOfRows(*L), NumberOfColumns(*L) + newplaces); + CopyBlock(NumberOfRows(*L), NumberOfColumns(*L), L, 0, 0, &result->LF, 0, 0); + } + + /*The new independent place list should contain all the places that were + added and each of the old places.*/ + result->iplfCount = ipCount + (places - oldplaces); + result->iplf = tcalloc(result->iplfCount, sizeof(int)); + for (i = 0; i < ipCount; i++) + { + result->iplf[i] = ipl[i]; + } + place = oldplaces; + for (; i < result->iplfCount; i++) + { + result->iplf[i] = place++; + } + +} + +/* +AddPlaces is responsible for filling in the values in the transitions and +places that are added during each iteration of the main processing loop. It +fills in values in the Petri net matrices, in the initial marking constraint +matrix L0f, in the independent-to-dependent marking transformation matrix MXf, +and in the unraisable transition arrays for the newly-created transitions. +It requires the result vector, the original output matrix, the transition +currently being processed by the main processing loop, the vector of Q flags, +the length of the vector of Q flags, and the lists of dependent and independent +places. +*/ +void AddPlaces(pn2eacpn_r* result, matrix* Dm, int Transition, int* Qflag, int Qlength, int* ipl, int ipCount, int* dpl, int dpCount) +{ + int Rows, Cols, i, j, x, ToAdd = 0; + matrix Dmf, Dpf, MX, L0; + int **TD; + int *TDCount; + + /*We will be adding a place and transition for each set Qflag. Count them.*/ + for (i = 0; i < Qlength; i++) + { + if (Qflag[i]) ToAdd++; + } + + /*We will be adding new columns to MX and L0. Reseve space and copy + existing columns.*/ + if (NumberOfRows(result->MXF)) + { + AllocateMatrixType(2, &MX, NumberOfRows(result->MXF), NumberOfColumns(result->MXF) + ToAdd); + CopyBlock(NumberOfRows(result->MXF), NumberOfColumns(result->MXF), &result->MXF, 0, 0, &MX, 0, 0); + } + else + { + /*Zero MX.*/ + AllocateMatrix(&MX, 0, 0); + } + if (NumberOfRows(result->L0F)) + { + AllocateMatrixType(2, &L0, NumberOfRows(result->L0F), NumberOfColumns(result->L0F) + ToAdd); + CopyBlock(NumberOfRows(result->L0F), NumberOfColumns(result->L0F), &result->L0F, 0, 0, &L0, 0, 0); + } + else + { + AllocateMatrix(&L0, 0, 0); + } + + /*We add rows and columns to the Petri net matrices. Store them temporarily + in the local Dmf and Dpf matrices. Allocate space and copy the existing + matrices into the new space.*/ + Rows = NumberOfRows(result->Dmf); + Cols = NumberOfColumns(result->Dmf); + AllocateMatrixType(2, &Dmf, Rows + ToAdd, Cols + ToAdd); + AllocateMatrixType(2, &Dpf, Rows + ToAdd, Cols + ToAdd); + CopyBlock(Rows, Cols, &result->Dmf, 0, 0, &Dmf, 0, 0); + CopyBlock(Rows, Cols, &result->Dpf, 0, 0, &Dpf, 0, 0); + + /*We will be adding a new unraisable transition array for each transition + being added. Allocate space for the addresses of the new arrays and copy + the addresses of the existing arrays, which will be reused.*/ + TD = tcalloc(Cols + ToAdd, sizeof(int*)); + TDCount = tcalloc(Cols + ToAdd, sizeof(int)); + for (i = 0; i < Cols; i++) + { + TDCount[i] = result->TDCount[i]; + TD[i] = result->TD[i]; + } + /*The new unraisable transition array for each transition consists of the + unraisable transition array from the transition that got it added (the + current transition) plus the new transition itself. Fill in the new + unraisable transition arrays.*/ + for (i = Cols; i < Cols + ToAdd; i++) + { + TDCount[i] = result->TDCount[Transition] + 1; + TD[i] = tcalloc(TDCount[i], sizeof(int)); + for (j = 0; j < result->TDCount[Transition]; j++) + { + TD[i][j] = result->TD[Transition][j]; + } + TD[i][result->TDCount[Transition]] = i; + } + /*Free the old memory used by the structure and replace it with the new.*/ + free(result->TD); + free(result->TDCount); + result->TD = TD; + result->TDCount = TDCount; + + /*Iterate through the places which have been Q-flagged. At each one add a new + place and transition. Use j to keep track of which place or transition is + being added.*/ + j = 0; + for (i = 0; i < Qlength; i++) + { + if (! Qflag[i]) continue; + /*Zero the output arc at the place and transition of interest*/ + SetMatrixEl(&Dmf, i, Transition, 0); + /*The place gets an output arc added at the new transition*/ + SetMatrixEl(&Dmf, i, Cols + j, 1); + /*The new place gets an input arc added at the new transition*/ + SetMatrixEl(&Dpf, Rows + j, Cols + j, 1); + /*The new place gets an output arc added to the current transition, with + the same weight as the original output arc at the place and transition of + interest.*/ + SetMatrixEl(&Dmf, Rows + j, Transition, GetMatrixEl(Dm, i, Transition)); + /*Modify MX and L0 if they exist.*/ + if (NumberOfRows(MX) || NumberOfRows(L0)) + { + /*Find out if the current place is independent..*/ + for (x = 0; x < ipCount; x++) + { + if (ipl[x] == i) + { + break; + } + } + /*If it is, we want to copy to the new columns of MX and L0 the values + in their respective existing columns corresponding to the independent + place just found. (if they exist)*/ + if (x < ipCount) + { + if (NumberOfRows(MX)) + { + CopyBlock(NumberOfRows(MX), 1, &MX, 0, x, &MX, 0, NumberOfColumns(MX) - ToAdd + j); + } + if (NumberOfRows(L0)) + { + CopyBlock(NumberOfRows(L0), 1, &L0, 0, x, &L0, 0, NumberOfColumns(L0) - ToAdd + j); + } + } + /*If not, we fill the new column of MX with a -1 in the row corresponding + to the dependent place indexed to by i. The new column of L0 remains zeroed.*/ + else + { + /*Get the index of the place.*/ + for (x = 0; x < dpCount; x++) + { + if (dpl[x] == i) break; + } + if (x < dpCount && NumberOfRows(MX)) + { + SetMatrixEl(&MX, x, NumberOfColumns(MX) - ToAdd + j, -1); + } + } + } + /*Increment the added-place counter.*/ + j++; + } + /*Now deallocate the old matrices and replace them with the new.*/ + DeallocateMatrix(&result->Dmf); + result->Dmf = Dmf; + DeallocateMatrix(&result->Dpf); + result->Dpf = Dpf; + if (NumberOfRows(MX)) + { + DeallocateMatrix(&result->MXF); + result->MXF = MX; + } + if (NumberOfRows(L0)) + { + DeallocateMatrix(&result->L0F); + result->L0F = L0; + } +} + +/*GetQPlace examines the pair of place indices in the U matrix that is +currently being processed and selects and returns on of the indicies, to be used +to set a Q-flag and perform operations on the cardbtx flag vector. +It requires the U matrix, the pair number ot process, the vector of Q-flags, +the mask provided to pn2acpn, and the result structure for read access to Dmf +and Dpf.*/ +int GetQPlace(matrix* U, int Pair, int* Qflag, int* mask, pn2eacpn_r* result) +{ + int U1, U2, i, arcCount1, arcCount2; + U1 = GetMatrixEl(U, 0, Pair); + U2 = GetMatrixEl(U, 1, Pair); + + /*If neither U1 nor U2 indexes a place that has a high mask bit, there is no + valid Q index. Return -1.*/ + if (! (mask[U1] || mask[U2])) + { + return -1; + } + /*If only one of U1 or U2 index a place with a high mask bit, that place is + the Q index.*/ + if (mask[U1] && (! mask[U2])) + { + return U1; + } + if ((! mask[U1]) && mask[U2]) + { + return U2; + } + /*Otherwise, we do some other tests to eliminate one of the numbers.*/ + /*If the qflags for both of the U indices are still 0...*/ + if (! (Qflag[U1] || Qflag[U2])) + { + //If we are examining any but the last pair of place indexes: + if (Pair < NumberOfColumns(*U) - 1) + { + /*If the first index in the next pair is the same as the first index in this pair, return that index.*/ + if (U1 == GetMatrixEl(U, 0, Pair + 1)) + { + return U1; + } + else + { + /*Otherwise, if there exist any pairs after the current one such that one of their indicies is the same as the second index of the current pair, return the second index of the current pair.*/ + for (i = Pair + 1; i < NumberOfColumns(*U); i++) + { + if (GetMatrixEl(U, 0, i) == U2 || GetMatrixEl(U, 1, i) == U2) + { + return U2; + } + } + } + } + /*If we get here, then we count the number of nonzero output arcs in the places specified by U1 and U2. We return the index of the place with the most nonzero output arcs.*/ + arcCount1 = 0; + arcCount2 = 0; + for (i = 0; i < NumberOfColumns(result->Dmf); i++) + { + if (GetMatrixEl(&result->Dmf, U1, i)) arcCount1++; + if (GetMatrixEl(&result->Dmf, U2, i)) arcCount2++; + } + if (arcCount1 >= arcCount2) + { + return U1; + } + else + { + return U2; + } + } + //If we get here, no valid place number was found. Return -1. + return -1; +} + +/*GetU creates and returns a 2 x n matrix, each column of which is a pair of +place indices such that the places exhibit some special relationship. The U +matrix is specific to the transition currently being investigated. Its +calculation requires the cardbt flag vector, the result structure for access +to the Petri net matrices, the index of the transition currently being processed, +and a count of the number of places in the original Petri net.*/ +matrix GetU(int* cardbt, pn2eacpn_r* result, int Transition, int **TD, int *TDCount) +{ + int *Row0, *Row1, *PlaceFlag; + int NextCol, ColCapacity, i, j, k, flag0, flag1, Transitions, Places, dmi, dmj; + int iCount, jCount; + matrix U; + + Transitions = NumberOfColumns(result->Dmf); + Places = NumberOfRows(result->Dmf); + + /*U will be a 2xn matrix, where each column contains a pair of place + indices. The pairs are determined algorithmically by examining all places in + the current transition that are nonzero.*/ + + /*It is hard to predict the number of pairs that will be found. Store pairs + in an array that will be reallocated periodically if necessary. Allocated + in blocks the size of the number of places.*/ + Row0 = tcalloc(Places, sizeof(int)); + Row1 = tcalloc(Places, sizeof(int)); + NextCol = 0; + ColCapacity = Places; + + /*We will be processing only a subset of places. Find that subset now + to reduce processing time. Use the ProcessPlace function.*/ + PlaceFlag = tcalloc(Places, sizeof(int)); + for (i = 0; i < Places; i++) + { + PlaceFlag[i] = ProcessPlace(Transition, i, &result->Dmf, &result->Dpf, TD, TDCount); + } + + /*Iterate through all but the last place in the transition of interest. + Process only those places for which ProcessPlace returns a nonzero value.*/ + for (i = 0; i < Places - 1; i++) + { + if (! PlaceFlag[i]) continue; + /*Iterate through all the remaining places for which ProcessTransition + returns true.*/ + for (j = i + 1; j < Places; j++) + { + if (! PlaceFlag[j]) continue; + /*The original Matlab algorithm set a flag according to this + algorithm: (some variable names changed to make it apparent in terms + of variables already used): + prj = Dmf(i,:) ~= 0; % p_j\bullet + prk = Dmf(j,:) ~= 0; % p_k\bullet + flag = sum((~prj) & (prj | prk)) & sum((~prk) & (prj | prk)); + The same operation can be reduced to a pair of examinations, one + to get the results of the operation logical of + sum((~prj) & (prj | prk)) and the next to get the results of the + operation logical of sum((~prk) & (prj | prk))*/ + flag0 = 0; + flag1 = 0; + for (k = 0; k < Transitions; k++) + { + dmi = GetMatrixEl(&result->Dmf, i, k); + dmj = GetMatrixEl(&result->Dmf, j, k); + if ((! dmi) && dmj) + { + flag0 = 1; + } + if ((! dmj) && dmi) + { + flag1 = 1; + } + } + /*If both flags are set, we add the current pair of places to the + U-matrix.*/ + if (flag0 && flag1) + { + /*If there is space left in the temporary holding places, use it. If + not, reallocate with more space.*/ + if (NextCol == ColCapacity) + { + Row0 = realloc(Row0, (ColCapacity += Places) * sizeof(int)); + Row1 = realloc(Row1, (ColCapacity += Places) * sizeof(int)); + } + Row0[NextCol] = i; + Row1[NextCol++] = j; + } + } + } + /*Copy the contents of Row0 and Row1 into the U-matrix.*/ + AllocateMatrixType(2, &U, 2, NextCol); + for (i = 0; i < NextCol; i++) + { + SetMatrixEl(&U, 0, i, Row0[i]); + SetMatrixEl(&U, 1, i, Row1[i]); + } + free(Row0); + free(Row1); + free(PlaceFlag); + + return U; +} + +/* +ProcessPlace returns a nonzero value for a place that should be processed in the +current transition. Any place should be processed which is both a parent and a +grandparent of the current transition, where the grandparent status is via a +transition that is raisable even if the current transition is dead. +*/ +int ProcessPlace(int Transition, int Place, matrix* Dm, matrix* Dp, int** TD, int* TDCount) +{ + int i, j, k; + + /*Check to see if the place is a parent of the transition. If not, fail.*/ + if (! GetMatrixEl(Dm, Place, Transition)) return 0; + + /*Iterate through all child transitions of the place.*/ + for (i = 0; i < NumberOfColumns(*Dm); i++) + { + /*If the current transition is not a child of the place, skip it.*/ + if (! GetMatrixEl(Dm, Place, i)) continue; + + /*If the current transition is unraisable skip it.*/ + k = 0; + for (j = 0; j < TDCount[Transition]; j++) + { + if (TD[Transition][j] == i) + { + k = 1; + break; + } + } + if (k) continue; + + /*Otherwise iterate through each the transition's child places.*/ + for (j = 0; j < NumberOfRows(*Dm); j++) + { + /*If the place is a child of the transition being examined in the loop + and a parent of the transition of interest, then the current place + satisfies the requirements. Return true.*/ + if (GetMatrixEl(Dp, j, i) && GetMatrixEl(Dm, j, Transition)) return 1; + } + } + return 0; +} + +/* +InitParts initializes intermediate variables cardbt and cardbtx, flag arrays, +Qflag, a flag array, and the Petri net matrices in the result structure. +*/ +int InitParts(MemoryManager* mem, pn2eacpn_r* result, int** cardbt, int** cardbtx, int** Qflag, matrix* Dm, matrix* Dp, matrix* MX, matrix* L0, int** TD, int *TDCount) +{ + int Places, Transitions, i, j, res = -1; + Places = NumberOfRows(*Dm); + Transitions = NumberOfColumns(*Dp); + + /*The result Petri net matrices should default to the same as the passed + matrices. The result MX and L0 should also default to the same as the passed + MX and L0, if they were given.*/ + AllocateMatrixType(2, &result->Dmf, Places, Transitions); + CopyMatrix(Dm, &result->Dmf); + AllocateMatrixType(2, &result->Dpf, Places, Transitions); + CopyMatrix(Dp, &result->Dpf); + if (MX) + { + AllocateMatrixType(2, &result->MXF, NumberOfRows(*MX), NumberOfColumns(*MX)); + CopyMatrix(MX, &result->MXF); + } + if (L0) + { + AllocateMatrixType(2, &result->L0F, NumberOfRows(*L0), NumberOfColumns(*L0)); + CopyMatrix(L0, &result->L0F); + } + + /*The Q-flag array has an element for each place.*/ + *Qflag = mcalloc(mem, Places, sizeof(int)); + + /*cardbt and cardbts are flag arrays with elements for each transition. They + default to containing a count of the number of nonzero output arcs associated + with the appropriate transition.*/ + *cardbt = mcalloc(mem, Transitions, sizeof(int)); + *cardbtx = mcalloc(mem, Transitions, sizeof(int)); + /*The return value should be the index of the first transition which will be + processed. This is the index of the first transition such that the associated + value of cardbt is greater than one.*/ + for (i = 0; i < Transitions; i++) + { + for (j = 0; j < Places; j++) + { + if (GetMatrixEl(Dm, j, i)) + { + (*cardbt)[i]++; + (*cardbtx)[i]++; + } + if (res < 0 && (*cardbt)[i] > 1) + { + res = i; + } + } + } + + /*The return TD and TDCount default to what they were. We will be adding + new transitions, but we will not be modifying any unraisabilities of the + original transitions, so the new transitions will get their own unraisability + arrays.*/ + result->TD = tcalloc(Transitions, sizeof(int*)); + result->TDCount = tcalloc(Transitions, sizeof(int)); + for (i = 0; i < Transitions; i++) + { + result->TD[i] = tcalloc(TDCount[i], sizeof(int)); + result->TDCount[i] = TDCount[i]; + for (j = 0; j < TDCount[i]; j++) + { + result->TD[i][j] = TD[i][j]; + } + } + + return res; +} + +/* +CheckParams examines the parameters to make sure that required parameters are +present and dimensions and array counts are consistent. It also fills in default +values where appropriate. +*/ +int CheckParams(MemoryManager* mem, matrix* Dm, matrix* Dp, int** Mask, matrix* MX, matrix* L0, matrix* L, int **ipl, int *ipCount, int **dpl, int *dpCount, int*** TD, int** TDCount) +{ + int Places, Transitions, i, j, k; + nltrans_r URT; + matrix D; + /*Dm - output matrix. Required. Same size as Dp. + Dp - input matrix. Required. Same size as Dm. */ + if (! (Dm && Dp)) + { + merror(0, "PN2ACPN: One of the required parameters Dm or Dp was null"); + return 0; + } + Places = NumberOfRows(*Dm); + Transitions = NumberOfColumns(*Dm); + if (NumberOfRows(*Dp) != Places || NumberOfColumns(*Dm) != Transitions) + { + merror(0, "PN2ACPN: The sizes of the input and output matrices Dp and Dm do not agree"); + return 0; + } + + /*Mask = array of int flags. Not required. Defaults to array of 1s, one for + each place (row of D).*/ + if (! *Mask) + { + (*Mask) = mcalloc(mem, Places, sizeof(int)); + for (i = 0; i < Places; i++) + { + (*Mask)[i] = 1; + } + } + + /*ipl, dpl: unpredictable-length int arrays, holding indices of independent + and dependent places. Not required. If either array pointer is null the count + should be set to zero and vice-versa. + Total number of ipl and dpl must be same as number of places if given. ipl + defaults to indexes of all places, dpl defaults to empty set.*/ + if (! *ipl) + { + *ipCount = 0; + } + else if (! ipCount) + { + *ipl = 0; + } + if (! *dpl) + { + *dpCount = 0; + } + else if (! (*dpCount)) + { + *dpl = 0; + } + + if (! (*ipCount)) + { + *ipl = mcalloc(mem, Places, sizeof(int)); + for (i = 0; i < Places; i++) + { + (*ipl)[i] = i; + } + *ipCount = Places; + } + + if (*ipCount + *dpCount != Places) + { + FreeMemory(mem); + merror(0, "PN2ACPN: The independent and dependent place list lengths do not agree with the number of places"); + return 0; + } + + /*L0 - matrix, initial marking constraint. Not required. If present must have + the same number of columns as there are independent places.*/ + if (L0) + { + if (NumberOfColumns(*L0) != *ipCount) + { + FreeMemory(mem); + merror(0, "PN2ACPN: The size of L0 and the independent place list do not agree"); + return 0; + } + } + + /*L - matrix, marking constraint. Not required. If present must have the same + number of columns as there are independent places.*/ + if (L) + { + if (NumberOfColumns(*L) != *ipCount) + { + FreeMemory(mem); + merror(0, "PN2ACPN: The size of L and the independent place list do not agree"); + return 0; + } + } + + /*MX - matrix, same meaning as in msplit: is the transformation matrix from + the independent marking to the dependent marking. Not required. If present, + must have the same number of rows as there are dependent places and the same + number of columns as there are independent places (if those counts are given)*/ + if (MX && ipCount && dpCount) + { + if (NumberOfRows(*MX) != *dpCount || NumberOfColumns(*MX) != *ipCount) + { + FreeMemory(mem); + merror(0, "PN2ACPN: The size of the transformation matrix MX and the dependent and independent place lists do not agree"); + return 0; + } + } + + /*TD, TDCount - TD is an array of arrays. It has one element (array) for each + transition. Each element is an index array that lists the indices of + transitions that cannot be brought to life if the transition corresponding to + the element is dead. TDCount is an array that gives the length of the arrays + in each element of TD. + If these have not been provided, compute them using nltrans: + nltrans_r nltrans(matrix* D, int* UnraisableTransitions, int urtCount)*/ + if (! (*TDCount && *TD)) + { + /*Get the incidence matrix - needed by nltrans.*/ + D = SubtractMatrix(Dp, Dm, (matrix*) 2); + + /*Allocate space for the TD and TDCount arrays.*/ + *TD = mcalloc(mem, Transitions, sizeof(int*)); + *TDCount = mcalloc(mem, Transitions, sizeof(int)); + for (i = 0; i < Transitions; i++) + { + /*Get a list of transitions which are unraisable if the transition we are + currently examining is dead.*/ + URT = nltrans(&D, &i, 1); + /*Count the number of transitions that are flagged in the flag array + returned by nltrans.*/ + for (j = 0; j < URT.dtrCount; j++) + { + if (URT.dtr[j]) (*TDCount)[i]++; + } + /*Now put their indices in the appropriate element of TD.*/ + (*TD)[i] = mcalloc(mem, (*TDCount)[i], sizeof(int)); + k = 0; + for (j = 0; j < URT.dtrCount; j++) + { + if (URT.dtr[j]) (*TD)[i][k++] = j; + } + free(URT.dtr); + } + + DeallocateMatrix(&D); + } + return 1; +} Modified: spnbox/spnbox.h =================================================================== --- spnbox/spnbox.h 2009-06-21 19:27:39 UTC (rev 92) +++ spnbox/spnbox.h 2009-06-22 22:12:37 UTC (rev 93) @@ -83,6 +83,20 @@ int iplfCount; } pn2acpn_r; +typedef struct pn2eacpn_r +{ + matrix Df; + matrix Dmf; + matrix Dpf; + matrix MXF; + matrix L0F; + matrix LF; + int *iplf; + int iplfCount; + int **TD; + int *TDCount; +} pn2eacpn_r; + /*Constants returned in by functions to indicate the nature of the result.*/ #define HOW_ERROR "error" #define HOW_OK "OK" @@ -364,4 +378,46 @@ Converted to C by Marian V. Iordache and Stephen Camp, ste...@le... Stephen Camp -- Jun. 18, 2009 */ + +pn2eacpn_r pn2eacpn(matrix* Dm, matrix* Dp, int* Mask, matrix* MX, matrix* L0, matrix* L, int *ipl, int ipCount, int* dpl, int dpCount, int** TD, int* TDCount); +/* +PN2EACPN - Transforms a Petri net to an extended asymmetric choice Petri net + +[Df, Dmf, Dpf] = pn2eacpn(D) + +[Df, Dmf, Dpf] = pn2eacpn(Dm, Dp) + +[Df, Dmf, Dpf] = pn2eacpn(Dm, Dp, mask) + +[Df, Dmf, Dpf, MF, L0F, LF, iplf, TDf] = pn2eacpn(Dm, Dp, mask, M, L0, L, ipl, dpl, TD) + +mask is an optional argument: mask(i) = 1 if the place i is +in the set M of the technical report. (M in the tech. report has +a different meaning than M in the DP program.) + +The last five parameters are optional. See DP code for meaning. +Their updated values are given as output. In particular, TD{t} lists +transitions that cannot be made live when t is dead (including t itself). +TD will typically be an underestimate of the total set. If not given, +TD is computed here (this computation takes time). The output TDf is so +that this computation may not be repeated again in the next iterations. +The use of TD differentiates PN2EACPN from PN2ACPN. + +If called before the first iteration, take LF = MF, as the computation +of LF does not consider this case! + +See MSPLIT. + +Written for Matlab by Marian V. Iordache, mio...@nd... +Original Matlab code extended the Matlab pn2acpn code written on +M. Iordache -- Sep. 4, 2000 +and revised on Oct. 24, 2001 + +This is the extension for extended asymmetric choice nets; +M. Iordache, July 2003 + +Converted to C by M. Iordache and Stephen Camp, Ste...@le.... +Matlab code was under construction at time of conversion to C. +Stephen Camp, June 2009 +*/ #endif Property changes on: spnbox/tests ___________________________________________________________________ Modified: svn:ignore - *.bsh *.exe out.txt test-pn2acpn-03.txt + *.bsh *.exe *.stackdump out.txt *part.txt Modified: spnbox/tests/StructuredIO.c =================================================================== --- spnbox/tests/StructuredIO.c 2009-06-21 19:27:39 UTC (rev 92) +++ spnbox/tests/StructuredIO.c 2009-06-22 22:12:37 UTC (rev 93) @@ -11,6 +11,7 @@ matrix* A pointer to a matrix. arrayi An array of integers stored as a pointer. arrayd An array of doubles stored as a pointer. + arraya An array of arrays of integers. int An integer. double A double. string A pointer to characters. Reads a single line. @@ -134,7 +135,7 @@ if (! NumberOfRows(*((matrix*)Data[Param[PID].Start]))) { FreeMemory(&memory); - merror(0, "Parse: There was an error reading a matrix."); + merror(0, "PARSESTRUCTURE: There was an error reading a matrix."); return 0; } ManageMatrix(Memory, (matrix*)Data[Param[PID].Start]); @@ -156,6 +157,21 @@ *((int*) Data[Param[PID].Start + 1]) = Length; ManageMemory(Memory, *((void**) Data[Param[PID].Start])); } + /*Array of arrays of integers*/ + else if (! strcmp(Param[PID].Type, "arraya")) + { + /*ReadArrayA takes as its third parameter a pointer to the array + pointer destined to hold the array of arrays, as its fourth parameter + a pointer to the array pointer destined to hold a count of the number + of elements in each subarray, and as its fifth parameter a pointer to + the number of arrays.*/ + if (! ReadArrayA(file, Memory, (int***) Data[Param[PID].Start], (int**) Data[Param[PID].Start + 1], (int*) Data[Param[PID].Start + 2])) + { + FreeMemory(&memory); + merror(0, "PARSESTRUCTURE: There was an error reading an array of arrays"); + return 0; + } + } /*A single integer.*/ else if (! strcmp(Param[PID].Type, "int")) { @@ -202,6 +218,7 @@ MemoryManager memory; matrix* Matrix; + int** IntAP; int* IntP; int Int, Length; double* DblP; @@ -296,6 +313,28 @@ printf("\n"); } } + else if (! strcmp(Params[i].Type, "arraya")) + { + /*The first parameter is the pointer to the array of arrays, the second + to the array of counts, and the third to the count of arrays.*/ + IntAP = va_arg(args, int**); + IntP = va_arg(args, int*); + Length = va_arg(args, int); + /*Display only if the array is nonzero*/ + if ((Mask ? Mask[i] : 1) && IntAP && IntP && Length) + { + printf("%s: %d subarrays:\n", Params[i].Name, Length); + for (j = 0; j < Length; j++) + { + printf("%s %d:\t", Params[i].Name, j); + for (k = 0; k < IntP[j]; k++) + { + printf("%d\t", IntAP[j][k]); + } + printf("\n"); + } + } + } else if (! strcmp(Params[i].Type, "int")) { Int = va_arg(args, int); @@ -467,6 +506,14 @@ { ToAdd = 2; } + /*If the type is an array of arrays, there will be three items in + ParseStructure's parameter list: the array pointer, the array of counts + pointer, and the pointer to the integer destined to hold the overall + count.*/ + else if (! strcmp("arraya ", Type2)) + { + ToAdd = 3; + } /*If the parameter was recognized...*/ if (ToAdd) { @@ -522,3 +569,39 @@ return 0; } } + +/*ReadArrayA takes as its third parameter a pointer to the array +pointer destined to hold the array of arrays, as its fourth parameter +a pointer to the array pointer destined to hold a count of the number +of elements in each subarray, and as its fifth parameter a pointer to +the number of arrays.*/ +int ReadArrayA(FILE* file, MemoryManager* mem, int*** array, int** arraycount, int* count) +{ + int i; + /*Arrays of arrays will be formatted thus: + Number of arrays + Array0Length Array0Contents + Array1Length Array1Contents + ...*/ + /*Try to read the number of arrays. If successful, allocate space for the + array of arrays and for the array of counts.*/ + if (! fscanf(file, "%d", count)) return 0; + *arraycount = mcalloc(mem, *count, sizeof(int)); + *array = mcalloc(mem, *count, sizeof(int**)); + /*Read all the arrays.*/ + for (i = 0; i < *count; i++) + { + /*Attempt to read the array. On success (indicated by a non-null pointer), + manage the memory for the array.*/ + if ((*array)[i] = ReadIntArray(file, (*arraycount) + i)) + { + ManageMemory(mem, (*array)[i]); + } + /*On failure, fail.*/ + else + { + return 0; + } + } + return 1; +} Modified: spnbox/tests/test-nltrans.txt =================================================================== --- spnbox/tests/test-nltrans.txt 2009-06-21 19:27:39 UTC (rev 92) +++ spnbox/tests/test-nltrans.txt 2009-06-22 22:12:37 UTC (rev 93) @@ -7,7 +7,6 @@ -1 2 -1 -3 1 0 - done echo Problem 2 @@ -22,5 +21,49 @@ done +echo Problem 3.0 +echo This problem has no predefined unraisable transitions. Each of the next +echo three problems will use this same incidence matrix but define different +echo sets of unraisable transitions. +D 3 5 +-1 1 0 1 -1 +-1 0 1 -1 1 +1 -2 -2 0 0 + +done + +echo Problem 3.1 +D 3 5 +-1 1 0 1 -1 +-1 0 1 -1 1 +1 -2 -2 0 0 + +URT 1 +2 + +done + +echo Problem 3.2 +D 3 5 +-1 1 0 1 -1 +-1 0 1 -1 1 +1 -2 -2 0 0 + +URT 1 +4 + +done + +echo Problem 3.3 +D 3 5 +-1 1 0 1 -1 +-1 0 1 -1 1 +1 -2 -2 0 0 + +URT 3 +0 2 3 + +done + quit \ No newline at end of file Modified: spnbox/tests/test-pn2acpn.mak =================================================================== --- spnbox/tests/test-pn2acpn.mak 2009-06-21 19:27:39 UTC (rev 92) +++ spnbox/tests/test-pn2acpn.mak 2009-06-22 22:12:37 UTC (rev 93) @@ -1,6 +1,6 @@ COMPILER=gcc -g -ggdb -test-mpsplit: test-pn2acpn.o matrix.o StructuredIO.o MemoryManager.o general.o pns.o matrixmath.o pn2acpn.o +test-pn2acpn: test-pn2acpn.o matrix.o StructuredIO.o MemoryManager.o general.o pns.o matrixmath.o pn2acpn.o $(COMPILER) -o test-pn2acpn.exe test-pn2acpn.o matrix.o StructuredIO.o MemoryManager.o general.o pns.o pn2acpn.o matrixmath.o ../lp_solve_5.5/lpsolve55/liblpsolve55.a general.o: ../../pnheaders/general.c ../../pnheaders/general.h Added: spnbox/tests/test-pn2eacpn.c =================================================================== --- spnbox/tests/test-pn2eacpn.c (rev 0) +++ spnbox/tests/test-pn2eacpn.c 2009-06-22 22:12:37 UTC (rev 93) @@ -0,0 +1,159 @@ +#include <stdio.h> +#include "../../pnheaders/pns.h" +#include "../../pnheaders/matrix.h" +#include "../matrixmath.h" +#include "../spnbox.h" +#include "../MemoryManager.h" +#include "StructuredIO.h" + +/*Reference materil: + +pn2eacpn function definition: +pn2eacpn_r pn2eacpn(matrix* Dm, matrix* Dp, int* Mask, matrix* MX, matrix* L0, matrix* L, int *ipl, int ipCount, int* dpl, int dpCount, int** TD, int* TDCount) + +pn2eacpn_r structure definition: +typedef struct pn2eacpn_r +{ + matrix Df; + matrix Dmf; + matrix Dpf; + matrix MXF; + matrix L0F; + matrix LF; + int *iplf; + int iplfCount; + int **TD; + int *TDCount; +} pn2eacpn_r; + +ParseStructure test function definition: +int ParseStructure(FILE *file, char* DataDescription, int** FilledMask, MemoryManager* Memory, ...); + +DisplayStructure test function definition: +void DisplayStructure(char* DataDescription, int* Mask, ...); +*/ + +void FillDmDp(int* Filled, matrix* D, matrix* Dm, matrix* Dp); +int HasSelfLoops(matrix* Dm, matrix* Dp); +int* BuildTDVector(int**TD, int *TDCount, int* VectorLength); +int** BuildTD(int* TDVector, int VectorLength, int* TDCount, int* Places); + +int main(int argc, char* argv[]) +{ + char InputDesc[] = "matrix D, matrix Dm, matrix Dp, matrix MX, matrix L0, matrix L, arrayi Mask, arrayi ipl, arrayi dpl, arraya TD"; + char OutputDesc[] = "matrix Df, matrix Dmf, matrix Dpf, matrix MXF, matrix L0F, matrix LF, arrayi ipl, arraya TD"; + FILE* input; + MemoryManager mem; + matrix Dm, Dp, MX, L0, L, D; + int** TD; + int *Mask, *ipl, *dpl, *Filled, *TDCount; + int MaskCount, ipCount, dpCount, ResFilled[9], i; + pn2eacpn_r result; + + /*Initialize the filled mask that will be used with the result display*/ + for (i = 0; i < 9; i++) + { + ResFilled[i] = 1; + } + + /*Get the input stream. If there was a command line argument, treat it as a + filename and attempt to open it for read access, terminating on failure. + Otherwise set stdin as the input stream.*/ + if (argc > 1) + { + if (input = fopen(argv[1], "r")) + { + printf("Taking input from file '%s'...\n", argv[1]); + } + else + { + printf("Failed to open file '%s' for read access! Terminating.\n", argv[1]); + return 1; + } + } + else + { + input = stdin; + printf("Taking input from console...\n"); + } + + /*Initialize the memory manager. We don't know how many matrices and arrays + we'll need so just pick a nice round number as the initial address block size + and use the default additional block size.*/ + mem = CreateMemoryManager(5, 5, 0, 0); + + /*Attempt to parse a problem from the file and fill all the problem parts. + Continue doing so until a fatal input error or a quit command is encountered.*/ + while(ParseStructure(input, InputDesc, &Filled, &mem, &D, &Dm, &Dp, &MX, &L0, &L, &Mask, &MaskCount, &ipl, &ipCount, &dpl, &dpCount, &TD, &TDCount, &i)) + { + /*If D was given, fill Dm and Dp appropriately.*/ + FillDmDp(Filled, &D, &Dm, &Dp); + /*Display the problem.*/ + DisplayStructure(InputDesc, Filled, &D, &Dm, &Dp, &MX, &L0, &L, Mask, MaskCount, ipl, ipCount, dpl, dpCount, TD, TDCount, i); + + /*Get the solution.*/ + result = pn2eacpn(Filled[1] ? &Dm : 0, Filled[2] ? &Dp : 0, Filled[6] ? Mask : 0, Filled[3] ? &MX : 0, Filled[4] ? &L0 : 0, Filled[5] ? &L : 0, Filled[7] ? ipl : 0, ipCount, Filled[8] ? dpl : 0, dpCount, Filled[9] ? TD : 0, TDCount); + + /*Display the solution. Show Dm and Dp only if there are self-loops and + D only if there are not self-loops.*/ + if (HasSelfLoops(&Dm, &Dp)) + { + ResFilled[0] = 0; + ResFilled[1] = 1; + ResFilled[2] = 1; + } + else + { + ResFilled[0] = 1; + ResFilled[1] = 0; + ResFilled[2] = 0; + } + printf("Solution:\n"); + DisplayStructure(OutputDesc, ResFilled, &result.Df, &result.Dmf, &result.Dpf, &result.MXF, &result.L0F, &result.LF, result.iplf, result.iplfCount, result.TD, result.TDCount, NumberOfColumns(result.Df)); + printf("---------------------------------------------------------------------------\n"); + FreeMemory(&mem); + mem = CreateMemoryManager(5, 5, 0, 0); + } + FreeMemory(&mem); + return 0; +} + +int HasSelfLoops(matrix* Dm, matrix* Dp) +{ + int i, j; + for (i = 0; i < NumberOfRows(*Dm); i++) + { + for (j = 0; j < NumberOfColumns(*Dm); j++) + { + if (GetMatrixEl(Dm, i, j) && GetMatrixEl(Dp, i, j)) + { + return 1; + } + } + } + return 0; +} + +void FillDmDp(int* Filled, matrix* D, matrix* Dm, matrix* Dp) +{ + /*If D has been filled...*/ + if (Filled[0]) + { + /*We want to ignore any given Dm and Dp and instead fill Dm and Dp with + matrices developed from D.*/ + if (Filled[1]) + { + DeallocateMatrix(Dm); + } + if (Filled[2]) + { + DeallocateMatrix(Dp); + } + AllocateMatrixType(2, Dm, NumberOfRows(*D), NumberOfColumns(*D)); + AllocateMatrixType(2, Dp, NumberOfRows(*D), NumberOfColumns(*D)); + d2dd(D, Dm, Dp); + Filled[0] = 0; + Filled[1] = 1; + Filled[2] = 1; + } +} Added: spnbox/tests/test-pn2eacpn.mak =================================================================== --- spnbox/tests/test-pn2eacpn.mak (rev 0) +++ spnbox/tests/test-pn2eacpn.mak 2009-06-22 22:12:37 UTC (rev 93) @@ -0,0 +1,42 @@ +COMPILER=gcc -g -ggdb + +test-pn2eacpn: test-pn2eacpn.o matrix.o StructuredIO.o MemoryManager.o general.o pns.o matrixmath.o pn2eacpn.o nltrans.o ipsolve.o ipslv.o + $(COMPILER) -o test-pn2eacpn.exe test-pn2eacpn.o matrix.o StructuredIO.o MemoryManager.o general.o pns.o pn2eacpn.o matrixmath.o nltrans.o ipsolve.o ipslv.o ../lp_solve_5.5/lpsolve55/liblpsolve55.a + +general.o: ../../pnheaders/general.c ../../pnheaders/general.h + $(COMPILER) -c ../../pnheaders/general.c + +pns.o: ../../pnheaders/pns.c ../../pnheaders/pns.h + $(COMPILER) -c ../../pnheaders/pns.c + +matrix.o: ../../pnheaders/matrix.c ../../pnheaders/matrix.h ../../pnheaders/pns.h + $(COMPILER) -c ../../pnheaders/matrix.c + +reader.o: ../spnbox.h ../MemoryManager.h reader.c + $(COMPILER) -c reader.c + +MemoryManager.o: ../MemoryManager.h ../MemoryManager.c ../../pnheaders/general.h ../../pnheaders/matrix.h + $(COMPILER) -c ../MemoryManager.c + +StructuredIO.o: ../MemoryManager.h ../../pnheaders/matrix.h StructuredIO.h StructuredIO.c + $(COMPILER) -c StructuredIO.c + +test-pn2eacpn.o: test-pn2eacpn.c ../spnbox.h ../MemoryManager.h StructuredIO.h ../matrixmath.h + $(COMPILER) -c test-pn2eacpn.c + +matrixmath.o: ../matrixmath.c ../matrixmath.h ../../pnheaders/matrix.h + $(COMPILER) -c ../matrixmath.c + +pn2eacpn.o: ../spnbox.h ../../pnheaders/matrix.h ../MemoryManager.h ../pn2eacpn.c + $(COMPILER) -c ../pn2eacpn.c + +ipsolve.o: ../spnbox.h ../matrixmath.h ../../pnheaders/general.h ../../pnheaders/matrix.h ../MemoryManager.h ../ipsolve.c + $(COMPILER) -c ../ipsolve.c + +ipslv.o: ../spnbox.h ../ipslv.c + $(COMPILER) -c ../ipslv.c + +nltrans.o: ../nltrans.c ../spnbox.h ../../pnheaders/matrix.h ../matrixmath.h ../MemoryManager.h + $(COMPILER) -c ../nltrans.c + + \ No newline at end of file Added: spnbox/tests/test-pn2eacpn.txt =================================================================== --- spnbox/tests/test-pn2eacpn.txt (rev 0) +++ spnbox/tests/test-pn2eacpn.txt 2009-06-22 22:12:37 UTC (rev 93) @@ -0,0 +1,86 @@ +rem Acceptable problem parts: +rem D incidence matrix +rem Dm output matrix +rem Dp input matrix +rem MX Transformation matrix from independent to dependent marking +rem L0 Initial marking constraint matrix +rem L Marking constraint matrix. +rem Mask An integer array, one element for each place of the Petri net. Serves +rem as a mask on which places will be processed. +rem ipl An array of the indices of independent places. +rem dpl An array of the indices of dependent places. +rem TD An array of arrays, one subarray for each transition. Each subarray +rem contains a list of the indices of transitions that cannot be made +rem live if the corresponding transition is dead. +rem As always, matrices are defined by the keyword followed by the matrix +rem dimensions followed by the elements of the matrix. Arrays are defined by the +rem keyword followed by the length of the array followed by the array elements. +rem If D is given Dm and Dp are ignored. + +rem ---------------------------------------------------------------------------- +echo Problem 1 +echo Example 5.2 from the thesis. +echo The first three test problems are the problems of the original matlab test +echo file pn2ecdem.m. +Dp 3 5 +0 1 0 1 0 +0 0 1 0 1 +1 0 0 0 0 + +Dm 3 5 +1 0 0 0 1 +1 0 0 1 0 +0 2 2 0 0 + +done + +rem ---------------------------------------------------------------------------- +echo Problem 2 +echo Example 5.1 from the thesis. +Dm 4 5 +1 0 1 0 1 +0 0 0 1 0 +0 1 0 0 1 +1 0 1 0 0 + +Dp 4 5 +0 0 0 1 0 +0 0 2 0 1 +3 0 0 0 0 +0 1 0 0 0 + +done + +rem ---------------------------------------------------------------------------- +echo Problem 3 + +D 5 6 +-1 -1 0 0 0 0 +0 -1 -1 0 0 0 +0 0 -1 -1 0 0 +0 0 0 -1 -1 0 +0 0 0 -1 0 -1 + +done + +rem ---------------------------------------------------------------------------- +echo Problem 4. +echo This is the EAC-net example of the dissertation, therefore the EAC-net +echo transformation should have no effect. +Dm 4 5 +1 0 0 1 1 +1 1 0 0 0 +0 0 1 1 0 +0 0 0 1 0 + +Dp 4 5 +0 0 0 2 0 +0 1 1 0 0 +2 0 0 0 1 +0 0 1 0 0 + +done + +quit + + This was sent by the SourceForge.net collaborative development platform, the world's largest Open Source development site. |
From: <the...@us...> - 2009-06-21 19:27:40
|
Revision: 92 http://pntool.svn.sourceforge.net/pntool/?rev=92&view=rev Author: thecodeweasel Date: 2009-06-21 19:27:39 +0000 (Sun, 21 Jun 2009) Log Message: ----------- Apparently directory removes are special? Removed Paths: ------------- translator/test/ This was sent by the SourceForge.net collaborative development platform, the world's largest Open Source development site. |
From: <the...@us...> - 2009-06-21 19:26:04
|
Revision: 91 http://pntool.svn.sourceforge.net/pntool/?rev=91&view=rev Author: thecodeweasel Date: 2009-06-21 19:25:53 +0000 (Sun, 21 Jun 2009) Log Message: ----------- Cleaning up very old irrelivant test data. Updating the makefile to test with my test script. Modified Paths: -------------- translator/Makefile translator/input/complete.txt Removed Paths: ------------- translator/input/constraintexps.txt translator/input/constraintvars.txt translator/input/innerconstraint.txt translator/input/invalidconstraints1.txt translator/input/invalidconstraints2.txt translator/input/multiconstraints.txt translator/input/multinet.txt translator/input/oddconstraints.txt translator/input/preconstraints.txt translator/input/scatteredconstraints.txt translator/input/simple.txt translator/input/whitespace.txt translator/test/pntranslator6-4-09.tar.bz2 Modified: translator/Makefile =================================================================== --- translator/Makefile 2009-06-21 19:17:58 UTC (rev 90) +++ translator/Makefile 2009-06-21 19:25:53 UTC (rev 91) @@ -46,4 +46,4 @@ cd clibs; make distclean test : - ./pnscript input/simple.txt \ No newline at end of file + ./pnscript input/complete.txt \ No newline at end of file Modified: translator/input/complete.txt =================================================================== --- translator/input/complete.txt 2009-06-21 19:17:58 UTC (rev 90) +++ translator/input/complete.txt 2009-06-21 19:25:53 UTC (rev 91) @@ -1,10 +1,84 @@ -PN: pn1 -places: p1 p2 state_a -transitions: t0 t1 t2 trans_a trans_b -p1*: t0 t2 -*p1: t1 trans_a -state_a*: trans_a t1 -*state_a: t0 t2 -constraints: pn1.p1 + pn1.state_a - 1 <= 3 -pn1.p2 + pn1.state_a > 2 -live: pn1.t0 pn1.t1 pn1.t2 \ No newline at end of file +process READER; +build: {make -f reader.mak}; +include: { + #include<stdio.h> + #include<string.h> + int state = 0; //set starting condition + char* var1 = "this is } a \"test\" of something"; + char* var2 = 'this is } \'test\'s\' something'; +}; +//------------------------------------------------ +process WRITER; +build: {make -f writer.mak}; +include: {#include "writer.h"}; +//------------------------------------------------ +extern process ARBITER; +//################################################ +ARBITER.PN: +places: p1 p2; +transitions: t1 t2; +*p1: t1; +p1*: t2; +*p2: t2; +p2*: t1; +//------------------------------------------------ +READER.PN: +places: p1 p1b p2 p3; +trans: t1 t2 t3 t4 ti t_end; +p1.code: { initialize_r(); }; +p1b.code: { initialize_r_b(); }; +p2.code: { + str = read_data(); +}; +p3.code: { process_data(str); }; +(p1b, ti, p1); +(p1, t1, p2).{i != 0}; +(p2, t2, p3); +(p3, t3, p1); +(p1, t_end).{exit_v == TRUE}; +(p1, t4, p3); +select function p1.{select_t}; +nondeterministic places: p1; +//------------------------------------------------ +WRITER.PN: +places: p pwr_1 pwr2; +transitions: t1 t2 t3 t4; +p.code: { process_wrdata(); }; +pwr_1.code: { write_dest1(); }; +pwr_2.code: { write_dest2(); }; +(p, t1, pwr_1).{dest == 1}; +(p, t2, pwr_2); +(pwr_1, t3, p); +(pwr_2, t4, p); +(t2, pwr_1, p); +//################################################ +READER r_group(p1:2, p3:1); +READER reader1(p1b); +WRITER writer1(p); +WRITER w_group(p:2); +ARBITER arbiter(p1); +//------------------------------------------------ +sync reader1.t1 arbiter.t1; +sync writer1.t2 arbiter.t2; +start r_group w_group reader1 writer1; +//################################################ +r_group.constraints: +live: t2 t4; +uncontrollable: t1 t_end t4; +unobservable: t1 t_end t4; +//------------------------------------------------ +w_group.constraints: +pwr_1 <= 1; +pwr_2 <= 2; +live: all; +//------------------------------------------------ +global.constraints: +(r_group.p2 <= 0) || (w_group.pwr_1 <= 0); +(r_group.p1b <= 0 || w_group.pwr_1 <= 0) && (reader1.p2 <= 0 || writer1.pwr2 <= 0); +q.reader1.t1 - writer1.p <= 0; +2*reader1.t1 - 2*reader1.t2 + w_group.pwr_2 <= 2; +//reader1.t1 - (reader1.t2 + w_group.pwr_2) > -1; +//(reader1.t1 - (reader1.t2 + w_group.pwr_2) > -1) || (r_group.p1b <= 0 && (w_group.pwr_1 <= 0)); +//-3*((reader1.p2+2)-2*w_group.pwr_2) < -(4*r_group.p1b-2*(3*writer1.pwr2-2)); +//################################################ +print supervisor to debug.log; \ No newline at end of file Deleted: translator/input/constraintexps.txt =================================================================== --- translator/input/constraintexps.txt 2009-06-21 19:17:58 UTC (rev 90) +++ translator/input/constraintexps.txt 2009-06-21 19:25:53 UTC (rev 91) @@ -1,21 +0,0 @@ -PN: pn1 - places: p1 p2 state_a - trans: t0 t1 t2 trans_a trans_b - p1*: t0 t2 - *p1: t1 trans_a - state_a*: trans_a t1 - *state_a: t0 t2 - -PN: pn2 - places: p1 p2 state_a - trans: t0 t1 t2 trans_a trans_b - p1*: t0 t2 - *p1: t1 trans_a - state_a*: trans_a t1 - *state_a: t0 t2 - -constraints: - (pn2.p1 + 2*pn1.state_a - 1 <= 2 AND - 3 < pn1.t2 + 3*pn2.state_a) OR - 2 + pn2.state_a = pn1.trans_b -live: pn1.t0 pn2.t1 pn1.t2 \ No newline at end of file Deleted: translator/input/constraintvars.txt =================================================================== --- translator/input/constraintvars.txt 2009-06-21 19:17:58 UTC (rev 90) +++ translator/input/constraintvars.txt 2009-06-21 19:25:53 UTC (rev 91) @@ -1,21 +0,0 @@ -PN: pn1 - places: p1 p2 state_a - trans: t0 t1 t2 trans_a trans_b - p1*: t0 t2 - *p1: t1 trans_a - state_a*: trans_a t1 - *state_a: t0 t2 - -PN: pn2 - places: p1 p2 state_a - trans: t0 t1 t2 trans_a trans_b - p1*: t0 t2 - *p1: t1 trans_a - state_a*: trans_a t1 - *state_a: t0 t2 - -constraints: - x = 2 //constraint vars need to be inside the constraints: tag and need to be before any constraint definitions - pn2.p1 + pn1.state_a - 1 <= x - x < pn1.p2 + pn2.state_a -live: pn1.t0 pn2.t1 pn1.t2 Deleted: translator/input/innerconstraint.txt =================================================================== --- translator/input/innerconstraint.txt 2009-06-21 19:17:58 UTC (rev 90) +++ translator/input/innerconstraint.txt 2009-06-21 19:25:53 UTC (rev 91) @@ -1,27 +0,0 @@ -PN: pn1 -places: p1 p2 state_a -trans: t0 t1 t2 trans_a trans_b -p1*: t0 t2 -*p1: t1 trans_a -state_a*: trans_a t1 -*state_a: t0 t2 - -constraints: pn2.p1 + pn1.state_a - 1 <= 3 -pn1.p2 + pn2.state_a > 2 -live: pn1.t0 pn3.t1 pn2.t2 - -PN: pn2 -places: p1 p2 state_a -trans: t0 t1 t2 trans_a trans_b -p1*: t0 t2 -*p1: t1 trans_a -state_a*: trans_a t1 -*state_a: t0 t2 - -PN: pn3 -places: p1 p2 state_a -trans: t0 t1 t2 trans_a trans_b -p1*: t0 t2 -*p1: t1 trans_a -state_a*: trans_a t1 -*state_a: t0 t2 \ No newline at end of file Deleted: translator/input/invalidconstraints1.txt =================================================================== --- translator/input/invalidconstraints1.txt 2009-06-21 19:17:58 UTC (rev 90) +++ translator/input/invalidconstraints1.txt 2009-06-21 19:25:53 UTC (rev 91) @@ -1,21 +0,0 @@ -PN: pn1 - places: p1 p2 state_a - trans: t0 t1 t2 trans_a trans_b - p1*: t0 t2 - *p1: t1 trans_a - state_a*: trans_a t1 - *state_a: t0 t2 - -PN: pn2 - places: p1 p2 state_a - trans: t0 t1 t2 trans_a trans_b - p1*: t0 t2 - *p1: t1 trans_a - state_a*: trans_a t1 - *state_a: t0 t2 - -constraints: - pn2.p1 + 2*pn1.state_a - 1 <= 2 - 3 < pn1.t2 + 3*pn2.state_a - 2 < 4 -live: pn1.t0 pn2.t1 pn1.t2 \ No newline at end of file Deleted: translator/input/invalidconstraints2.txt =================================================================== --- translator/input/invalidconstraints2.txt 2009-06-21 19:17:58 UTC (rev 90) +++ translator/input/invalidconstraints2.txt 2009-06-21 19:25:53 UTC (rev 91) @@ -1,21 +0,0 @@ -PN: pn1 - places: p1 p2 state_a - trans: t0 t1 t2 trans_a trans_b - p1*: t0 t2 - *p1: t1 trans_a - state_a*: trans_a t1 - *state_a: t0 t2 - -PN: pn2 - places: p1 p2 state_a - trans: t0 t1 t2 trans_a trans_b - p1*: t0 t2 - *p1: t1 trans_a - state_a*: trans_a t1 - *state_a: t0 t2 - -constraints: - 3 >= 5 - pn2.p1 + 2*pn1.state_a - 1 <= 2 - 3 < pn1.t2 + 3*pn2.state_a -live: pn1.t0 pn2.t1 pn1.t2 \ No newline at end of file Deleted: translator/input/multiconstraints.txt =================================================================== --- translator/input/multiconstraints.txt 2009-06-21 19:17:58 UTC (rev 90) +++ translator/input/multiconstraints.txt 2009-06-21 19:25:53 UTC (rev 91) @@ -1,31 +0,0 @@ -PN: pn1 -places: p1 p2 state_a -trans: t0 t1 t2 trans_a trans_b -p1*: t0 t2 -*p1: t1 trans_a -state_a*: trans_a t1 -*state_a: t0 t2 - -constraints: pn2.p1 + pn3.state_a - 4 >= 0 -live: pn1.t0 pn3.t1 pn2.t2 - -PN: pn2 -places: p1 p2 state_a -trans: t0 t1 t2 trans_a trans_b -p1*: t0 t2 -*p1: t1 trans_a -state_a*: trans_a t1 -*state_a: t0 t2 - -constraints: pn2.p1 + pn1.state_a - 1 <= 3 -pn1.p2 + pn2.state_a > 2 - -PN: pn3 -places: p1 p2 state_a -trans: t0 t1 t2 trans_a trans_b -p1*: t0 t2 -*p1: t1 trans_a -state_a*: trans_a t1 -*state_a: t0 t2 - -live: pn1.t2 \ No newline at end of file Deleted: translator/input/multinet.txt =================================================================== --- translator/input/multinet.txt 2009-06-21 19:17:58 UTC (rev 90) +++ translator/input/multinet.txt 2009-06-21 19:25:53 UTC (rev 91) @@ -1,19 +0,0 @@ -PN: pn1 - places: p1 p2 state_a - trans: t0 t1 t2 trans_a trans_b - p1*: t0 t2 - *p1: t1 trans_a - state_a*: trans_a t1 - *state_a: t0 t2 - -PN: pn2 - places: p1 p2 state_a - trans: t0 t1 t2 trans_a trans_b - p1*: t0 t2 - *p1: t1 trans_a - state_a*: trans_a t1 - *state_a: t0 t2 - -constraints: pn2.p1 + pn1.state_a - 1 <= 3 - 2 < pn1.p2 + pn2.state_a -live: pn1.t0 pn2.t1 pn1.t2 \ No newline at end of file Deleted: translator/input/oddconstraints.txt =================================================================== --- translator/input/oddconstraints.txt 2009-06-21 19:17:58 UTC (rev 90) +++ translator/input/oddconstraints.txt 2009-06-21 19:25:53 UTC (rev 91) @@ -1,20 +0,0 @@ -PN: pn1 - places: p1 p2 state_a - trans: t0 t1 t2 trans_a trans_b - p1*: t0 t2 - *p1: t1 trans_a - state_a*: trans_a t1 - *state_a: t0 t2 - -PN: pn2 - places: p1 p2 state_a - trans: t0 t1 t2 trans_a trans_b - p1*: t0 t2 - *p1: t1 trans_a - state_a*: trans_a t1 - *state_a: t0 t2 - -constraints: - pn2.p1 + 2*pn1.state_a - 1 <= 2 - 3 < pn1.t2 + 3*pn2.state_a -live: pn1.t0 pn2.t1 pn1.t2 \ No newline at end of file Deleted: translator/input/preconstraints.txt =================================================================== --- translator/input/preconstraints.txt 2009-06-21 19:17:58 UTC (rev 90) +++ translator/input/preconstraints.txt 2009-06-21 19:25:53 UTC (rev 91) @@ -1,27 +0,0 @@ -constraints: pn2.p1 + pn1.state_a - 1 <= 3 -pn1.p2 + pn2.state_a > 2 -live: pn1.t0 pn3.t1 pn2.t2 - -PN: pn1 -places: p1 p2 state_a -trans: t0 t1 t2 trans_a trans_b -p1*: t0 t2 -*p1: t1 trans_a -state_a*: trans_a t1 -*state_a: t0 t2 - -PN: pn2 -places: p1 p2 state_a -trans: t0 t1 t2 trans_a trans_b -p1*: t0 t2 -*p1: t1 trans_a -state_a*: trans_a t1 -*state_a: t0 t2 - -PN: pn3 -places: p1 p2 state_a -trans: t0 t1 t2 trans_a trans_b -p1*: t0 t2 -*p1: t1 trans_a -state_a*: trans_a t1 -*state_a: t0 t2 \ No newline at end of file Deleted: translator/input/scatteredconstraints.txt =================================================================== --- translator/input/scatteredconstraints.txt 2009-06-21 19:17:58 UTC (rev 90) +++ translator/input/scatteredconstraints.txt 2009-06-21 19:25:53 UTC (rev 91) @@ -1,28 +0,0 @@ -PN: pn1 -places: p1 p2 state_a -trans: t0 t1 t2 trans_a trans_b -p1*: t0 t2 -*p1: t1 trans_a -state_a*: trans_a t1 -*state_a: t0 t2 - -live: pn1.t0 pn3.t1 pn2.t2 - -PN: pn2 -places: p1 p2 state_a -trans: t0 t1 t2 trans_a trans_b -p1*: t0 t2 -*p1: t1 trans_a -state_a*: trans_a t1 -*state_a: t0 t2 - -constraints: pn2.p1 + pn1.state_a - 1 <= 3 -pn1.p2 + pn2.state_a > 2 - -PN: pn3 -places: p1 p2 state_a -trans: t0 t1 t2 trans_a trans_b -p1*: t0 t2 -*p1: t1 trans_a -state_a*: trans_a t1 -*state_a: t0 t2 \ No newline at end of file Deleted: translator/input/simple.txt =================================================================== --- translator/input/simple.txt 2009-06-21 19:17:58 UTC (rev 90) +++ translator/input/simple.txt 2009-06-21 19:25:53 UTC (rev 91) @@ -1,7 +0,0 @@ -PN: pn1 -places: p1 p2 state_a -trans: t0 t1 t2 trans_a trans_b -p1*: t0 t2 -*p1: t1 trans_a -state_a*: trans_a t1 -*state_a: t0 t2 \ No newline at end of file Deleted: translator/input/whitespace.txt =================================================================== --- translator/input/whitespace.txt 2009-06-21 19:17:58 UTC (rev 90) +++ translator/input/whitespace.txt 2009-06-21 19:25:53 UTC (rev 91) @@ -1,17 +0,0 @@ -PN: pn1 - - places: p1 p2 state_a - trans: t0 t1 t2 trans_a trans_b - p1*: t0 - t2 - *p1: t1 trans_a - state_a*: trans_a t1 - *state_a: t0 t2 - -constraints: - pn1.p1 + pn1.state_a - 1 <= 3 - pn1.p2 + pn1.state_a > 2 - -live: pn1.t0 - pn1.t2 - Deleted: translator/test/pntranslator6-4-09.tar.bz2 =================================================================== (Binary files differ) This was sent by the SourceForge.net collaborative development platform, the world's largest Open Source development site. |
From: <the...@us...> - 2009-06-21 19:18:00
|
Revision: 90 http://pntool.svn.sourceforge.net/pntool/?rev=90&view=rev Author: thecodeweasel Date: 2009-06-21 19:17:58 +0000 (Sun, 21 Jun 2009) Log Message: ----------- Finished implementing constraints. The translator should be working. Modified Paths: -------------- translator/pngenerator.c translator/pngenerator.g translator/pngenerator.h Modified: translator/pngenerator.c =================================================================== --- translator/pngenerator.c 2009-06-21 17:13:25 UTC (rev 89) +++ translator/pngenerator.c 2009-06-21 19:17:58 UTC (rev 90) @@ -2,7 +2,7 @@ * This C source file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pngenerator.g - * - On : 2009-06-21 12:11:06 + * - On : 2009-06-21 14:16:59 * - for the tree parser : pngeneratorTreeParser * * Editing it, at least manually, is not wise. * @@ -810,6 +810,7 @@ ASSOC_ARRAY* threads; specs* output; constraint** constraintList; + int constraintNum; static void showContext(pANTLR3_BASE_TREE t) { pANTLR3_COMMON_TOKEN tok = t->getToken(t); @@ -1005,129 +1006,129 @@ /** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints404 */ static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints404_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints404 = { FOLLOW_constraint_block_in_constraints404_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints406 */ -static ANTLR3_BITWORD FOLLOW_eq_in_constraints406_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints406 = { FOLLOW_eq_in_constraints406_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints409 */ -static ANTLR3_BITWORD FOLLOW_live_def_in_constraints409_bits[] = { ANTLR3_UINT64_LIT(0x0000000300000008) }; -static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints409 = { FOLLOW_live_def_in_constraints409_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints412 */ -static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints412_bits[] = { ANTLR3_UINT64_LIT(0x0000000200000008) }; -static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints412 = { FOLLOW_uncontrol_in_constraints412_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints415 */ -static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints415_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints415 = { FOLLOW_unobserve_in_constraints415_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block425 */ -static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block425_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block425 = { FOLLOW_ID_in_constraint_block425_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq445 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq445_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq445 = { FOLLOW_relationalExpression_in_eq445_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq453 */ -static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq453_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq453 = { FOLLOW_EQS_OP_in_eq453_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq455 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq455_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq455 = { FOLLOW_eq_in_eq455_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq457 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq457_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq457 = { FOLLOW_eq_in_eq457_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression486 */ -static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression486_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression486 = { FOLLOW_EQ_OP_in_relationalExpression486_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression488 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression488_bits[] = { ANTLR3_UINT64_LIT(0x0002000000000000) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression488 = { FOLLOW_additiveExpression_in_relationalExpression488_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_relationalExpression491 */ -static ANTLR3_BITWORD FOLLOW_NUM_in_relationalExpression491_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_NUM_in_relationalExpression491 = { FOLLOW_NUM_in_relationalExpression491_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression510 */ -static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression510_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression510 = { FOLLOW_primary_in_additiveExpression510_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_additiveExpression522 */ -static ANTLR3_BITWORD FOLLOW_ADD_in_additiveExpression522_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ADD_in_additiveExpression522 = { FOLLOW_ADD_in_additiveExpression522_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression524 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression524_bits[] = { ANTLR3_UINT64_LIT(0x0001800000040088) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression524 = { FOLLOW_additiveExpression_in_additiveExpression524_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression527 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression527_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression527 = { FOLLOW_additiveExpression_in_additiveExpression527_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SUB_in_additiveExpression538 */ -static ANTLR3_BITWORD FOLLOW_SUB_in_additiveExpression538_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SUB_in_additiveExpression538 = { FOLLOW_SUB_in_additiveExpression538_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression540 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression540_bits[] = { ANTLR3_UINT64_LIT(0x0001800000040088) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression540 = { FOLLOW_additiveExpression_in_additiveExpression540_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression543 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression543_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression543 = { FOLLOW_additiveExpression_in_additiveExpression543_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary565 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_primary565_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary565 = { FOLLOW_group_elements_in_primary565_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary576 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_primary576_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary576 = { FOLLOW_MULT_in_primary576_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_primary578 */ -static ANTLR3_BITWORD FOLLOW_NUM_in_primary578_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; -static ANTLR3_BITSET_LIST FOLLOW_NUM_in_primary578 = { FOLLOW_NUM_in_primary578_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary580 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_primary580_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary580 = { FOLLOW_group_elements_in_primary580_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def593 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def593_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def593 = { FOLLOW_LIVE_in_live_def593_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def595 */ -static ANTLR3_BITWORD FOLLOW_ALL_in_live_def595_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def595 = { FOLLOW_ALL_in_live_def595_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def600 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def600_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def600 = { FOLLOW_ID_in_live_def600_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def611 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def611_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def611 = { FOLLOW_LIVE_in_live_def611_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints407 */ +static ANTLR3_BITWORD FOLLOW_eq_in_constraints407_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints407 = { FOLLOW_eq_in_constraints407_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints413 */ +static ANTLR3_BITWORD FOLLOW_live_def_in_constraints413_bits[] = { ANTLR3_UINT64_LIT(0x0000000300000008) }; +static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints413 = { FOLLOW_live_def_in_constraints413_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints416 */ +static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints416_bits[] = { ANTLR3_UINT64_LIT(0x0000000200000008) }; +static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints416 = { FOLLOW_uncontrol_in_constraints416_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints419 */ +static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints419_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints419 = { FOLLOW_unobserve_in_constraints419_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block429 */ +static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block429_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block429 = { FOLLOW_ID_in_constraint_block429_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq449 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq449_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq449 = { FOLLOW_relationalExpression_in_eq449_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq457 */ +static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq457_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq457 = { FOLLOW_EQS_OP_in_eq457_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq463 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq463_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq463 = { FOLLOW_eq_in_eq463_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq469 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq469_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq469 = { FOLLOW_eq_in_eq469_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression500 */ +static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression500_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression500 = { FOLLOW_EQ_OP_in_relationalExpression500_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression502 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression502_bits[] = { ANTLR3_UINT64_LIT(0x0002000000000000) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression502 = { FOLLOW_additiveExpression_in_relationalExpression502_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_relationalExpression505 */ +static ANTLR3_BITWORD FOLLOW_NUM_in_relationalExpression505_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_NUM_in_relationalExpression505 = { FOLLOW_NUM_in_relationalExpression505_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression524 */ +static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression524_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression524 = { FOLLOW_primary_in_additiveExpression524_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_additiveExpression536 */ +static ANTLR3_BITWORD FOLLOW_ADD_in_additiveExpression536_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ADD_in_additiveExpression536 = { FOLLOW_ADD_in_additiveExpression536_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression538 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression538_bits[] = { ANTLR3_UINT64_LIT(0x0001800000040088) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression538 = { FOLLOW_additiveExpression_in_additiveExpression538_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression541 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression541_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression541 = { FOLLOW_additiveExpression_in_additiveExpression541_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SUB_in_additiveExpression552 */ +static ANTLR3_BITWORD FOLLOW_SUB_in_additiveExpression552_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SUB_in_additiveExpression552 = { FOLLOW_SUB_in_additiveExpression552_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression554 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression554_bits[] = { ANTLR3_UINT64_LIT(0x0001800000040088) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression554 = { FOLLOW_additiveExpression_in_additiveExpression554_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression557 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression557_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression557 = { FOLLOW_additiveExpression_in_additiveExpression557_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary579 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_primary579_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary579 = { FOLLOW_group_elements_in_primary579_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary590 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_primary590_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary590 = { FOLLOW_MULT_in_primary590_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_primary592 */ +static ANTLR3_BITWORD FOLLOW_NUM_in_primary592_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; +static ANTLR3_BITSET_LIST FOLLOW_NUM_in_primary592 = { FOLLOW_NUM_in_primary592_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary594 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_primary594_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary594 = { FOLLOW_group_elements_in_primary594_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def607 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def607_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def607 = { FOLLOW_LIVE_in_live_def607_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def609 */ +static ANTLR3_BITWORD FOLLOW_ALL_in_live_def609_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def609 = { FOLLOW_ALL_in_live_def609_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def614 */ static ANTLR3_BITWORD FOLLOW_ID_in_live_def614_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def614 = { FOLLOW_ID_in_live_def614_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol629 */ -static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol629_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol629 = { FOLLOW_UNCONTROL_in_uncontrol629_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol632 */ -static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol632_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol632 = { FOLLOW_ID_in_uncontrol632_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve647 */ -static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve647_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve647 = { FOLLOW_UNOBSERVE_in_unobserve647_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve650 */ -static ANTLR3_BITWORD FOLLOW_ID_in_unobserve650_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve650 = { FOLLOW_ID_in_unobserve650_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands665 */ -static ANTLR3_BITWORD FOLLOW_print_in_other_commands665_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands665 = { FOLLOW_print_in_other_commands665_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print676 */ -static ANTLR3_BITWORD FOLLOW_PRINT_in_print676_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print676 = { FOLLOW_PRINT_in_print676_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print678 */ -static ANTLR3_BITWORD FOLLOW_ID_in_print678_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_print678 = { FOLLOW_ID_in_print678_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print680 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_print680_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print680 = { FOLLOW_group_elements_in_print680_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_GROUP_in_group_elements701 */ -static ANTLR3_BITWORD FOLLOW_GROUP_in_group_elements701_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_GROUP_in_group_elements701 = { FOLLOW_GROUP_in_group_elements701_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements704 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements704_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements704 = { FOLLOW_ID_in_group_elements704_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID723 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID723_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID723 = { FOLLOW_ID_in_numbered_ID723_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID731 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID731_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID731 = { FOLLOW_ID_in_numbered_ID731_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID733 */ -static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID733_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID733 = { FOLLOW_INT_in_numbered_ID733_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def625 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def625_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def625 = { FOLLOW_LIVE_in_live_def625_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def628 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def628_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def628 = { FOLLOW_ID_in_live_def628_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol643 */ +static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol643_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol643 = { FOLLOW_UNCONTROL_in_uncontrol643_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol646 */ +static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol646_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol646 = { FOLLOW_ID_in_uncontrol646_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve661 */ +static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve661_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve661 = { FOLLOW_UNOBSERVE_in_unobserve661_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve664 */ +static ANTLR3_BITWORD FOLLOW_ID_in_unobserve664_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve664 = { FOLLOW_ID_in_unobserve664_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands679 */ +static ANTLR3_BITWORD FOLLOW_print_in_other_commands679_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands679 = { FOLLOW_print_in_other_commands679_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print690 */ +static ANTLR3_BITWORD FOLLOW_PRINT_in_print690_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print690 = { FOLLOW_PRINT_in_print690_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print692 */ +static ANTLR3_BITWORD FOLLOW_ID_in_print692_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_print692 = { FOLLOW_ID_in_print692_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print694 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_print694_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print694 = { FOLLOW_group_elements_in_print694_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_GROUP_in_group_elements715 */ +static ANTLR3_BITWORD FOLLOW_GROUP_in_group_elements715_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_GROUP_in_group_elements715 = { FOLLOW_GROUP_in_group_elements715_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements718 */ +static ANTLR3_BITWORD FOLLOW_ID_in_group_elements718_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements718 = { FOLLOW_ID_in_group_elements718_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID737 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID737_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID737 = { FOLLOW_ID_in_numbered_ID737_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID745 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID745_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID745 = { FOLLOW_ID_in_numbered_ID745_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID747 */ +static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID747_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID747 = { FOLLOW_INT_in_numbered_ID747_bits, 1 }; @@ -1137,7 +1138,7 @@ */ /** * $ANTLR start pn - * /Users/bion/projects/iordache/translator/pngenerator.g:128:1: pn[ASSOC_ARRAY* procData, ASSOC_ARRAY* threadData, char* fileName, int num] returns [specs* ret] : ( proc_definitions )+ ( proc_instantiations )+ ( constraints )* ( other_commands )* ; + * /Users/bion/projects/iordache/translator/pngenerator.g:129:1: pn[ASSOC_ARRAY* procData, ASSOC_ARRAY* threadData, char* fileName, int num] returns [specs* ret] : ( proc_definitions )+ ( proc_instantiations )+ ( constraints )* ( other_commands )* ; */ static specs* pn(ppngenerator ctx, ASSOC_ARRAY* procData, ASSOC_ARRAY* threadData, char* fileName, int num) @@ -1156,15 +1157,16 @@ output = tmalloc(sizeof(specs)); output->name = fileName; constraintList = tcalloc(num, sizeof(constraint*)); + constraintNum = 0; for(i = 0; i < num; i++) { constraintList[i] = malloc(sizeof(constraint)); } { - // /Users/bion/projects/iordache/translator/pngenerator.g:141:2: ( ( proc_definitions )+ ( proc_instantiations )+ ( constraints )* ( other_commands )* ) - // /Users/bion/projects/iordache/translator/pngenerator.g:141:4: ( proc_definitions )+ ( proc_instantiations )+ ( constraints )* ( other_commands )* + // /Users/bion/projects/iordache/translator/pngenerator.g:143:2: ( ( proc_definitions )+ ( proc_instantiations )+ ( constraints )* ( other_commands )* ) + // /Users/bion/projects/iordache/translator/pngenerator.g:143:4: ( proc_definitions )+ ( proc_instantiations )+ ( constraints )* ( other_commands )* { - // /Users/bion/projects/iordache/translator/pngenerator.g:141:4: ( proc_definitions )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:143:4: ( proc_definitions )+ { int cnt1=0; @@ -1224,7 +1226,7 @@ switch (alt1) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:141:4: proc_definitions + // /Users/bion/projects/iordache/translator/pngenerator.g:143:4: proc_definitions { FOLLOWPUSH(FOLLOW_proc_definitions_in_pn67); proc_definitions(ctx); @@ -1258,7 +1260,7 @@ } loop1: ; /* Jump to here if this rule does not match */ } - // /Users/bion/projects/iordache/translator/pngenerator.g:141:22: ( proc_instantiations )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:143:22: ( proc_instantiations )+ { int cnt2=0; @@ -1300,7 +1302,7 @@ switch (alt2) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:141:22: proc_instantiations + // /Users/bion/projects/iordache/translator/pngenerator.g:143:22: proc_instantiations { FOLLOWPUSH(FOLLOW_proc_instantiations_in_pn70); proc_instantiations(ctx); @@ -1335,7 +1337,7 @@ loop2: ; /* Jump to here if this rule does not match */ } - // /Users/bion/projects/iordache/translator/pngenerator.g:141:43: ( constraints )* + // /Users/bion/projects/iordache/translator/pngenerator.g:143:43: ( constraints )* for (;;) { @@ -1353,7 +1355,7 @@ switch (alt3) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:141:43: constraints + // /Users/bion/projects/iordache/translator/pngenerator.g:143:43: constraints { FOLLOWPUSH(FOLLOW_constraints_in_pn73); constraints(ctx); @@ -1376,7 +1378,7 @@ loop3: ; /* Jump out to here if this rule does not match */ - // /Users/bion/projects/iordache/translator/pngenerator.g:141:56: ( other_commands )* + // /Users/bion/projects/iordache/translator/pngenerator.g:143:56: ( other_commands )* for (;;) { @@ -1394,7 +1396,7 @@ switch (alt4) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:141:56: other_commands + // /Users/bion/projects/iordache/translator/pngenerator.g:143:56: other_commands { FOLLOWPUSH(FOLLOW_other_commands_in_pn76); other_commands(ctx); @@ -1428,6 +1430,7 @@ list = (pANTLR3_LIST) threads->iter(threads, i); output->process_array[i] = (process*) list->get(list, kPROC); } + output->constraint_array = constraintList; ret= output; } @@ -1454,7 +1457,7 @@ /** * $ANTLR start proc_definitions - * /Users/bion/projects/iordache/translator/pngenerator.g:155:1: proc_definitions : ^( def_start ( trans_defs )* ( select_functions )* ( nondeterm )? ) ; + * /Users/bion/projects/iordache/translator/pngenerator.g:158:1: proc_definitions : ^( def_start ( trans_defs )* ( select_functions )* ( nondeterm )? ) ; */ static void proc_definitions(ppngenerator ctx) @@ -1464,8 +1467,8 @@ ctx->ppngenerator_proc_definitionsTop = ppngenerator_proc_definitionsPush(ctx); { - // /Users/bion/projects/iordache/translator/pngenerator.g:161:2: ( ^( def_start ( trans_defs )* ( select_functions )* ( nondeterm )? ) ) - // /Users/bion/projects/iordache/translator/pngenerator.g:161:4: ^( def_start ( trans_defs )* ( select_functions )* ( nondeterm )? ) + // /Users/bion/projects/iordache/translator/pngenerator.g:164:2: ( ^( def_start ( trans_defs )* ( select_functions )* ( nondeterm )? ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:164:4: ^( def_start ( trans_defs )* ( select_functions )* ( nondeterm )? ) { FOLLOWPUSH(FOLLOW_def_start_in_proc_definitions94); def_start(ctx); @@ -1485,7 +1488,7 @@ } - // /Users/bion/projects/iordache/translator/pngenerator.g:161:16: ( trans_defs )* + // /Users/bion/projects/iordache/translator/pngenerator.g:164:16: ( trans_defs )* for (;;) { @@ -1503,7 +1506,7 @@ switch (alt5) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:161:16: trans_defs + // /Users/bion/projects/iordache/translator/pngenerator.g:164:16: trans_defs { FOLLOWPUSH(FOLLOW_trans_defs_in_proc_definitions96); trans_defs(ctx); @@ -1526,7 +1529,7 @@ loop5: ; /* Jump out to here if this rule does not match */ - // /Users/bion/projects/iordache/translator/pngenerator.g:161:28: ( select_functions )* + // /Users/bion/projects/iordache/translator/pngenerator.g:164:28: ( select_functions )* for (;;) { @@ -1544,7 +1547,7 @@ switch (alt6) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:161:28: select_functions + // /Users/bion/projects/iordache/translator/pngenerator.g:164:28: select_functions { FOLLOWPUSH(FOLLOW_select_functions_in_proc_definitions99); select_functions(ctx); @@ -1567,7 +1570,7 @@ loop6: ; /* Jump out to here if this rule does not match */ - // /Users/bion/projects/iordache/translator/pngenerator.g:161:46: ( nondeterm )? + // /Users/bion/projects/iordache/translator/pngenerator.g:164:46: ( nondeterm )? { int alt7=2; { @@ -1580,7 +1583,7 @@ switch (alt7) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:161:46: nondeterm + // /Users/bion/projects/iordache/translator/pngenerator.g:164:46: nondeterm { FOLLOWPUSH(FOLLOW_nondeterm_in_proc_definitions102); nondeterm(ctx); @@ -1630,7 +1633,7 @@ /** * $ANTLR start def_start - * /Users/bion/projects/iordache/translator/pngenerator.g:162:1: def_start : ID ; + * /Users/bion/projects/iordache/translator/pngenerator.g:165:1: def_start : ID ; */ static void def_start(ppngenerator ctx) @@ -1647,8 +1650,8 @@ ID1 = NULL; { - // /Users/bion/projects/iordache/translator/pngenerator.g:166:2: ( ID ) - // /Users/bion/projects/iordache/translator/pngenerator.g:166:4: ID + // /Users/bion/projects/iordache/translator/pngenerator.g:169:2: ( ID ) + // /Users/bion/projects/iordache/translator/pngenerator.g:169:4: ID { ID1 = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_def_start118); if (HASEXCEPTION()) @@ -1702,7 +1705,7 @@ /** * $ANTLR start trans_defs - * /Users/bion/projects/iordache/translator/pngenerator.g:187:1: trans_defs : ( extern_trans_def | trans_def ); + * /Users/bion/projects/iordache/translator/pngenerator.g:190:1: trans_defs : ( extern_trans_def | trans_def ); */ static void trans_defs(ppngenerator ctx) @@ -1713,7 +1716,7 @@ { { - // /Users/bion/projects/iordache/translator/pngenerator.g:188:2: ( extern_trans_def | trans_def ) + // /Users/bion/projects/iordache/translator/pngenerator.g:191:2: ( extern_trans_def | trans_def ) ANTLR3_UINT32 alt8; @@ -1746,7 +1749,7 @@ switch (alt8) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:188:4: extern_trans_def + // /Users/bion/projects/iordache/translator/pngenerator.g:191:4: extern_trans_def { FOLLOWPUSH(FOLLOW_extern_trans_def_in_trans_defs128); extern_trans_def(ctx); @@ -1761,7 +1764,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pngenerator.g:189:4: trans_def + // /Users/bion/projects/iordache/translator/pngenerator.g:192:4: trans_def { FOLLOWPUSH(FOLLOW_trans_def_in_trans_defs133); trans_def(ctx); @@ -1798,7 +1801,7 @@ /** * $ANTLR start extern_trans_def - * /Users/bion/projects/iordache/translator/pngenerator.g:190:1: extern_trans_def : ^( ( TO | FROM ) ( ID )+ ) ; + * /Users/bion/projects/iordache/translator/pngenerator.g:193:1: extern_trans_def : ^( ( TO | FROM ) ( ID )+ ) ; */ static void extern_trans_def(ppngenerator ctx) @@ -1821,11 +1824,11 @@ ID4 = NULL; { - // /Users/bion/projects/iordache/translator/pngenerator.g:196:2: ( ^( ( TO | FROM ) ( ID )+ ) ) - // /Users/bion/projects/iordache/translator/pngenerator.g:196:4: ^( ( TO | FROM ) ( ID )+ ) + // /Users/bion/projects/iordache/translator/pngenerator.g:199:2: ( ^( ( TO | FROM ) ( ID )+ ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:199:4: ^( ( TO | FROM ) ( ID )+ ) { - // /Users/bion/projects/iordache/translator/pngenerator.g:196:6: ( TO | FROM ) + // /Users/bion/projects/iordache/translator/pngenerator.g:199:6: ( TO | FROM ) { int alt9=2; @@ -1855,7 +1858,7 @@ switch (alt9) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:196:7: TO + // /Users/bion/projects/iordache/translator/pngenerator.g:199:7: TO { TO2 = (pANTLR3_BASE_TREE) MATCHT(TO, &FOLLOW_TO_in_extern_trans_def149); if (HASEXCEPTION()) @@ -1873,7 +1876,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pngenerator.g:199:7: FROM + // /Users/bion/projects/iordache/translator/pngenerator.g:202:7: FROM { FROM3 = (pANTLR3_BASE_TREE) MATCHT(FROM, &FOLLOW_FROM_in_extern_trans_def155); if (HASEXCEPTION()) @@ -1900,7 +1903,7 @@ goto ruleextern_trans_defEx; } - // /Users/bion/projects/iordache/translator/pngenerator.g:202:6: ( ID )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:205:6: ( ID )+ { int cnt10=0; @@ -1920,7 +1923,7 @@ switch (alt10) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:202:7: ID + // /Users/bion/projects/iordache/translator/pngenerator.g:205:7: ID { ID4 = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_extern_trans_def161); if (HASEXCEPTION()) @@ -1987,7 +1990,7 @@ /** * $ANTLR start trans_def - * /Users/bion/projects/iordache/translator/pngenerator.g:206:1: trans_def : ( ^( ID CODE_BLOCK ) | ^(tran= ID (place= ID )+ ( CODE_BLOCK )? ) | ^(tran= ID ^(pInit= ID (place= ID )+ ( CODE_BLOCK )? ) ) ); + * /Users/bion/projects/iordache/translator/pngenerator.g:209:1: trans_def : ( ^( ID CODE_BLOCK ) | ^(tran= ID (place= ID )+ ( CODE_BLOCK )? ) | ^(tran= ID ^(pInit= ID (place= ID )+ ( CODE_BLOCK )? ) ) ); */ static void trans_def(ppngenerator ctx) @@ -2026,7 +2029,7 @@ { { - // /Users/bion/projects/iordache/translator/pngenerator.g:219:2: ( ^( ID CODE_BLOCK ) | ^(tran= ID (place= ID )+ ( CODE_BLOCK )? ) | ^(tran= ID ^(pInit= ID (place= ID )+ ( CODE_BLOCK )? ) ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:222:2: ( ^( ID CODE_BLOCK ) | ^(tran= ID (place= ID )+ ( CODE_BLOCK )? ) | ^(tran= ID ^(pInit= ID (place= ID )+ ( CODE_BLOCK )? ) ) ) ANTLR3_UINT32 alt15; @@ -2120,7 +2123,7 @@ switch (alt15) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:219:4: ^( ID CODE_BLOCK ) + // /Users/bion/projects/iordache/translator/pngenerator.g:222:4: ^( ID CODE_BLOCK ) { ID5 = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_trans_def181); if (HASEXCEPTION()) @@ -2161,7 +2164,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pngenerator.g:227:4: ^(tran= ID (place= ID )+ ( CODE_BLOCK )? ) + // /Users/bion/projects/iordache/translator/pngenerator.g:230:4: ^(tran= ID (place= ID )+ ( CODE_BLOCK )? ) { tran = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_trans_def197); if (HASEXCEPTION()) @@ -2182,7 +2185,7 @@ goto ruletrans_defEx; } - // /Users/bion/projects/iordache/translator/pngenerator.g:229:5: (place= ID )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:232:5: (place= ID )+ { int cnt11=0; @@ -2202,7 +2205,7 @@ switch (alt11) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:229:6: place= ID + // /Users/bion/projects/iordache/translator/pngenerator.g:232:6: place= ID { place = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_trans_def204); if (HASEXCEPTION()) @@ -2251,7 +2254,7 @@ } - // /Users/bion/projects/iordache/translator/pngenerator.g:240:5: ( CODE_BLOCK )? + // /Users/bion/projects/iordache/translator/pngenerator.g:243:5: ( CODE_BLOCK )? { int alt12=2; { @@ -2264,7 +2267,7 @@ switch (alt12) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:240:6: CODE_BLOCK + // /Users/bion/projects/iordache/translator/pngenerator.g:243:6: CODE_BLOCK { CODE_BLOCK7 = (pANTLR3_BASE_TREE) MATCHT(CODE_BLOCK, &FOLLOW_CODE_BLOCK_in_trans_def213); if (HASEXCEPTION()) @@ -2299,7 +2302,7 @@ } break; case 3: - // /Users/bion/projects/iordache/translator/pngenerator.g:246:4: ^(tran= ID ^(pInit= ID (place= ID )+ ( CODE_BLOCK )? ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:249:4: ^(tran= ID ^(pInit= ID (place= ID )+ ( CODE_BLOCK )? ) ) { tran = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_trans_def231); if (HASEXCEPTION()) @@ -2339,7 +2342,7 @@ goto ruletrans_defEx; } - // /Users/bion/projects/iordache/translator/pngenerator.g:250:5: (place= ID )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:253:5: (place= ID )+ { int cnt13=0; @@ -2359,7 +2362,7 @@ switch (alt13) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:250:6: place= ID + // /Users/bion/projects/iordache/translator/pngenerator.g:253:6: place= ID { place = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_trans_def245); if (HASEXCEPTION()) @@ -2408,7 +2411,7 @@ } - // /Users/bion/projects/iordache/translator/pngenerator.g:261:5: ( CODE_BLOCK )? + // /Users/bion/projects/iordache/translator/pngenerator.g:264:5: ( CODE_BLOCK )? { int alt14=2; { @@ -2421,7 +2424,7 @@ switch (alt14) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:261:6: CODE_BLOCK + // /Users/bion/projects/iordache/translator/pngenerator.g:264:6: CODE_BLOCK { CODE_BLOCK8 = (pANTLR3_BASE_TREE) MATCHT(CODE_BLOCK, &FOLLOW_CODE_BLOCK_in_trans_def254); if (HASEXCEPTION()) @@ -2485,7 +2488,7 @@ /** * $ANTLR start select_functions - * /Users/bion/projects/iordache/translator/pngenerator.g:266:1: select_functions : ^( SELECT_DEF ID CODE_BLOCK ) ; + * /Users/bion/projects/iordache/translator/pngenerator.g:269:1: select_functions : ^( SELECT_DEF ID CODE_BLOCK ) ; */ static void select_functions(ppngenerator ctx) @@ -2501,8 +2504,8 @@ CODE_BLOCK10 = NULL; { - // /Users/bion/projects/iordache/translator/pngenerator.g:267:2: ( ^( SELECT_DEF ID CODE_BLOCK ) ) - // /Users/bion/projects/iordache/translator/pngenerator.g:267:4: ^( SELECT_DEF ID CODE_BLOCK ) + // /Users/bion/projects/iordache/translator/pngenerator.g:270:2: ( ^( SELECT_DEF ID CODE_BLOCK ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:270:4: ^( SELECT_DEF ID CODE_BLOCK ) { MATCHT(SELECT_DEF, &FOLLOW_SELECT_DEF_in_select_functions271); if (HASEXCEPTION()) @@ -2568,7 +2571,7 @@ /** * $ANTLR start nondeterm - * /Users/bion/projects/iordache/translator/pngenerator.g:274:1: nondeterm : ^( 'nondeterministic places: ' ( ID )+ ) ; + * /Users/bion/projects/iordache/translator/pngenerator.g:277:1: nondeterm : ^( 'nondeterministic places: ' ( ID )+ ) ; */ static void nondeterm(ppngenerator ctx) @@ -2582,8 +2585,8 @@ ID11 = NULL; { - // /Users/bion/projects/iordache/translator/pngenerator.g:275:2: ( ^( 'nondeterministic places: ' ( ID )+ ) ) - // /Users/bion/projects/iordache/translator/pngenerator.g:275:4: ^( 'nondeterministic places: ' ( ID )+ ) + // /Users/bion/projects/iordache/translator/pngenerator.g:278:2: ( ^( 'nondeterministic places: ' ( ID )+ ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:278:4: ^( 'nondeterministic places: ' ( ID )+ ) { MATCHT(45, &FOLLOW_45_in_nondeterm288); if (HASEXCEPTION()) @@ -2598,7 +2601,7 @@ goto rulenondetermEx; } - // /Users/bion/projects/iordache/translator/pngenerator.g:275:34: ( ID )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:278:34: ( ID )+ { int cnt16=0; @@ -2618,7 +2621,7 @@ switch (alt16) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:275:35: ID + // /Users/bion/projects/iordache/translator/pngenerator.g:278:35: ID { ID11 = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_nondeterm291); if (HASEXCEPTION()) @@ -2686,7 +2689,7 @@ /** * $ANTLR start proc_instantiations - * /Users/bion/projects/iordache/translator/pngenerator.g:281:1: proc_instantiations : ( proc_init | sync_def | proc_start ); + * /Users/bion/projects/iordache/translator/pngenerator.g:284:1: proc_instantiations : ( proc_init | sync_def | proc_start ); */ static void proc_instantiations(ppngenerator ctx) @@ -2697,7 +2700,7 @@ ctx->ppngenerator_proc_instantiationsTop = ppngenerator_proc_instantiationsPush(ctx); { { - // /Users/bion/projects/iordache/translator/pngenerator.g:287:2: ( proc_init | sync_def | proc_start ) + // /Users/bion/projects/iordache/translator/pngenerator.g:290:2: ( proc_init | sync_def | proc_start ) ANTLR3_UINT32 alt17; @@ -2735,7 +2738,7 @@ switch (alt17) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:287:4: proc_init + // /Users/bion/projects/iordache/translator/pngenerator.g:290:4: proc_init { FOLLOWPUSH(FOLLOW_proc_init_in_proc_instantiations310); proc_init(ctx); @@ -2750,7 +2753,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pngenerator.g:287:16: sync_def + // /Users/bion/projects/iordache/translator/pngenerator.g:290:16: sync_def { FOLLOWPUSH(FOLLOW_sync_def_in_proc_instantiations314); sync_def(ctx); @@ -2765,7 +2768,7 @@ } break; case 3: - // /Users/bion/projects/iordache/translator/pngenerator.g:287:27: proc_start + // /Users/bion/projects/iordache/translator/pngenerator.g:290:27: proc_start { FOLLOWPUSH(FOLLOW_proc_start_in_proc_instantiations318); proc_start(ctx); @@ -2804,7 +2807,7 @@ /** * $ANTLR start proc_init - * /Users/bion/projects/iordache/translator/pngenerator.g:288:1: proc_init : ^( ID ( numbered_ID[$proc_instantiations::places] )+ ) ; + * /Users/bion/projects/iordache/translator/pngenerator.g:291:1: proc_init : ^( ID ( numbered_ID[$proc_instantiations::places] )+ ) ; */ static void proc_init(ppngenerator ctx) @@ -2827,8 +2830,8 @@ numbered_ID13 = NULL; { - // /Users/bion/projects/iordache/translator/pngenerator.g:294:2: ( ^( ID ( numbered_ID[$proc_instantiations::places] )+ ) ) - // /Users/bion/projects/iordache/translator/pngenerator.g:294:4: ^( ID ( numbered_ID[$proc_instantiations::places] )+ ) + // /Users/bion/projects/iordache/translator/pngenerator.g:297:2: ( ^( ID ( numbered_ID[$proc_instantiations::places] )+ ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:297:4: ^( ID ( numbered_ID[$proc_instantiations::places] )+ ) { ID12 = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_proc_init333); if (HASEXCEPTION()) @@ -2856,7 +2859,7 @@ goto ruleproc_initEx; } - // /Users/bion/projects/iordache/translator/pngenerator.g:303:5: ( numbered_ID[$proc_instantiations::places] )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:306:5: ( numbered_ID[$proc_instantiations::places] )+ { int cnt18=0; @@ -2876,7 +2879,7 @@ switch (alt18) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:303:6: numbered_ID[$proc_instantiations::places] + // /Users/bion/projects/iordache/translator/pngenerator.g:306:6: numbered_ID[$proc_instantiations::places] { FOLLOWPUSH(FOLLOW_numbered_ID_in_proc_init338); numbered_ID13=numbered_ID(ctx, (SCOPE_TOP(proc_instantiations))->places); @@ -2963,7 +2966,7 @@ /** * $ANTLR start sync_def - * /Users/bion/projects/iordache/translator/pngenerator.g:321:1: sync_def : ^( SYNC_TOK ( group_elements )+ ) ; + * /Users/bion/projects/iordache/translator/pngenerator.g:324:1: sync_def : ^( SYNC_TOK ( group_elements )+ ) ; */ static void sync_def(ppngenerator ctx) @@ -2983,8 +2986,8 @@ group_elements14 = NULL; { - // /Users/bion/projects/iordache/translator/pngenerator.g:326:2: ( ^( SYNC_TOK ( group_elements )+ ) ) - // /Users/bion/projects/iordache/translator/pngenerator.g:326:4: ^( SYNC_TOK ( group_elements )+ ) + // /Users/bion/projects/iordache/translator/pngenerator.g:329:2: ( ^( SYNC_TOK ( group_elements )+ ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:329:4: ^( SYNC_TOK ( group_elements )+ ) { MATCHT(SYNC_TOK, &FOLLOW_SYNC_TOK_in_sync_def361); if (HASEXCEPTION()) @@ -2999,7 +3002,7 @@ goto rulesync_defEx; } - // /Users/bion/projects/iordache/translator/pngenerator.g:326:15: ( group_elements )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:329:15: ( group_elements )+ { int cnt19=0; @@ -3019,7 +3022,7 @@ switch (alt19) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:326:16: group_elements + // /Users/bion/projects/iordache/translator/pngenerator.g:329:16: group_elements { FOLLOWPUSH(FOLLOW_group_elements_in_sync_def364); group_elements14=group_elements(ctx); @@ -3136,7 +3139,7 @@ /** * $ANTLR start proc_start - * /Users/bion/projects/iordache/translator/pngenerator.g:374:1: proc_start : ^( START ( ID )+ ) ; + * /Users/bion/projects/iordache/translator/pngenerator.g:377:1: proc_start : ^( START ( ID )+ ) ; */ static void proc_start(ppngenerator ctx) @@ -3150,8 +3153,8 @@ ID15 = NULL; { - // /Users/bion/projects/iordache/translator/pngenerator.g:375:2: ( ^( START ( ID )+ ) ) - // /Users/bion/projects/iordache/translator/pngenerator.g:375:4: ^( START ( ID )+ ) + // /Users/bion/projects/iordache/translator/pngenerator.g:378:2: ( ^( START ( ID )+ ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:378:4: ^( START ( ID )+ ) { MATCHT(START, &FOLLOW_START_in_proc_start381); if (HASEXCEPTION()) @@ -3166,7 +3169,7 @@ goto ruleproc_startEx; } - // /Users/bion/projects/iordache/translator/pngenerator.g:375:12: ( ID )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:378:12: ( ID )+ { int cnt20=0; @@ -3186,7 +3189,7 @@ switch (alt20) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:375:13: ID + // /Users/bion/projects/iordache/translator/pngenerator.g:378:13: ID { ID15 = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_proc_start384); if (HASEXCEPTION()) @@ -3256,18 +3259,22 @@ /** * $ANTLR start constraints - * /Users/bion/projects/iordache/translator/pngenerator.g:383:1: constraints : ^( constraint_block ( eq )* ( live_def )? ( uncontrol )? ( unobserve )? ) ; + * /Users/bion/projects/iordache/translator/pngenerator.g:386:1: constraints : ^( constraint_block ( eq )* ( live_def )? ( uncontrol )? ( unobserve )? ) ; */ static void constraints(ppngenerator ctx) { + pngenerator_eq_return eq16; + #undef RETURN_TYPE_eq16 + #define RETURN_TYPE_eq16 pngenerator_eq_return + /* Initialize rule variables */ ctx->ppngenerator_constraintsTop = ppngenerator_constraintsPush(ctx); { - // /Users/bion/projects/iordache/translator/pngenerator.g:389:2: ( ^( constraint_block ( eq )* ( live_def )? ( uncontrol )? ( unobserve )? ) ) - // /Users/bion/projects/iordache/translator/pngenerator.g:389:4: ^( constraint_block ( eq )* ( live_def )? ( uncontrol )? ( unobserve )? ) + // /Users/bion/projects/iordache/translator/pngenerator.g:392:2: ( ^( constraint_block ( eq )* ( live_def )? ( uncontrol )? ( unobserve )? ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:392:4: ^( constraint_block ( eq )* ( live_def )? ( uncontrol )? ( unobserve )? ) { FOLLOWPUSH(FOLLOW_constraint_block_in_constraints404); constraint_block(ctx); @@ -3287,7 +3294,7 @@ } - // /Users/bion/projects/iordache/translator/pngenerator.g:389:23: ( eq )* + // /Users/bion/projects/iordache/translator/pngenerator.g:392:23: ( eq )* for (;;) { @@ -3305,10 +3312,10 @@ switch (alt21) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:389:23: eq + // /Users/bion/projects/iordache/translator/pngenerator.g:392:24: eq { - FOLLOWPUSH(FOLLOW_eq_in_constraints406); - eq(ctx); + FOLLOWPUSH(FOLLOW_eq_in_constraints407); + eq16=eq(ctx); FOLLOWPOP(); if (HASEXCEPTION()) @@ -3316,7 +3323,12 @@ goto ruleconstraintsEx; } + { + constraintList[constraintNum]->expr = (expression*) eq16.ret; + + } + } break; @@ -3328,7 +3340,7 @@ loop21: ; /* Jump out to here if this rule does not match */ - // /Users/bion/projects/iordache/translator/pngenerator.g:389:27: ( live_def )? + // /Users/bion/projects/iordache/translator/pngenerator.g:394:7: ( live_def )? { int alt22=2; { @@ -3341,9 +3353,9 @@ switch (alt22) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:389:27: live_def + // /Users/bion/projects/iordache/translator/pngenerator.g:394:7: live_def { - FOLLOWPUSH(FOLLOW_live_def_in_constraints409); + FOLLOWPUSH(FOLLOW_live_def_in_constraints413); live_def(ctx); FOLLOWPOP(); @@ -3359,7 +3371,7 @@ } } - // /Users/bion/projects/iordache/translator/pngenerator.g:389:37: ( uncontrol )? + // /Users/bion/projects/iordache/translator/pngenerator.g:394:17: ( uncontrol )? { int alt23=2; { @@ -3372,9 +3384,9 @@ switch (alt23) { case 1: - // /Users/bion/proje... [truncated message content] |
From: <the...@us...> - 2009-06-21 17:13:37
|
Revision: 89 http://pntool.svn.sourceforge.net/pntool/?rev=89&view=rev Author: thecodeweasel Date: 2009-06-21 17:13:25 +0000 (Sun, 21 Jun 2009) Log Message: ----------- Working on building a constraints array. I'm assuming it's an array and not a linked list... Modified Paths: -------------- translator/main.c translator/pncompactor.c translator/pncompactor.g translator/pncompactor.h translator/pngenerator.c translator/pngenerator.g translator/pngenerator.h Modified: translator/main.c =================================================================== --- translator/main.c 2009-06-20 19:43:23 UTC (rev 88) +++ translator/main.c 2009-06-21 17:13:25 UTC (rev 89) @@ -226,6 +226,9 @@ if (psr->pParser->rec->state->errorCount > 0) { fprintf(stderr, "The parser returned %d error(s), tree walking aborted.\n", psr->pParser->rec->state->errorCount); } else { + int* numConstraints; + numConstraints = tmalloc(sizeof(int)); + *numConstraints = 0; nodes = antlr3CommonTreeNodeStreamNewTree(pnscriptAST.tree, ANTLR3_SIZE_HINT); // sIZE HINT WILL SOON BE DEPRECATED!! //print tree structure from the initial parsing @@ -241,7 +244,7 @@ printf("Done.\n"); fflush(stdout); printf("Validating and optimizing...\n"); - pncompactAST = treePsr->pn(treePsr); + pncompactAST = treePsr->pn(treePsr, numConstraints); if (treePsr->pTreeParser->rec->state->errorCount > 0) { fprintf(stderr, "The parser returned %d error(s), tree walking aborted.\n", treePsr->pTreeParser->rec->state->errorCount); } else { @@ -259,7 +262,7 @@ printf("Done.\n"); fflush(stdout); printf("Generating Petri Nets...\n"); - output = generator->pn(generator, processes, threads, (char*) fName); + output = generator->pn(generator, processes, threads, (char*) fName, *numConstraints); if (generator->pTreeParser->rec->state->errorCount > 0) { fprintf(stderr, "The parser returned %d error(s), code generation aborted.\n", generator->pTreeParser->rec->state->errorCount); } @@ -267,6 +270,7 @@ nodes ->free (nodes); nodes = NULL; generator ->free (generator); generator = NULL; } + free(numConstraints); numConstraints = NULL; } // We did not return anything from this parser rule, so we can finish. It only remains Modified: translator/pncompactor.c =================================================================== --- translator/pncompactor.c 2009-06-20 19:43:23 UTC (rev 88) +++ translator/pncompactor.c 2009-06-21 17:13:25 UTC (rev 89) @@ -2,7 +2,7 @@ * This C source file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pncompactor.g - * - On : 2009-06-19 16:07:30 + * - On : 2009-06-20 00:57:44 * - for the tree parser : pncompactorTreeParser * * Editing it, at least manually, is not wise. * @@ -361,7 +361,7 @@ // Forward declare the locally static matching functions we have generated. // -static pncompactor_pn_return pn (ppncompactor ctx); +static pncompactor_pn_return pn (ppncompactor ctx, int* num); static pncompactor_proc_definitions_return proc_definitions (ppncompactor ctx); static pncompactor_def_start_return def_start (ppncompactor ctx); static pncompactor_trans_defs_return trans_defs (ppncompactor ctx); @@ -545,277 +545,280 @@ return pncompactorTokenNames; } + + int* numConstraints; + /* Declare the bitsets */ -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_definitions_in_pn78 */ -static ANTLR3_BITWORD FOLLOW_proc_definitions_in_pn78_bits[] = { ANTLR3_UINT64_LIT(0x0000000000C00400) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_definitions_in_pn78 = { FOLLOW_proc_definitions_in_pn78_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_pn81 */ -static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_pn81_bits[] = { ANTLR3_UINT64_LIT(0x0000000400C00402) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_pn81 = { FOLLOW_proc_instantiations_in_pn81_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraints_in_pn84 */ -static ANTLR3_BITWORD FOLLOW_constraints_in_pn84_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000402) }; -static ANTLR3_BITSET_LIST FOLLOW_constraints_in_pn84 = { FOLLOW_constraints_in_pn84_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_other_commands_in_pn87 */ -static ANTLR3_BITWORD FOLLOW_other_commands_in_pn87_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000002) }; -static ANTLR3_BITSET_LIST FOLLOW_other_commands_in_pn87 = { FOLLOW_other_commands_in_pn87_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_def_start_in_proc_definitions99 */ -static ANTLR3_BITWORD FOLLOW_def_start_in_proc_definitions99_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_def_start_in_proc_definitions99 = { FOLLOW_def_start_in_proc_definitions99_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_trans_defs_in_proc_definitions101 */ -static ANTLR3_BITWORD FOLLOW_trans_defs_in_proc_definitions101_bits[] = { ANTLR3_UINT64_LIT(0x0000200000200468) }; -static ANTLR3_BITSET_LIST FOLLOW_trans_defs_in_proc_definitions101 = { FOLLOW_trans_defs_in_proc_definitions101_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_select_functions_in_proc_definitions104 */ -static ANTLR3_BITWORD FOLLOW_select_functions_in_proc_definitions104_bits[] = { ANTLR3_UINT64_LIT(0x0000200000200008) }; -static ANTLR3_BITSET_LIST FOLLOW_select_functions_in_proc_definitions104 = { FOLLOW_select_functions_in_proc_definitions104_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_nondeterm_in_proc_definitions107 */ -static ANTLR3_BITWORD FOLLOW_nondeterm_in_proc_definitions107_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_nondeterm_in_proc_definitions107 = { FOLLOW_nondeterm_in_proc_definitions107_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_def_start118 */ -static ANTLR3_BITWORD FOLLOW_ID_in_def_start118_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_def_start118 = { FOLLOW_ID_in_def_start118_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_extern_trans_def_in_trans_defs126 */ -static ANTLR3_BITWORD FOLLOW_extern_trans_def_in_trans_defs126_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_extern_trans_def_in_trans_defs126 = { FOLLOW_extern_trans_def_in_trans_defs126_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_trans_def_in_trans_defs131 */ -static ANTLR3_BITWORD FOLLOW_trans_def_in_trans_defs131_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_trans_def_in_trans_defs131 = { FOLLOW_trans_def_in_trans_defs131_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_set_in_extern_trans_def141 */ -static ANTLR3_BITWORD FOLLOW_set_in_extern_trans_def141_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_set_in_extern_trans_def141 = { FOLLOW_set_in_extern_trans_def141_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_extern_trans_def149 */ -static ANTLR3_BITWORD FOLLOW_ID_in_extern_trans_def149_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_extern_trans_def149 = { FOLLOW_ID_in_extern_trans_def149_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def161 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def161_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def161 = { FOLLOW_ID_in_trans_def161_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def163 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def163_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def163 = { FOLLOW_CODE_BLOCK_in_trans_def163_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def170 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def170_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def170 = { FOLLOW_ID_in_trans_def170_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def172 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def172_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def172 = { FOLLOW_ID_in_trans_def172_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_definitions_in_pn90 */ +static ANTLR3_BITWORD FOLLOW_proc_definitions_in_pn90_bits[] = { ANTLR3_UINT64_LIT(0x0000000000C00400) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_definitions_in_pn90 = { FOLLOW_proc_definitions_in_pn90_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_pn93 */ +static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_pn93_bits[] = { ANTLR3_UINT64_LIT(0x0000000400C00402) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_pn93 = { FOLLOW_proc_instantiations_in_pn93_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraints_in_pn96 */ +static ANTLR3_BITWORD FOLLOW_constraints_in_pn96_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000402) }; +static ANTLR3_BITSET_LIST FOLLOW_constraints_in_pn96 = { FOLLOW_constraints_in_pn96_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_other_commands_in_pn99 */ +static ANTLR3_BITWORD FOLLOW_other_commands_in_pn99_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000002) }; +static ANTLR3_BITSET_LIST FOLLOW_other_commands_in_pn99 = { FOLLOW_other_commands_in_pn99_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_def_start_in_proc_definitions111 */ +static ANTLR3_BITWORD FOLLOW_def_start_in_proc_definitions111_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_def_start_in_proc_definitions111 = { FOLLOW_def_start_in_proc_definitions111_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_trans_defs_in_proc_definitions113 */ +static ANTLR3_BITWORD FOLLOW_trans_defs_in_proc_definitions113_bits[] = { ANTLR3_UINT64_LIT(0x0000200000200468) }; +static ANTLR3_BITSET_LIST FOLLOW_trans_defs_in_proc_definitions113 = { FOLLOW_trans_defs_in_proc_definitions113_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_select_functions_in_proc_definitions116 */ +static ANTLR3_BITWORD FOLLOW_select_functions_in_proc_definitions116_bits[] = { ANTLR3_UINT64_LIT(0x0000200000200008) }; +static ANTLR3_BITSET_LIST FOLLOW_select_functions_in_proc_definitions116 = { FOLLOW_select_functions_in_proc_definitions116_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_nondeterm_in_proc_definitions119 */ +static ANTLR3_BITWORD FOLLOW_nondeterm_in_proc_definitions119_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_nondeterm_in_proc_definitions119 = { FOLLOW_nondeterm_in_proc_definitions119_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_def_start130 */ +static ANTLR3_BITWORD FOLLOW_ID_in_def_start130_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_def_start130 = { FOLLOW_ID_in_def_start130_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_extern_trans_def_in_trans_defs138 */ +static ANTLR3_BITWORD FOLLOW_extern_trans_def_in_trans_defs138_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_extern_trans_def_in_trans_defs138 = { FOLLOW_extern_trans_def_in_trans_defs138_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_trans_def_in_trans_defs143 */ +static ANTLR3_BITWORD FOLLOW_trans_def_in_trans_defs143_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_trans_def_in_trans_defs143 = { FOLLOW_trans_def_in_trans_defs143_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_set_in_extern_trans_def153 */ +static ANTLR3_BITWORD FOLLOW_set_in_extern_trans_def153_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_set_in_extern_trans_def153 = { FOLLOW_set_in_extern_trans_def153_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_extern_trans_def161 */ +static ANTLR3_BITWORD FOLLOW_ID_in_extern_trans_def161_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_extern_trans_def161 = { FOLLOW_ID_in_extern_trans_def161_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def173 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def173_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def173 = { FOLLOW_ID_in_trans_def173_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def175 */ static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def175_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def175 = { FOLLOW_CODE_BLOCK_in_trans_def175_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def183 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def183_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def183 = { FOLLOW_ID_in_trans_def183_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def186 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def186_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def186 = { FOLLOW_ID_in_trans_def186_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def188 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def188_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def188 = { FOLLOW_ID_in_trans_def188_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def191 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def191_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def191 = { FOLLOW_CODE_BLOCK_in_trans_def191_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SELECT_DEF_in_select_functions203 */ -static ANTLR3_BITWORD FOLLOW_SELECT_DEF_in_select_functions203_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SELECT_DEF_in_select_functions203 = { FOLLOW_SELECT_DEF_in_select_functions203_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_select_functions205 */ -static ANTLR3_BITWORD FOLLOW_ID_in_select_functions205_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002000) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_select_functions205 = { FOLLOW_ID_in_select_functions205_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_select_functions207 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_select_functions207_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_select_functions207 = { FOLLOW_CODE_BLOCK_in_select_functions207_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_45_in_nondeterm218 */ -static ANTLR3_BITWORD FOLLOW_45_in_nondeterm218_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_45_in_nondeterm218 = { FOLLOW_45_in_nondeterm218_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_nondeterm220 */ -static ANTLR3_BITWORD FOLLOW_ID_in_nondeterm220_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_nondeterm220 = { FOLLOW_ID_in_nondeterm220_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_init_in_proc_instantiations232 */ -static ANTLR3_BITWORD FOLLOW_proc_init_in_proc_instantiations232_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_init_in_proc_instantiations232 = { FOLLOW_proc_init_in_proc_instantiations232_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_sync_def_in_proc_instantiations236 */ -static ANTLR3_BITWORD FOLLOW_sync_def_in_proc_instantiations236_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_sync_def_in_proc_instantiations236 = { FOLLOW_sync_def_in_proc_instantiations236_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_start_in_proc_instantiations240 */ -static ANTLR3_BITWORD FOLLOW_proc_start_in_proc_instantiations240_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_start_in_proc_instantiations240 = { FOLLOW_proc_start_in_proc_instantiations240_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init250 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_init250_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init250 = { FOLLOW_ID_in_proc_init250_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_numbered_ID_in_proc_init252 */ -static ANTLR3_BITWORD FOLLOW_numbered_ID_in_proc_init252_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_numbered_ID_in_proc_init252 = { FOLLOW_numbered_ID_in_proc_init252_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SYNC_TOK_in_sync_def264 */ -static ANTLR3_BITWORD FOLLOW_SYNC_TOK_in_sync_def264_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SYNC_TOK_in_sync_def264 = { FOLLOW_SYNC_TOK_in_sync_def264_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_sync_def266 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def266_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_sync_def266 = { FOLLOW_group_elements_in_sync_def266_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start278 */ -static ANTLR3_BITWORD FOLLOW_START_in_proc_start278_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start278 = { FOLLOW_START_in_proc_start278_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start280 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_start280_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start280 = { FOLLOW_ID_in_proc_start280_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints297 */ -static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints297_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints297 = { FOLLOW_constraint_block_in_constraints297_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints302 */ -static ANTLR3_BITWORD FOLLOW_eq_in_constraints302_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints302 = { FOLLOW_eq_in_constraints302_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints308 */ -static ANTLR3_BITWORD FOLLOW_live_def_in_constraints308_bits[] = { ANTLR3_UINT64_LIT(0x0000000300000008) }; -static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints308 = { FOLLOW_live_def_in_constraints308_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints311 */ -static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints311_bits[] = { ANTLR3_UINT64_LIT(0x0000000200000008) }; -static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints311 = { FOLLOW_uncontrol_in_constraints311_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints314 */ -static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints314_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints314 = { FOLLOW_unobserve_in_constraints314_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block324 */ -static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block324_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block324 = { FOLLOW_ID_in_constraint_block324_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq333 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq333_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq333 = { FOLLOW_relationalExpression_in_eq333_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq339 */ -static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq339_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq339 = { FOLLOW_EQS_OP_in_eq339_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq341 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq341_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq341 = { FOLLOW_eq_in_eq341_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq343 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq343_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq343 = { FOLLOW_eq_in_eq343_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression365 */ -static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression365_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression365 = { FOLLOW_EQ_OP_in_relationalExpression365_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression368 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression368_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression368 = { FOLLOW_relationalExpression_in_relationalExpression368_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression370 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression370_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression370 = { FOLLOW_additiveExpression_in_relationalExpression370_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression376 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression376_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression376 = { FOLLOW_relationalExpression_in_relationalExpression376_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression378 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression378_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression378 = { FOLLOW_additiveExpression_in_relationalExpression378_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression400 */ -static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression400_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression400 = { FOLLOW_primary_in_additiveExpression400_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_PLUS_in_additiveExpression410 */ -static ANTLR3_BITWORD FOLLOW_PLUS_in_additiveExpression410_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_PLUS_in_additiveExpression410 = { FOLLOW_PLUS_in_additiveExpression410_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression414 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression414_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression414 = { FOLLOW_additiveExpression_in_additiveExpression414_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression431 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression431_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression431 = { FOLLOW_additiveExpression_in_additiveExpression431_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_additiveExpression481 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_additiveExpression481_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_additiveExpression481 = { FOLLOW_MINUS_in_additiveExpression481_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression485 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression485_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression485 = { FOLLOW_additiveExpression_in_additiveExpression485_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression501 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression501_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression501 = { FOLLOW_additiveExpression_in_additiveExpression501_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_primary562 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_primary562_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_primary562 = { FOLLOW_MINUS_in_primary562_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary566 */ -static ANTLR3_BITWORD FOLLOW_eq_in_primary566_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary566 = { FOLLOW_eq_in_primary566_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary581 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_primary581_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary581 = { FOLLOW_group_elements_in_primary581_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary622 */ -static ANTLR3_BITWORD FOLLOW_number_in_primary622_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_primary622 = { FOLLOW_number_in_primary622_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary633 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_primary633_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary633 = { FOLLOW_MULT_in_primary633_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary635 */ -static ANTLR3_BITWORD FOLLOW_number_in_primary635_bits[] = { ANTLR3_UINT64_LIT(0x0000000021040088) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_primary635 = { FOLLOW_number_in_primary635_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary637 */ -static ANTLR3_BITWORD FOLLOW_primary_in_primary637_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary637 = { FOLLOW_primary_in_primary637_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary672 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_primary672_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary672 = { FOLLOW_MULT_in_primary672_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary674 */ -static ANTLR3_BITWORD FOLLOW_number_in_primary674_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_primary674 = { FOLLOW_number_in_primary674_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary678 */ -static ANTLR3_BITWORD FOLLOW_eq_in_primary678_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary678 = { FOLLOW_eq_in_primary678_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def702 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def702_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def702 = { FOLLOW_LIVE_in_live_def702_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def704 */ -static ANTLR3_BITWORD FOLLOW_ALL_in_live_def704_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def704 = { FOLLOW_ALL_in_live_def704_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def706 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def706_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def706 = { FOLLOW_ID_in_live_def706_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def182 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def182_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def182 = { FOLLOW_ID_in_trans_def182_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def184 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def184_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def184 = { FOLLOW_ID_in_trans_def184_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def187 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def187_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def187 = { FOLLOW_CODE_BLOCK_in_trans_def187_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def195 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def195_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def195 = { FOLLOW_ID_in_trans_def195_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def198 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def198_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def198 = { FOLLOW_ID_in_trans_def198_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def200 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def200_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def200 = { FOLLOW_ID_in_trans_def200_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def203 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def203_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def203 = { FOLLOW_CODE_BLOCK_in_trans_def203_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SELECT_DEF_in_select_functions215 */ +static ANTLR3_BITWORD FOLLOW_SELECT_DEF_in_select_functions215_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SELECT_DEF_in_select_functions215 = { FOLLOW_SELECT_DEF_in_select_functions215_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_select_functions217 */ +static ANTLR3_BITWORD FOLLOW_ID_in_select_functions217_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002000) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_select_functions217 = { FOLLOW_ID_in_select_functions217_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_select_functions219 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_select_functions219_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_select_functions219 = { FOLLOW_CODE_BLOCK_in_select_functions219_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_45_in_nondeterm230 */ +static ANTLR3_BITWORD FOLLOW_45_in_nondeterm230_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_45_in_nondeterm230 = { FOLLOW_45_in_nondeterm230_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_nondeterm232 */ +static ANTLR3_BITWORD FOLLOW_ID_in_nondeterm232_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_nondeterm232 = { FOLLOW_ID_in_nondeterm232_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_init_in_proc_instantiations244 */ +static ANTLR3_BITWORD FOLLOW_proc_init_in_proc_instantiations244_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_init_in_proc_instantiations244 = { FOLLOW_proc_init_in_proc_instantiations244_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_sync_def_in_proc_instantiations248 */ +static ANTLR3_BITWORD FOLLOW_sync_def_in_proc_instantiations248_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_sync_def_in_proc_instantiations248 = { FOLLOW_sync_def_in_proc_instantiations248_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_start_in_proc_instantiations252 */ +static ANTLR3_BITWORD FOLLOW_proc_start_in_proc_instantiations252_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_start_in_proc_instantiations252 = { FOLLOW_proc_start_in_proc_instantiations252_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init262 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_init262_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init262 = { FOLLOW_ID_in_proc_init262_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_numbered_ID_in_proc_init264 */ +static ANTLR3_BITWORD FOLLOW_numbered_ID_in_proc_init264_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_numbered_ID_in_proc_init264 = { FOLLOW_numbered_ID_in_proc_init264_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SYNC_TOK_in_sync_def276 */ +static ANTLR3_BITWORD FOLLOW_SYNC_TOK_in_sync_def276_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SYNC_TOK_in_sync_def276 = { FOLLOW_SYNC_TOK_in_sync_def276_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_sync_def278 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def278_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_sync_def278 = { FOLLOW_group_elements_in_sync_def278_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start290 */ +static ANTLR3_BITWORD FOLLOW_START_in_proc_start290_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start290 = { FOLLOW_START_in_proc_start290_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start292 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_start292_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start292 = { FOLLOW_ID_in_proc_start292_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints309 */ +static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints309_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints309 = { FOLLOW_constraint_block_in_constraints309_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints314 */ +static ANTLR3_BITWORD FOLLOW_eq_in_constraints314_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints314 = { FOLLOW_eq_in_constraints314_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints320 */ +static ANTLR3_BITWORD FOLLOW_live_def_in_constraints320_bits[] = { ANTLR3_UINT64_LIT(0x0000000300000008) }; +static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints320 = { FOLLOW_live_def_in_constraints320_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints323 */ +static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints323_bits[] = { ANTLR3_UINT64_LIT(0x0000000200000008) }; +static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints323 = { FOLLOW_uncontrol_in_constraints323_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints326 */ +static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints326_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints326 = { FOLLOW_unobserve_in_constraints326_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block336 */ +static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block336_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block336 = { FOLLOW_ID_in_constraint_block336_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq345 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq345_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq345 = { FOLLOW_relationalExpression_in_eq345_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq351 */ +static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq351_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq351 = { FOLLOW_EQS_OP_in_eq351_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq353 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq353_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq353 = { FOLLOW_eq_in_eq353_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq355 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq355_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq355 = { FOLLOW_eq_in_eq355_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression377 */ +static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression377_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression377 = { FOLLOW_EQ_OP_in_relationalExpression377_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression380 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression380_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression380 = { FOLLOW_relationalExpression_in_relationalExpression380_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression382 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression382_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression382 = { FOLLOW_additiveExpression_in_relationalExpression382_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression388 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression388_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression388 = { FOLLOW_relationalExpression_in_relationalExpression388_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression390 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression390_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression390 = { FOLLOW_additiveExpression_in_relationalExpression390_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression412 */ +static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression412_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression412 = { FOLLOW_primary_in_additiveExpression412_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_PLUS_in_additiveExpression422 */ +static ANTLR3_BITWORD FOLLOW_PLUS_in_additiveExpression422_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_PLUS_in_additiveExpression422 = { FOLLOW_PLUS_in_additiveExpression422_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression426 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression426_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression426 = { FOLLOW_additiveExpression_in_additiveExpression426_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression443 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression443_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression443 = { FOLLOW_additiveExpression_in_additiveExpression443_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_additiveExpression493 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_additiveExpression493_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_additiveExpression493 = { FOLLOW_MINUS_in_additiveExpression493_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression497 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression497_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression497 = { FOLLOW_additiveExpression_in_additiveExpression497_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression513 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression513_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression513 = { FOLLOW_additiveExpression_in_additiveExpression513_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_primary574 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_primary574_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_primary574 = { FOLLOW_MINUS_in_primary574_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary578 */ +static ANTLR3_BITWORD FOLLOW_eq_in_primary578_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary578 = { FOLLOW_eq_in_primary578_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary593 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_primary593_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary593 = { FOLLOW_group_elements_in_primary593_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary634 */ +static ANTLR3_BITWORD FOLLOW_number_in_primary634_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_primary634 = { FOLLOW_number_in_primary634_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary645 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_primary645_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary645 = { FOLLOW_MULT_in_primary645_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary647 */ +static ANTLR3_BITWORD FOLLOW_number_in_primary647_bits[] = { ANTLR3_UINT64_LIT(0x0000000021040088) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_primary647 = { FOLLOW_number_in_primary647_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary649 */ +static ANTLR3_BITWORD FOLLOW_primary_in_primary649_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary649 = { FOLLOW_primary_in_primary649_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary684 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_primary684_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary684 = { FOLLOW_MULT_in_primary684_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary686 */ +static ANTLR3_BITWORD FOLLOW_number_in_primary686_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_primary686 = { FOLLOW_number_in_primary686_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary690 */ +static ANTLR3_BITWORD FOLLOW_eq_in_primary690_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary690 = { FOLLOW_eq_in_primary690_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def714 */ static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def714_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def714 = { FOLLOW_LIVE_in_live_def714_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def716 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def716_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def716 = { FOLLOW_ID_in_live_def716_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol728 */ -static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol728_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol728 = { FOLLOW_UNCONTROL_in_uncontrol728_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol730 */ -static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol730_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol730 = { FOLLOW_ID_in_uncontrol730_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve742 */ -static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve742_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve742 = { FOLLOW_UNOBSERVE_in_unobserve742_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve744 */ -static ANTLR3_BITWORD FOLLOW_ID_in_unobserve744_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve744 = { FOLLOW_ID_in_unobserve744_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands756 */ -static ANTLR3_BITWORD FOLLOW_print_in_other_commands756_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands756 = { FOLLOW_print_in_other_commands756_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print766 */ -static ANTLR3_BITWORD FOLLOW_PRINT_in_print766_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print766 = { FOLLOW_PRINT_in_print766_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print768 */ -static ANTLR3_BITWORD FOLLOW_ID_in_print768_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_print768 = { FOLLOW_ID_in_print768_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print770 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_print770_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print770 = { FOLLOW_group_elements_in_print770_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number789 */ -static ANTLR3_BITWORD FOLLOW_INT_in_number789_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_number789 = { FOLLOW_INT_in_number789_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_number802 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_number802_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_number802 = { FOLLOW_MINUS_in_number802_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number804 */ -static ANTLR3_BITWORD FOLLOW_INT_in_number804_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_number804 = { FOLLOW_INT_in_number804_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_GROUP_in_group_elements822 */ -static ANTLR3_BITWORD FOLLOW_GROUP_in_group_elements822_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_GROUP_in_group_elements822 = { FOLLOW_GROUP_in_group_elements822_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements824 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements824_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements824 = { FOLLOW_ID_in_group_elements824_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID835 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID835_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID835 = { FOLLOW_ID_in_numbered_ID835_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID841 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID841_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID841 = { FOLLOW_ID_in_numbered_ID841_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID843 */ -static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID843_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID843 = { FOLLOW_INT_in_numbered_ID843_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def716 */ +static ANTLR3_BITWORD FOLLOW_ALL_in_live_def716_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def716 = { FOLLOW_ALL_in_live_def716_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def718 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def718_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def718 = { FOLLOW_ID_in_live_def718_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def726 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def726_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def726 = { FOLLOW_LIVE_in_live_def726_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def728 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def728_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def728 = { FOLLOW_ID_in_live_def728_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol740 */ +static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol740_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol740 = { FOLLOW_UNCONTROL_in_uncontrol740_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol742 */ +static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol742_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol742 = { FOLLOW_ID_in_uncontrol742_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve754 */ +static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve754_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve754 = { FOLLOW_UNOBSERVE_in_unobserve754_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve756 */ +static ANTLR3_BITWORD FOLLOW_ID_in_unobserve756_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve756 = { FOLLOW_ID_in_unobserve756_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands768 */ +static ANTLR3_BITWORD FOLLOW_print_in_other_commands768_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands768 = { FOLLOW_print_in_other_commands768_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print778 */ +static ANTLR3_BITWORD FOLLOW_PRINT_in_print778_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print778 = { FOLLOW_PRINT_in_print778_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print780 */ +static ANTLR3_BITWORD FOLLOW_ID_in_print780_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_print780 = { FOLLOW_ID_in_print780_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print782 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_print782_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print782 = { FOLLOW_group_elements_in_print782_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number801 */ +static ANTLR3_BITWORD FOLLOW_INT_in_number801_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_number801 = { FOLLOW_INT_in_number801_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_number814 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_number814_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_number814 = { FOLLOW_MINUS_in_number814_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number816 */ +static ANTLR3_BITWORD FOLLOW_INT_in_number816_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_number816 = { FOLLOW_INT_in_number816_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_GROUP_in_group_elements834 */ +static ANTLR3_BITWORD FOLLOW_GROUP_in_group_elements834_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_GROUP_in_group_elements834 = { FOLLOW_GROUP_in_group_elements834_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements836 */ +static ANTLR3_BITWORD FOLLOW_ID_in_group_elements836_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements836 = { FOLLOW_ID_in_group_elements836_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID847 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID847_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID847 = { FOLLOW_ID_in_numbered_ID847_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID853 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID853_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID853 = { FOLLOW_ID_in_numbered_ID853_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID855 */ +static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID855_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID855 = { FOLLOW_INT_in_numbered_ID855_bits, 1 }; @@ -823,7 +826,7 @@ * DFA tables for the parser */ /** Static dfa state tables for Cyclic dfa: - * 146:1: primary[bool enableAlt] : ( ^( MINUS eq ) -> eq | group_elements -> {!enableAlt || i == 1}? group_elements -> ^( MULT[tok2, newVal2] NUM[tok, newVal] group_elements ) | number | ^( MULT number primary[false] ) -> {$number.value == 0}? -> ^( MULT number primary ) | ^( MULT number eq ) -> {i == 0}? -> eq ); + * 154:1: primary[bool enableAlt] : ( ^( MINUS eq ) -> eq | group_elements -> {!enableAlt || i == 1}? group_elements -> ^( MULT[tok2, newVal2] NUM... [truncated message content] |
From: <com...@us...> - 2009-06-20 19:43:27
|
Revision: 88 http://pntool.svn.sourceforge.net/pntool/?rev=88&view=rev Author: compaqdrew Date: 2009-06-20 19:43:23 +0000 (Sat, 20 Jun 2009) Log Message: ----------- Fixing some supervisor bugs Modified Paths: -------------- codegen/src/codegen.xcodeproj/drew.mode1v3 codegen/src/codegen.xcodeproj/drew.pbxuser codegen/src/supervisor_static_include.h Modified: codegen/src/codegen.xcodeproj/drew.mode1v3 =================================================================== --- codegen/src/codegen.xcodeproj/drew.mode1v3 2009-06-20 19:43:13 UTC (rev 87) +++ codegen/src/codegen.xcodeproj/drew.mode1v3 2009-06-20 19:43:23 UTC (rev 88) @@ -216,7 +216,7 @@ <key>_historyCapacity</key> <integer>0</integer> <key>bookmark</key> - <string>3A09E32B0FED7130003FAB0D</string> + <string>3A09E32E0FED7148003FAB0D</string> <key>history</key> <array> <string>3AA340FA0FE9EC1D004E156E</string> @@ -256,7 +256,7 @@ <key>_historyCapacity</key> <integer>0</integer> <key>bookmark</key> - <string>3A09E32C0FED7130003FAB0D</string> + <string>3A09E32F0FED7148003FAB0D</string> <key>history</key> <array> <string>3AA340FB0FE9EC1D004E156E</string> @@ -416,7 +416,7 @@ <key>_historyCapacity</key> <integer>0</integer> <key>bookmark</key> - <string>3A09E32A0FED7130003FAB0D</string> + <string>3A09E32D0FED7148003FAB0D</string> <key>history</key> <array> <string>3A7FCEED0FBC046D00EF8097</string> Modified: codegen/src/codegen.xcodeproj/drew.pbxuser =================================================================== --- codegen/src/codegen.xcodeproj/drew.pbxuser 2009-06-20 19:43:13 UTC (rev 87) +++ codegen/src/codegen.xcodeproj/drew.pbxuser 2009-06-20 19:43:23 UTC (rev 88) @@ -142,6 +142,9 @@ 3A09E32A0FED7130003FAB0D /* PBXTextBookmark */ = 3A09E32A0FED7130003FAB0D /* PBXTextBookmark */; 3A09E32B0FED7130003FAB0D /* PBXTextBookmark */ = 3A09E32B0FED7130003FAB0D /* PBXTextBookmark */; 3A09E32C0FED7130003FAB0D /* PBXTextBookmark */ = 3A09E32C0FED7130003FAB0D /* PBXTextBookmark */; + 3A09E32D0FED7148003FAB0D /* PBXTextBookmark */ = 3A09E32D0FED7148003FAB0D /* PBXTextBookmark */; + 3A09E32E0FED7148003FAB0D /* PBXTextBookmark */ = 3A09E32E0FED7148003FAB0D /* PBXTextBookmark */; + 3A09E32F0FED7148003FAB0D /* PBXTextBookmark */ = 3A09E32F0FED7148003FAB0D /* PBXTextBookmark */; 3A232C980FB21F7F00A5C7C2 = 3A232C980FB21F7F00A5C7C2 /* PBXTextBookmark */; 3A232C9A0FB21F7F00A5C7C2 = 3A232C9A0FB21F7F00A5C7C2 /* PBXTextBookmark */; 3A232C9B0FB21F7F00A5C7C2 = 3A232C9B0FB21F7F00A5C7C2 /* PBXTextBookmark */; @@ -504,7 +507,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 439"; rLen = 0; - rLoc = 10859; + rLoc = 10882; rType = 0; vrLen = 1260; vrLoc = 5612; @@ -652,7 +655,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 439"; rLen = 0; - rLoc = 10859; + rLoc = 10882; rType = 0; vrLen = 1260; vrLoc = 5612; @@ -709,7 +712,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 439"; rLen = 0; - rLoc = 10859; + rLoc = 10882; rType = 0; vrLen = 1208; vrLoc = 5612; @@ -739,7 +742,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 440"; rLen = 0; - rLoc = 10859; + rLoc = 10882; rType = 0; vrLen = 1260; vrLoc = 5612; @@ -769,7 +772,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 440"; rLen = 0; - rLoc = 10859; + rLoc = 10882; rType = 0; vrLen = 1208; vrLoc = 5612; @@ -799,7 +802,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 440"; rLen = 0; - rLoc = 10859; + rLoc = 10882; rType = 0; vrLen = 1260; vrLoc = 5612; @@ -829,7 +832,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 440"; rLen = 0; - rLoc = 10859; + rLoc = 10882; rType = 0; vrLen = 1282; vrLoc = 5612; @@ -859,7 +862,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 441"; rLen = 0; - rLoc = 10859; + rLoc = 10882; rType = 0; vrLen = 1282; vrLoc = 5612; @@ -889,7 +892,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 441"; rLen = 0; - rLoc = 10859; + rLoc = 10882; rType = 0; vrLen = 1282; vrLoc = 5612; @@ -908,7 +911,7 @@ isa = PBXTextBookmark; fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; rLen = 8; - rLoc = 12611; + rLoc = 12634; rType = 0; }; 3A09E31C0FED708C003FAB0D /* PBXTextBookmark */ = { @@ -916,7 +919,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 499"; rLen = 0; - rLoc = 12603; + rLoc = 12626; rType = 0; vrLen = 579; vrLoc = 12331; @@ -936,7 +939,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 441"; rLen = 0; - rLoc = 10859; + rLoc = 10882; rType = 0; vrLen = 1282; vrLoc = 5612; @@ -966,7 +969,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 440"; rLen = 0; - rLoc = 10859; + rLoc = 10882; rType = 0; vrLen = 1282; vrLoc = 5612; @@ -996,7 +999,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 441"; rLen = 0; - rLoc = 10859; + rLoc = 10882; rType = 0; vrLen = 1282; vrLoc = 5612; @@ -1026,7 +1029,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 441"; rLen = 0; - rLoc = 10859; + rLoc = 10882; rType = 0; vrLen = 1282; vrLoc = 5612; @@ -1056,7 +1059,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 440"; rLen = 0; - rLoc = 10859; + rLoc = 10882; rType = 0; vrLen = 1282; vrLoc = 5612; @@ -1071,6 +1074,36 @@ vrLen = 1209; vrLoc = 4373; }; + 3A09E32D0FED7148003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 317"; + rLen = 0; + rLoc = 7548; + rType = 0; + vrLen = 1248; + vrLoc = 6569; + }; + 3A09E32E0FED7148003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 441"; + rLen = 0; + rLoc = 10882; + rType = 0; + vrLen = 1282; + vrLoc = 5612; + }; + 3A09E32F0FED7148003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 166"; + rLen = 0; + rLoc = 4872; + rType = 0; + vrLen = 1209; + vrLoc = 4373; + }; 3A13FC180FDA5F3C0051F833 /* supervisorCompler.c:176 */ = { isa = PBXFileBreakpoint; actions = ( @@ -1686,7 +1719,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 384"; rLen = 0; - rLoc = 9172; + rLoc = 9195; rType = 0; vrLen = 1708; vrLoc = 10066; @@ -1716,7 +1749,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 384"; rLen = 0; - rLoc = 9172; + rLoc = 9195; rType = 0; vrLen = 1708; vrLoc = 10066; @@ -1756,7 +1789,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 439"; rLen = 0; - rLoc = 10859; + rLoc = 10882; rType = 0; vrLen = 1332; vrLoc = 5679; @@ -1961,8 +1994,8 @@ }; 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */ = { uiCtxt = { - sepNavIntBoundsRect = "{{0, 0}, {968, 8540}}"; - sepNavSelRange = "{10859, 0}"; + sepNavIntBoundsRect = "{{0, 0}, {968, 8554}}"; + sepNavSelRange = "{10882, 0}"; sepNavVisRange = "{5612, 1282}"; sepNavWindowFrame = "{{422, -52}, {1027, 1024}}"; }; @@ -1972,7 +2005,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 15"; rLen = 0; - rLoc = 13289; + rLoc = 13312; rType = 0; vrLen = 292; vrLoc = 0; @@ -2039,7 +2072,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 439"; rLen = 0; - rLoc = 10859; + rLoc = 10882; rType = 0; vrLen = 1262; vrLoc = 5610; @@ -2097,7 +2130,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 571"; rLen = 0; - rLoc = 14851; + rLoc = 14874; rType = 0; vrLen = 1014; vrLoc = 2468; @@ -2191,7 +2224,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 576"; rLen = 0; - rLoc = 14851; + rLoc = 14874; rType = 0; vrLen = 1467; vrLoc = 2800; @@ -2261,7 +2294,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 576"; rLen = 0; - rLoc = 14851; + rLoc = 14874; rType = 0; vrLen = 1372; vrLoc = 2895; @@ -2281,7 +2314,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 449"; rLen = 0; - rLoc = 11783; + rLoc = 11806; rType = 0; vrLen = 1741; vrLoc = 10191; @@ -2311,7 +2344,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 397"; rLen = 0; - rLoc = 9531; + rLoc = 9554; rType = 0; vrLen = 1995; vrLoc = 8614; @@ -2341,7 +2374,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 399"; rLen = 0; - rLoc = 9531; + rLoc = 9554; rType = 0; vrLen = 2022; vrLoc = 8633; @@ -2371,7 +2404,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 399"; rLen = 0; - rLoc = 9531; + rLoc = 9554; rType = 0; vrLen = 2022; vrLoc = 8633; @@ -2401,7 +2434,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 399"; rLen = 0; - rLoc = 9531; + rLoc = 9554; rType = 0; vrLen = 2030; vrLoc = 8633; @@ -2431,7 +2464,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 406"; rLen = 0; - rLoc = 9531; + rLoc = 9554; rType = 0; vrLen = 2079; vrLoc = 8633; @@ -2461,7 +2494,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 397"; rLen = 0; - rLoc = 9531; + rLoc = 9554; rType = 0; vrLen = 2079; vrLoc = 8633; @@ -2491,7 +2524,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 399"; rLen = 0; - rLoc = 9531; + rLoc = 9554; rType = 0; vrLen = 2074; vrLoc = 8633; @@ -2521,7 +2554,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 397"; rLen = 0; - rLoc = 9531; + rLoc = 9554; rType = 0; vrLen = 1901; vrLoc = 8568; @@ -2551,7 +2584,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 414"; rLen = 0; - rLoc = 10263; + rLoc = 10286; rType = 0; vrLen = 1906; vrLoc = 8568; @@ -2581,7 +2614,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 414"; rLen = 0; - rLoc = 10263; + rLoc = 10286; rType = 0; vrLen = 1906; vrLoc = 8568; @@ -2611,7 +2644,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 414"; rLen = 0; - rLoc = 10187; + rLoc = 10210; rType = 0; vrLen = 1884; vrLoc = 8568; @@ -2641,7 +2674,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 414"; rLen = 0; - rLoc = 10145; + rLoc = 10168; rType = 0; vrLen = 1892; vrLoc = 8568; @@ -2671,7 +2704,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 411"; rLen = 0; - rLoc = 9980; + rLoc = 10003; rType = 0; vrLen = 1894; vrLoc = 8568; @@ -2701,7 +2734,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 414"; rLen = 0; - rLoc = 10225; + rLoc = 10248; rType = 0; vrLen = 1943; vrLoc = 8568; @@ -2731,7 +2764,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 408"; rLen = 0; - rLoc = 9531; + rLoc = 9554; rType = 0; vrLen = 2070; vrLoc = 8483; @@ -2761,7 +2794,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 408"; rLen = 0; - rLoc = 9531; + rLoc = 9554; rType = 0; vrLen = 2078; vrLoc = 8483; @@ -2791,7 +2824,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 406"; rLen = 0; - rLoc = 9531; + rLoc = 9554; rType = 0; vrLen = 2163; vrLoc = 8486; @@ -2821,7 +2854,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 406"; rLen = 0; - rLoc = 9531; + rLoc = 9554; rType = 0; vrLen = 2163; vrLoc = 8486; @@ -2851,7 +2884,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 406"; rLen = 0; - rLoc = 9531; + rLoc = 9554; rType = 0; vrLen = 2170; vrLoc = 8486; @@ -2881,7 +2914,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 413"; rLen = 0; - rLoc = 9922; + rLoc = 9945; rType = 0; vrLen = 2174; vrLoc = 8486; @@ -2911,7 +2944,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 423"; rLen = 0; - rLoc = 10438; + rLoc = 10461; rType = 0; vrLen = 2191; vrLoc = 8783; @@ -2941,7 +2974,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 423"; rLen = 0; - rLoc = 10355; + rLoc = 10378; rType = 0; vrLen = 2422; vrLoc = 9153; @@ -2971,7 +3004,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 470"; rLen = 0; - rLoc = 12212; + rLoc = 12235; rType = 0; vrLen = 1435; vrLoc = 11317; @@ -3001,7 +3034,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 462"; rLen = 0; - rLoc = 11886; + rLoc = 11909; rType = 0; vrLen = 1800; vrLoc = 10864; @@ -3031,7 +3064,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 459"; rLen = 0; - rLoc = 11783; + rLoc = 11806; rType = 0; vrLen = 1798; vrLoc = 10864; @@ -3061,7 +3094,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 463"; rLen = 0; - rLoc = 11889; + rLoc = 11912; rType = 0; vrLen = 1801; vrLoc = 10864; @@ -3091,7 +3124,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 463"; rLen = 0; - rLoc = 11889; + rLoc = 11912; rType = 0; vrLen = 1801; vrLoc = 10864; @@ -3121,7 +3154,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 384"; rLen = 0; - rLoc = 9215; + rLoc = 9238; rType = 0; vrLen = 1681; vrLoc = 8367; @@ -3151,7 +3184,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 393"; rLen = 0; - rLoc = 9312; + rLoc = 9335; rType = 0; vrLen = 1670; vrLoc = 8387; @@ -3181,7 +3214,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 444"; rLen = 0; - rLoc = 11327; + rLoc = 11350; rType = 0; vrLen = 2442; vrLoc = 9111; @@ -3211,7 +3244,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 457"; rLen = 0; - rLoc = 11656; + rLoc = 11679; rType = 0; vrLen = 2436; vrLoc = 9328; @@ -3241,7 +3274,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 398"; rLen = 0; - rLoc = 9529; + rLoc = 9552; rType = 0; vrLen = 2208; vrLoc = 8870; @@ -3271,7 +3304,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 414"; rLen = 0; - rLoc = 9922; + rLoc = 9945; rType = 0; vrLen = 2221; vrLoc = 8882; @@ -3301,7 +3334,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 414"; rLen = 0; - rLoc = 9531; + rLoc = 9554; rType = 0; vrLen = 2225; vrLoc = 8882; @@ -3331,7 +3364,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 383"; rLen = 0; - rLoc = 9169; + rLoc = 9192; rType = 0; vrLen = 2085; vrLoc = 8825; @@ -3361,7 +3394,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 460"; rLen = 0; - rLoc = 11656; + rLoc = 11679; rType = 0; vrLen = 1977; vrLoc = 10587; @@ -3391,7 +3424,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 411"; rLen = 0; - rLoc = 9892; + rLoc = 9915; rType = 0; vrLen = 1874; vrLoc = 8967; @@ -3421,7 +3454,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 478"; rLen = 0; - rLoc = 12248; + rLoc = 12271; rType = 0; vrLen = 1498; vrLoc = 10980; @@ -3451,7 +3484,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 495"; rLen = 0; - rLoc = 12603; + rLoc = 12626; rType = 0; vrLen = 1500; vrLoc = 10980; @@ -3481,7 +3514,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 476"; rLen = 0; - rLoc = 12187; + rLoc = 12210; rType = 0; vrLen = 1504; vrLoc = 10980; @@ -3511,7 +3544,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 495"; rLen = 0; - rLoc = 12603; + rLoc = 12626; rType = 0; vrLen = 1502; vrLoc = 10980; @@ -3541,7 +3574,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 495"; rLen = 0; - rLoc = 12623; + rLoc = 12646; rType = 0; vrLen = 1502; vrLoc = 10980; @@ -3571,7 +3604,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 465"; rLen = 0; - rLoc = 11781; + rLoc = 11804; rType = 0; vrLen = 1790; vrLoc = 10449; @@ -3601,7 +3634,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 413"; rLen = 0; - rLoc = 9855; + rLoc = 9878; rType = 0; vrLen = 2035; vrLoc = 9253; @@ -3631,7 +3664,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 413"; rLen = 0; - rLoc = 9869; + rLoc = 9892; rType = 0; vrLen = 1684; vrLoc = 8542; @@ -3661,7 +3694,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 413"; rLen = 0; - rLoc = 9855; + rLoc = 9878; rType = 0; vrLen = 1686; vrLoc = 8542; @@ -3691,7 +3724,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 405"; rLen = 0; - rLoc = 9560; + rLoc = 9583; rType = 0; vrLen = 1679; vrLoc = 8542; @@ -3721,7 +3754,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 466"; rLen = 0; - rLoc = 11781; + rLoc = 11804; rType = 0; vrLen = 1484; vrLoc = 11005; @@ -3751,7 +3784,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 460"; rLen = 0; - rLoc = 11656; + rLoc = 11679; rType = 0; vrLen = 1482; vrLoc = 11005; @@ -3781,7 +3814,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 450"; rLen = 0; - rLoc = 11553; + rLoc = 11576; rType = 0; vrLen = 2204; vrLoc = 9843; @@ -3811,7 +3844,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 434"; rLen = 0; - rLoc = 10670; + rLoc = 10693; rType = 0; vrLen = 2336; vrLoc = 9843; @@ -3841,7 +3874,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 449"; rLen = 0; - rLoc = 11327; + rLoc = 11350; rType = 0; vrLen = 2029; vrLoc = 10544; @@ -3871,7 +3904,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 448"; rLen = 0; - rLoc = 11264; + rLoc = 11287; rType = 0; vrLen = 2030; vrLoc = 10544; @@ -3901,7 +3934,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 448"; rLen = 0; - rLoc = 11264; + rLoc = 11287; rType = 0; vrLen = 2030; vrLoc = 10544; @@ -3931,7 +3964,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 448"; rLen = 0; - rLoc = 11264; + rLoc = 11287; rType = 0; vrLen = 2057; vrLoc = 10544; @@ -3961,7 +3994,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 448"; rLen = 0; - rLoc = 11324; + rLoc = 11347; rType = 0; vrLen = 2279; vrLoc = 10066; @@ -3991,7 +4024,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 448"; rLen = 0; - rLoc = 11270; + rLoc = 11293; rType = 0; vrLen = 2281; vrLoc = 10066; @@ -4021,7 +4054,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 439"; rLen = 0; - rLoc = 10856; + rLoc = 10879; rType = 0; vrLen = 2309; vrLoc = 9722; @@ -4051,7 +4084,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 439"; rLen = 0; - rLoc = 10856; + rLoc = 10879; rType = 0; vrLen = 2350; vrLoc = 9722; @@ -4101,7 +4134,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 439"; rLen = 0; - rLoc = 10856; + rLoc = 10879; rType = 0; vrLen = 2392; vrLoc = 9731; @@ -4131,7 +4164,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 439"; rLen = 0; - rLoc = 10856; + rLoc = 10879; rType = 0; vrLen = 2392; vrLoc = 9731; @@ -4161,7 +4194,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 439"; rLen = 0; - rLoc = 10856; + rLoc = 10879; rType = 0; vrLen = 2392; vrLoc = 9731; @@ -4191,7 +4224,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 439"; rLen = 0; - rLoc = 10856; + rLoc = 10879; rType = 0; vrLen = 2392; vrLoc = 9731; @@ -4221,7 +4254,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 439"; rLen = 0; - rLoc = 10856; + rLoc = 10879; rType = 0; vrLen = 2392; vrLoc = 9731; @@ -4261,7 +4294,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 384"; rLen = 0; - rLoc = 9172; + rLoc = 9195; rType = 0; vrLen = 1711; vrLoc = 10069; @@ -4285,7 +4318,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 440"; rLen = 0; - rLoc = 10859; + rLoc = 10882; rType = 0; vrLen = 1541; vrLoc = 5499; Modified: codegen/src/supervisor_static_include.h =================================================================== --- codegen/src/supervisor_static_include.h 2009-06-20 19:43:13 UTC (rev 87) +++ codegen/src/supervisor_static_include.h 2009-06-20 19:43:23 UTC (rev 88) @@ -314,6 +314,7 @@ int drid = atoi(rid); printf("Plant %d reserving %d-%d on id %d\n",plant,res->u[i].label,res->u[i].t,res->id); } + printf("Here!\n"); track_reservation(r, plant, res); break; } This was sent by the SourceForge.net collaborative development platform, the world's largest Open Source development site. |
From: <com...@us...> - 2009-06-20 19:43:15
|
Revision: 87 http://pntool.svn.sourceforge.net/pntool/?rev=87&view=rev Author: compaqdrew Date: 2009-06-20 19:43:13 +0000 (Sat, 20 Jun 2009) Log Message: ----------- Fixing some supervisor bugs Modified Paths: -------------- codegen/src/codegen.xcodeproj/drew.mode1v3 codegen/src/codegen.xcodeproj/drew.pbxuser codegen/src/supervisorCompler.c codegen/src/supervisor_static_include.h Modified: codegen/src/codegen.xcodeproj/drew.mode1v3 =================================================================== --- codegen/src/codegen.xcodeproj/drew.mode1v3 2009-06-20 17:56:44 UTC (rev 86) +++ codegen/src/codegen.xcodeproj/drew.mode1v3 2009-06-20 19:43:13 UTC (rev 87) @@ -216,10 +216,10 @@ <key>_historyCapacity</key> <integer>0</integer> <key>bookmark</key> - <string>3AA340FA0FE9EC1D004E156E</string> + <string>3A09E32B0FED7130003FAB0D</string> <key>history</key> <array> - <string>3A752B8F0FE6A2DC00091C76</string> + <string>3AA340FA0FE9EC1D004E156E</string> </array> </dict> <key>SplitCount</key> @@ -235,7 +235,7 @@ <key>PBXModuleWindowStatusBarHidden2</key> <false/> <key>RubberWindowFrame</key> - <string>336 173 1027 855 0 0 1680 1028 </string> + <string>130 147 1027 855 0 0 1280 1002 </string> </dict> </dict> <dict> @@ -256,10 +256,10 @@ <key>_historyCapacity</key> <integer>0</integer> <key>bookmark</key> - <string>3AA340FB0FE9EC1D004E156E</string> + <string>3A09E32C0FED7130003FAB0D</string> <key>history</key> <array> - <string>3A752B900FE6A2DC00091C76</string> + <string>3AA340FB0FE9EC1D004E156E</string> </array> </dict> <key>SplitCount</key> @@ -275,7 +275,7 @@ <key>PBXModuleWindowStatusBarHidden2</key> <false/> <key>RubberWindowFrame</key> - <string>278 231 981 583 0 0 1680 1028 </string> + <string>119 219 981 583 0 0 1280 1002 </string> </dict> </dict> </array> @@ -314,8 +314,6 @@ <key>Layout</key> <array> <dict> - <key>BecomeActive</key> - <true/> <key>ContentConfiguration</key> <dict> <key>PBXBottomSmartGroupGIDs</key> @@ -362,7 +360,8 @@ <key>PBXSmartGroupTreeModuleOutlineStateSelectionKey</key> <array> <array> - <integer>4</integer> + <integer>13</integer> + <integer>11</integer> <integer>3</integer> <integer>0</integer> </array> @@ -387,7 +386,7 @@ <real>186</real> </array> <key>RubberWindowFrame</key> - <string>400 172 1280 856 0 0 1680 1028 </string> + <string>0 146 1280 856 0 0 1280 1002 </string> </dict> <key>Module</key> <string>PBXSmartGroupTreeModule</string> @@ -398,12 +397,14 @@ <key>Dock</key> <array> <dict> + <key>BecomeActive</key> + <true/> <key>ContentConfiguration</key> <dict> <key>PBXProjectModuleGUID</key> <string>1CE0B20306471E060097A5F4</string> <key>PBXProjectModuleLabel</key> - <string>text.h</string> + <string>supervisor_static_include.h</string> <key>PBXSplitModuleInNavigatorKey</key> <dict> <key>Split0</key> @@ -411,11 +412,11 @@ <key>PBXProjectModuleGUID</key> <string>1CE0B20406471E060097A5F4</string> <key>PBXProjectModuleLabel</key> - <string>text.h</string> + <string>supervisor_static_include.h</string> <key>_historyCapacity</key> <integer>0</integer> <key>bookmark</key> - <string>3AA340F70FE9EC1D004E156E</string> + <string>3A09E32A0FED7130003FAB0D</string> <key>history</key> <array> <string>3A7FCEED0FBC046D00EF8097</string> @@ -433,10 +434,12 @@ <string>3A62EF040FD5FF7900E60F50</string> <string>3A62EF380FD6012C00E60F50</string> <string>3AF3E42A0FDA4B8400D2224F</string> - <string>3ACFDD190FDA866300C504DE</string> - <string>3A752B860FE6A2DC00091C76</string> - <string>3A752B870FE6A2DC00091C76</string> - <string>3A752B8C0FE6A2DC00091C76</string> + <string>3A09E2D00FED6DF6003FAB0D</string> + <string>3A09E2E10FED6EEA003FAB0D</string> + <string>3A09E2E20FED6EEA003FAB0D</string> + <string>3A09E2E30FED6EEA003FAB0D</string> + <string>3A09E2F40FED6F4E003FAB0D</string> + <string>3A09E2F50FED6F4E003FAB0D</string> </array> <key>prevStack</key> <array> @@ -459,6 +462,16 @@ <string>3A65A75C0FC0D5C2004E4F00</string> <string>3A65A7690FC0D8CA004E4F00</string> <string>3A65A77A0FC0FC3F004E4F00</string> + <string>3A09E2D20FED6DF6003FAB0D</string> + <string>3A09E2D30FED6DF6003FAB0D</string> + <string>3A09E2D40FED6DF6003FAB0D</string> + <string>3A09E2E60FED6EEA003FAB0D</string> + <string>3A09E2E70FED6EEA003FAB0D</string> + <string>3A09E2E80FED6EEA003FAB0D</string> + <string>3A09E2E90FED6EEA003FAB0D</string> + <string>3A09E2EB0FED6EEA003FAB0D</string> + <string>3A09E2EC0FED6EEA003FAB0D</string> + <string>3A09E2F60FED6F4E003FAB0D</string> </array> </dict> <key>SplitCount</key> @@ -472,7 +485,7 @@ <key>Frame</key> <string>{{0, 0}, {1072, 658}}</string> <key>RubberWindowFrame</key> - <string>400 172 1280 856 0 0 1680 1028 </string> + <string>0 146 1280 856 0 0 1280 1002 </string> </dict> <key>Module</key> <string>PBXNavigatorGroup</string> @@ -492,7 +505,7 @@ <key>Frame</key> <string>{{0, 663}, {1072, 152}}</string> <key>RubberWindowFrame</key> - <string>400 172 1280 856 0 0 1680 1028 </string> + <string>0 146 1280 856 0 0 1280 1002 </string> </dict> <key>Module</key> <string>XCDetailModule</string> @@ -516,9 +529,9 @@ </array> <key>TableOfContents</key> <array> - <string>3AA340F80FE9EC1D004E156E</string> + <string>3A09E2D60FED6DF6003FAB0D</string> <string>1CE0B1FE06471DED0097A5F4</string> - <string>3AA340F90FE9EC1D004E156E</string> + <string>3A09E2D70FED6DF6003FAB0D</string> <string>1CE0B20306471E060097A5F4</string> <string>1CE0B20506471E060097A5F4</string> </array> @@ -652,6 +665,10 @@ <integer>5</integer> <key>WindowOrderList</key> <array> + <string>3A09E2FE0FED6F4E003FAB0D</string> + <string>3A09E2FF0FED6F4E003FAB0D</string> + <string>1C78EAAD065D492600B07095</string> + <string>1C530D57069F1CE1000CFCEE</string> <string>3A232CB10FB21F7F00A5C7C2</string> <string>1CD10A99069EF8BA00B06720</string> <string>3A13FC520FDA612F0051F833</string> @@ -659,7 +676,7 @@ <string>/Volumes/Code/pntool/codegen/src/codegen.xcodeproj</string> </array> <key>WindowString</key> - <string>400 172 1280 856 0 0 1680 1028 </string> + <string>0 146 1280 856 0 0 1280 1002 </string> <key>WindowToolsV3</key> <array> <dict> @@ -689,7 +706,7 @@ <key>Frame</key> <string>{{0, 0}, {1280, 602}}</string> <key>RubberWindowFrame</key> - <string>560 -58 1280 855 0 0 1680 1028 </string> + <string>160 -58 1280 855 0 0 1280 1002 </string> </dict> <key>Module</key> <string>PBXNavigatorGroup</string> @@ -713,7 +730,7 @@ <key>Frame</key> <string>{{0, 607}, {1280, 207}}</string> <key>RubberWindowFrame</key> - <string>560 -58 1280 855 0 0 1680 1028 </string> + <string>160 -58 1280 855 0 0 1280 1002 </string> </dict> <key>Module</key> <string>PBXBuildResultsModule</string> @@ -736,14 +753,14 @@ <key>TableOfContents</key> <array> <string>3A232CB10FB21F7F00A5C7C2</string> - <string>3AA340FC0FE9EC1D004E156E</string> + <string>3A09E2DA0FED6DF6003FAB0D</string> <string>1CD0528F0623707200166675</string> <string>XCMainBuildResultsModuleGUID</string> </array> <key>ToolbarConfiguration</key> <string>xcode.toolbar.config.buildV3</string> <key>WindowString</key> - <string>560 -58 1280 855 0 0 1680 1028 </string> + <string>160 -58 1280 855 0 0 1280 1002 </string> <key>WindowToolGUID</key> <string>3A232CB10FB21F7F00A5C7C2</string> <key>WindowToolIsVisible</key> @@ -830,10 +847,10 @@ <key>Frame</key> <string>{{456, 0}, {544, 297}}</string> <key>RubberWindowFrame</key> - <string>420 408 1000 597 0 0 1680 1028 </string> + <string>173 384 1000 597 0 0 1280 1002 </string> </dict> <key>RubberWindowFrame</key> - <string>420 408 1000 597 0 0 1680 1028 </string> + <string>173 384 1000 597 0 0 1280 1002 </string> </dict> <key>Module</key> <string>PBXDebugSessionModule</string> @@ -856,18 +873,18 @@ <key>TableOfContents</key> <array> <string>1CD10A99069EF8BA00B06720</string> - <string>3AA340FD0FE9EC1D004E156E</string> + <string>3A09E2DB0FED6DF6003FAB0D</string> <string>1C162984064C10D400B95A72</string> - <string>3AA340FE0FE9EC1D004E156E</string> - <string>3AA340FF0FE9EC1D004E156E</string> - <string>3AA341000FE9EC1D004E156E</string> - <string>3AA341010FE9EC1D004E156E</string> - <string>3AA341020FE9EC1D004E156E</string> + <string>3A09E2DC0FED6DF6003FAB0D</string> + <string>3A09E2DD0FED6DF6003FAB0D</string> + <string>3A09E2DE0FED6DF6003FAB0D</string> + <string>3A09E2DF0FED6DF6003FAB0D</string> + <string>3A09E2E00FED6DF6003FAB0D</string> </array> <key>ToolbarConfiguration</key> <string>xcode.toolbar.config.debugV3</string> <key>WindowString</key> - <string>420 408 1000 597 0 0 1680 1028 </string> + <string>173 384 1000 597 0 0 1280 1002 </string> <key>WindowToolGUID</key> <string>1CD10A99069EF8BA00B06720</string> <key>WindowToolIsVisible</key> @@ -896,25 +913,25 @@ <key>PBXProjectModuleGUID</key> <string>1CDD528C0622207200134675</string> <key>PBXProjectModuleLabel</key> - <string>petriNetSerializer.h</string> + <string>supervisor_static_include.h</string> <key>StatusBarVisibility</key> <true/> </dict> <key>GeometryConfiguration</key> <dict> <key>Frame</key> - <string>{{0, 0}, {781, 212}}</string> + <string>{{0, 0}, {1086, 450}}</string> <key>RubberWindowFrame</key> - <string>82 462 781 470 0 0 1280 1002 </string> + <string>82 224 1086 708 0 0 1280 1002 </string> </dict> <key>Module</key> <string>PBXNavigatorGroup</string> <key>Proportion</key> - <string>781pt</string> + <string>1086pt</string> </dict> </array> <key>Proportion</key> - <string>212pt</string> + <string>450pt</string> </dict> <dict> <key>ContentConfiguration</key> @@ -927,9 +944,9 @@ <key>GeometryConfiguration</key> <dict> <key>Frame</key> - <string>{{0, 217}, {781, 212}}</string> + <string>{{0, 455}, {1086, 212}}</string> <key>RubberWindowFrame</key> - <string>82 462 781 470 0 0 1280 1002 </string> + <string>82 224 1086 708 0 0 1280 1002 </string> </dict> <key>Module</key> <string>PBXProjectFindModule</string> @@ -938,7 +955,7 @@ </dict> </array> <key>Proportion</key> - <string>429pt</string> + <string>667pt</string> </dict> </array> <key>Name</key> @@ -952,13 +969,13 @@ <key>TableOfContents</key> <array> <string>1C530D57069F1CE1000CFCEE</string> - <string>3A5D84E00FCCAA6700465DF2</string> - <string>3A5D84E10FCCAA6700465DF2</string> + <string>3A09E2FA0FED6F4E003FAB0D</string> + <string>3A09E2FB0FED6F4E003FAB0D</string> <string>1CDD528C0622207200134675</string> <string>1CD0528E0623707200166675</string> </array> <key>WindowString</key> - <string>82 462 781 470 0 0 1280 1002 </string> + <string>82 224 1086 708 0 0 1280 1002 </string> <key>WindowToolGUID</key> <string>1C530D57069F1CE1000CFCEE</string> <key>WindowToolIsVisible</key> @@ -1016,7 +1033,7 @@ <key>TableOfContents</key> <array> <string>1C78EAAD065D492600B07095</string> - <string>3A752B980FE6A2DC00091C76</string> + <string>3A09E2FC0FED6F4E003FAB0D</string> <string>1C78EAAC065D492600B07095</string> </array> <key>ToolbarConfiguration</key> Modified: codegen/src/codegen.xcodeproj/drew.pbxuser =================================================================== --- codegen/src/codegen.xcodeproj/drew.pbxuser 2009-06-20 17:56:44 UTC (rev 86) +++ codegen/src/codegen.xcodeproj/drew.pbxuser 2009-06-20 19:43:13 UTC (rev 87) @@ -8,18 +8,18 @@ 8DD76FA90486AB0100D96B5E /* codegen */, ); breakpoints = ( - 3AEAF9600FB2738200D61E73 /* supervisorCompler.c:190 */, + 3AEAF9600FB2738200D61E73 /* supervisorCompler.c:191 */, 3AEE0D760FB3AB0000248D5F /* petriNetSerializer.c:103 */, 3AEE0D7D0FB3ABC300248D5F /* main.c:34 */, 3A99A5BD0FB8D43200B1F47C /* main.c:35 */, - 3A7DF4AD0FC7ECD900A18013 /* supervisorCompler.c:103 */, - 3A3A77380FC888EB00DB2D28 /* supervisorCompler.c:113 */, + 3A7DF4AD0FC7ECD900A18013 /* supervisorCompler.c:104 */, + 3A3A77380FC888EB00DB2D28 /* supervisorCompler.c:114 */, 3A3A77E70FC891BD00DB2D28 /* petriNetSerializer.c:33 */, - 3A3A783D0FC894C600DB2D28 /* supervisorCompler.c:115 */, - 3A13FC180FDA5F3C0051F833 /* supervisorCompler.c:175 */, + 3A3A783D0FC894C600DB2D28 /* supervisorCompler.c:116 */, + 3A13FC180FDA5F3C0051F833 /* supervisorCompler.c:176 */, 3A13FC1E0FDA5F810051F833 /* supervisor_static_include.h:279 */, 3A13FC220FDA5F970051F833 /* supervisor_static_include.h:272 */, - 3A13FC250FDA5FBA0051F833 /* supervisorCompler.c:173 */, + 3A13FC250FDA5FBA0051F833 /* supervisorCompler.c:174 */, 3A13FC660FDA62D90051F833 /* supervisor_static_include.h:295 */, 3A13FC680FDA62DA0051F833 /* supervisor_static_include.h:270 */, 3A13FC750FDA64190051F833 /* supervisor_static_include.h:308 */, @@ -76,10 +76,72 @@ PBXFileDataSource_Warnings_ColumnID, ); }; - PBXPerProjectTemplateStateSaveDate = 266988558; - PBXWorkspaceStateSaveDate = 266988558; + PBXPerProjectTemplateStateSaveDate = 267218397; + PBXWorkspaceStateSaveDate = 267218397; }; perUserProjectItems = { + 3A09E2D00FED6DF6003FAB0D /* PBXTextBookmark */ = 3A09E2D00FED6DF6003FAB0D /* PBXTextBookmark */; + 3A09E2D10FED6DF6003FAB0D /* PBXTextBookmark */ = 3A09E2D10FED6DF6003FAB0D /* PBXTextBookmark */; + 3A09E2D20FED6DF6003FAB0D /* PBXTextBookmark */ = 3A09E2D20FED6DF6003FAB0D /* PBXTextBookmark */; + 3A09E2D30FED6DF6003FAB0D /* PBXTextBookmark */ = 3A09E2D30FED6DF6003FAB0D /* PBXTextBookmark */; + 3A09E2D40FED6DF6003FAB0D /* PBXTextBookmark */ = 3A09E2D40FED6DF6003FAB0D /* PBXTextBookmark */; + 3A09E2D50FED6DF6003FAB0D /* PBXTextBookmark */ = 3A09E2D50FED6DF6003FAB0D /* PBXTextBookmark */; + 3A09E2D80FED6DF6003FAB0D /* PBXTextBookmark */ = 3A09E2D80FED6DF6003FAB0D /* PBXTextBookmark */; + 3A09E2D90FED6DF6003FAB0D /* PBXTextBookmark */ = 3A09E2D90FED6DF6003FAB0D /* PBXTextBookmark */; + 3A09E2E10FED6EEA003FAB0D /* PBXTextBookmark */ = 3A09E2E10FED6EEA003FAB0D /* PBXTextBookmark */; + 3A09E2E20FED6EEA003FAB0D /* PBXTextBookmark */ = 3A09E2E20FED6EEA003FAB0D /* PBXTextBookmark */; + 3A09E2E30FED6EEA003FAB0D /* PBXTextBookmark */ = 3A09E2E30FED6EEA003FAB0D /* PBXTextBookmark */; + 3A09E2E50FED6EEA003FAB0D /* PBXTextBookmark */ = 3A09E2E50FED6EEA003FAB0D /* PBXTextBookmark */; + 3A09E2E60FED6EEA003FAB0D /* PBXTextBookmark */ = 3A09E2E60FED6EEA003FAB0D /* PBXTextBookmark */; + 3A09E2E70FED6EEA003FAB0D /* PBXTextBookmark */ = 3A09E2E70FED6EEA003FAB0D /* PBXTextBookmark */; + 3A09E2E80FED6EEA003FAB0D /* PBXTextBookmark */ = 3A09E2E80FED6EEA003FAB0D /* PBXTextBookmark */; + 3A09E2E90FED6EEA003FAB0D /* PBXTextBookmark */ = 3A09E2E90FED6EEA003FAB0D /* PBXTextBookmark */; + 3A09E2EB0FED6EEA003FAB0D /* PBXTextBookmark */ = 3A09E2EB0FED6EEA003FAB0D /* PBXTextBookmark */; + 3A09E2EC0FED6EEA003FAB0D /* PBXTextBookmark */ = 3A09E2EC0FED6EEA003FAB0D /* PBXTextBookmark */; + 3A09E2EE0FED6EEA003FAB0D /* PBXTextBookmark */ = 3A09E2EE0FED6EEA003FAB0D /* PBXTextBookmark */; + 3A09E2EF0FED6EEA003FAB0D /* PBXTextBookmark */ = 3A09E2EF0FED6EEA003FAB0D /* PBXTextBookmark */; + 3A09E2F00FED6EEA003FAB0D /* PBXTextBookmark */ = 3A09E2F00FED6EEA003FAB0D /* PBXTextBookmark */; + 3A09E2F40FED6F4E003FAB0D /* PBXTextBookmark */ = 3A09E2F40FED6F4E003FAB0D /* PBXTextBookmark */; + 3A09E2F50FED6F4E003FAB0D /* PBXTextBookmark */ = 3A09E2F50FED6F4E003FAB0D /* PBXTextBookmark */; + 3A09E2F60FED6F4E003FAB0D /* PBXTextBookmark */ = 3A09E2F60FED6F4E003FAB0D /* PBXTextBookmark */; + 3A09E2F70FED6F4E003FAB0D /* PBXTextBookmark */ = 3A09E2F70FED6F4E003FAB0D /* PBXTextBookmark */; + 3A09E2F80FED6F4E003FAB0D /* PBXTextBookmark */ = 3A09E2F80FED6F4E003FAB0D /* PBXTextBookmark */; + 3A09E2F90FED6F4E003FAB0D /* PBXTextBookmark */ = 3A09E2F90FED6F4E003FAB0D /* PBXTextBookmark */; + 3A09E3020FED6F9E003FAB0D /* PBXTextBookmark */ = 3A09E3020FED6F9E003FAB0D /* PBXTextBookmark */; + 3A09E3030FED6F9E003FAB0D /* PBXTextBookmark */ = 3A09E3030FED6F9E003FAB0D /* PBXTextBookmark */; + 3A09E3040FED6F9E003FAB0D /* PBXTextBookmark */ = 3A09E3040FED6F9E003FAB0D /* PBXTextBookmark */; + 3A09E3060FED6FBC003FAB0D /* PBXTextBookmark */ = 3A09E3060FED6FBC003FAB0D /* PBXTextBookmark */; + 3A09E3070FED6FBC003FAB0D /* PBXTextBookmark */ = 3A09E3070FED6FBC003FAB0D /* PBXTextBookmark */; + 3A09E3080FED6FBC003FAB0D /* PBXTextBookmark */ = 3A09E3080FED6FBC003FAB0D /* PBXTextBookmark */; + 3A09E30A0FED6FCC003FAB0D /* PBXTextBookmark */ = 3A09E30A0FED6FCC003FAB0D /* PBXTextBookmark */; + 3A09E30B0FED6FCC003FAB0D /* PBXTextBookmark */ = 3A09E30B0FED6FCC003FAB0D /* PBXTextBookmark */; + 3A09E30C0FED6FCC003FAB0D /* PBXTextBookmark */ = 3A09E30C0FED6FCC003FAB0D /* PBXTextBookmark */; + 3A09E30D0FED6FEB003FAB0D /* PBXTextBookmark */ = 3A09E30D0FED6FEB003FAB0D /* PBXTextBookmark */; + 3A09E30E0FED6FEB003FAB0D /* PBXTextBookmark */ = 3A09E30E0FED6FEB003FAB0D /* PBXTextBookmark */; + 3A09E30F0FED6FEB003FAB0D /* PBXTextBookmark */ = 3A09E30F0FED6FEB003FAB0D /* PBXTextBookmark */; + 3A09E3110FED704A003FAB0D /* PBXTextBookmark */ = 3A09E3110FED704A003FAB0D /* PBXTextBookmark */; + 3A09E3120FED704A003FAB0D /* PBXTextBookmark */ = 3A09E3120FED704A003FAB0D /* PBXTextBookmark */; + 3A09E3130FED704A003FAB0D /* PBXTextBookmark */ = 3A09E3130FED704A003FAB0D /* PBXTextBookmark */; + 3A09E3160FED706F003FAB0D /* PBXTextBookmark */ = 3A09E3160FED706F003FAB0D /* PBXTextBookmark */; + 3A09E3170FED706F003FAB0D /* PBXTextBookmark */ = 3A09E3170FED706F003FAB0D /* PBXTextBookmark */; + 3A09E3180FED706F003FAB0D /* PBXTextBookmark */ = 3A09E3180FED706F003FAB0D /* PBXTextBookmark */; + 3A09E31B0FED708C003FAB0D /* PBXTextBookmark */ = 3A09E31B0FED708C003FAB0D /* PBXTextBookmark */; + 3A09E31C0FED708C003FAB0D /* PBXTextBookmark */ = 3A09E31C0FED708C003FAB0D /* PBXTextBookmark */; + 3A09E31E0FED70AD003FAB0D /* PBXTextBookmark */ = 3A09E31E0FED70AD003FAB0D /* PBXTextBookmark */; + 3A09E31F0FED70AD003FAB0D /* PBXTextBookmark */ = 3A09E31F0FED70AD003FAB0D /* PBXTextBookmark */; + 3A09E3200FED70AD003FAB0D /* PBXTextBookmark */ = 3A09E3200FED70AD003FAB0D /* PBXTextBookmark */; + 3A09E3210FED70E5003FAB0D /* PBXTextBookmark */ = 3A09E3210FED70E5003FAB0D /* PBXTextBookmark */; + 3A09E3220FED70E5003FAB0D /* PBXTextBookmark */ = 3A09E3220FED70E5003FAB0D /* PBXTextBookmark */; + 3A09E3230FED70E5003FAB0D /* PBXTextBookmark */ = 3A09E3230FED70E5003FAB0D /* PBXTextBookmark */; + 3A09E3240FED70FD003FAB0D /* PBXTextBookmark */ = 3A09E3240FED70FD003FAB0D /* PBXTextBookmark */; + 3A09E3250FED70FD003FAB0D /* PBXTextBookmark */ = 3A09E3250FED70FD003FAB0D /* PBXTextBookmark */; + 3A09E3260FED70FD003FAB0D /* PBXTextBookmark */ = 3A09E3260FED70FD003FAB0D /* PBXTextBookmark */; + 3A09E3270FED7121003FAB0D /* PBXTextBookmark */ = 3A09E3270FED7121003FAB0D /* PBXTextBookmark */; + 3A09E3280FED7121003FAB0D /* PBXTextBookmark */ = 3A09E3280FED7121003FAB0D /* PBXTextBookmark */; + 3A09E3290FED7121003FAB0D /* PBXTextBookmark */ = 3A09E3290FED7121003FAB0D /* PBXTextBookmark */; + 3A09E32A0FED7130003FAB0D /* PBXTextBookmark */ = 3A09E32A0FED7130003FAB0D /* PBXTextBookmark */; + 3A09E32B0FED7130003FAB0D /* PBXTextBookmark */ = 3A09E32B0FED7130003FAB0D /* PBXTextBookmark */; + 3A09E32C0FED7130003FAB0D /* PBXTextBookmark */ = 3A09E32C0FED7130003FAB0D /* PBXTextBookmark */; 3A232C980FB21F7F00A5C7C2 = 3A232C980FB21F7F00A5C7C2 /* PBXTextBookmark */; 3A232C9A0FB21F7F00A5C7C2 = 3A232C9A0FB21F7F00A5C7C2 /* PBXTextBookmark */; 3A232C9B0FB21F7F00A5C7C2 = 3A232C9B0FB21F7F00A5C7C2 /* PBXTextBookmark */; @@ -127,9 +189,9 @@ 3A99A7400FB8EC6800B1F47C = 3A99A7400FB8EC6800B1F47C /* PBXTextBookmark */; 3A99A7960FB8F21100B1F47C = 3A99A7960FB8F21100B1F47C /* PBXTextBookmark */; 3A99A7980FB8F21100B1F47C = 3A99A7980FB8F21100B1F47C /* PBXTextBookmark */; - 3AA340F70FE9EC1D004E156E /* PBXTextBookmark */ = 3AA340F70FE9EC1D004E156E /* PBXTextBookmark */; - 3AA340FA0FE9EC1D004E156E /* PBXTextBookmark */ = 3AA340FA0FE9EC1D004E156E /* PBXTextBookmark */; - 3AA340FB0FE9EC1D004E156E /* PBXTextBookmark */ = 3AA340FB0FE9EC1D004E156E /* PBXTextBookmark */; + 3AA340F70FE9EC1D004E156E = 3AA340F70FE9EC1D004E156E /* PBXTextBookmark */; + 3AA340FA0FE9EC1D004E156E = 3AA340FA0FE9EC1D004E156E /* PBXTextBookmark */; + 3AA340FB0FE9EC1D004E156E = 3AA340FB0FE9EC1D004E156E /* PBXTextBookmark */; 3AA9B2520FCC9354001346EA = 3AA9B2520FCC9354001346EA /* PBXTextBookmark */; 3AA9B2530FCC9354001346EA = 3AA9B2530FCC9354001346EA /* PBXTextBookmark */; 3ACEFBB10FDA7F2600B47227 = 3ACEFBB10FDA7F2600B47227 /* PBXTextBookmark */; @@ -371,13 +433,645 @@ }; 08FB7796FE84155DC02AAC07 /* main.c */ = { uiCtxt = { - sepNavIntBoundsRect = "{{0, 0}, {1011, 980}}"; - sepNavSelRange = "{1694, 0}"; - sepNavVisRange = "{805, 1121}"; + sepNavIntBoundsRect = "{{0, 0}, {691, 938}}"; + sepNavSelRange = "{0, 0}"; + sepNavVisRange = "{0, 1791}"; sepNavWindowFrame = "{{199, 162}, {1027, 575}}"; }; }; - 3A13FC180FDA5F3C0051F833 /* supervisorCompler.c:175 */ = { + 3A09E2D00FED6DF6003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A5B50FB8C45B00B1F47C /* text.h */; + name = "text.h: 1"; + rLen = 0; + rLoc = 0; + rType = 0; + vrLen = 643; + vrLoc = 0; + }; + 3A09E2D10FED6DF6003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A5B60FB8C45B00B1F47C /* text.c */; + name = "text.c: 1"; + rLen = 0; + rLoc = 0; + rType = 0; + vrLen = 920; + vrLoc = 0; + }; + 3A09E2D20FED6DF6003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A5B50FB8C45B00B1F47C /* text.h */; + name = "text.h: 1"; + rLen = 0; + rLoc = 0; + rType = 0; + vrLen = 643; + vrLoc = 0; + }; + 3A09E2D30FED6DF6003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A5B60FB8C45B00B1F47C /* text.c */; + name = "text.c: 1"; + rLen = 0; + rLoc = 0; + rType = 0; + vrLen = 920; + vrLoc = 0; + }; + 3A09E2D40FED6DF6003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A5B50FB8C45B00B1F47C /* text.h */; + name = "text.h: 1"; + rLen = 0; + rLoc = 0; + rType = 0; + vrLen = 643; + vrLoc = 0; + }; + 3A09E2D50FED6DF6003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A5B60FB8C45B00B1F47C /* text.c */; + name = "text.c: 1"; + rLen = 0; + rLoc = 0; + rType = 0; + vrLen = 920; + vrLoc = 0; + }; + 3A09E2D80FED6DF6003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 439"; + rLen = 0; + rLoc = 10859; + rType = 0; + vrLen = 1260; + vrLoc = 5612; + }; + 3A09E2D90FED6DF6003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 165"; + rLen = 0; + rLoc = 4872; + rType = 0; + vrLen = 1209; + vrLoc = 4359; + }; + 3A09E2E10FED6EEA003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A5B60FB8C45B00B1F47C /* text.c */; + name = "text.c: 17"; + rLen = 4; + rLoc = 263; + rType = 0; + vrLen = 920; + vrLoc = 0; + }; + 3A09E2E20FED6EEA003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A752B7E0FE6A2B300091C76 /* pns.h */; + name = "pns.h: 251"; + rLen = 0; + rLoc = 10108; + rType = 0; + vrLen = 1446; + vrLoc = 0; + }; + 3A09E2E30FED6EEA003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A09E2E40FED6EEA003FAB0D /* supervisor.c */; + name = "supervisor.c: 1"; + rLen = 0; + rLoc = 0; + rType = 0; + vrLen = 846; + vrLoc = 0; + }; + 3A09E2E40FED6EEA003FAB0D /* supervisor.c */ = { + isa = PBXFileReference; + name = supervisor.c; + path = /Volumes/Code/pntool/codegen/src/build/Debug/staging/supervisor.c; + sourceTree = "<absolute>"; + }; + 3A09E2E50FED6EEA003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 165"; + rLen = 19; + rLoc = 4853; + rType = 0; + vrLen = 1381; + vrLoc = 4115; + }; + 3A09E2E60FED6EEA003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A5B60FB8C45B00B1F47C /* text.c */; + name = "text.c: 17"; + rLen = 4; + rLoc = 263; + rType = 0; + vrLen = 920; + vrLoc = 0; + }; + 3A09E2E70FED6EEA003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A752B7E0FE6A2B300091C76 /* pns.h */; + name = "pns.h: 251"; + rLen = 0; + rLoc = 10108; + rType = 0; + vrLen = 1446; + vrLoc = 0; + }; + 3A09E2E80FED6EEA003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 63"; + rLen = 0; + rLoc = 1970; + rType = 0; + vrLen = 1292; + vrLoc = 2389; + }; + 3A09E2E90FED6EEA003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A09E2EA0FED6EEA003FAB0D /* supervisor.c */; + name = "supervisor.c: 1"; + rLen = 0; + rLoc = 0; + rType = 0; + vrLen = 846; + vrLoc = 0; + }; + 3A09E2EA0FED6EEA003FAB0D /* supervisor.c */ = { + isa = PBXFileReference; + name = supervisor.c; + path = /Volumes/Code/pntool/codegen/src/build/Debug/staging/supervisor.c; + sourceTree = "<absolute>"; + }; + 3A09E2EB0FED6EEA003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 165"; + rLen = 19; + rLoc = 4853; + rType = 0; + vrLen = 1381; + vrLoc = 4115; + }; + 3A09E2EC0FED6EEA003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A09E2ED0FED6EEA003FAB0D /* supervisor.c */; + name = "supervisor.c: 1"; + rLen = 0; + rLoc = 0; + rType = 0; + vrLen = 846; + vrLoc = 0; + }; + 3A09E2ED0FED6EEA003FAB0D /* supervisor.c */ = { + isa = PBXFileReference; + name = supervisor.c; + path = /Volumes/Code/pntool/codegen/src/build/Debug/staging/supervisor.c; + sourceTree = "<absolute>"; + }; + 3A09E2EE0FED6EEA003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 62"; + rLen = 0; + rLoc = 1855; + rType = 0; + vrLen = 1286; + vrLoc = 1328; + }; + 3A09E2EF0FED6EEA003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 439"; + rLen = 0; + rLoc = 10859; + rType = 0; + vrLen = 1260; + vrLoc = 5612; + }; + 3A09E2F00FED6EEA003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 166"; + rLen = 0; + rLoc = 4872; + rType = 0; + vrLen = 1209; + vrLoc = 4373; + }; + 3A09E2F40FED6F4E003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 62"; + rLen = 0; + rLoc = 1855; + rType = 0; + vrLen = 1286; + vrLoc = 1328; + }; + 3A09E2F50FED6F4E003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + rLen = 9; + rLoc = 7448; + rType = 0; + }; + 3A09E2F60FED6F4E003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 62"; + rLen = 0; + rLoc = 1855; + rType = 0; + vrLen = 1286; + vrLoc = 1328; + }; + 3A09E2F70FED6F4E003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 314"; + rLen = 9; + rLoc = 7448; + rType = 0; + vrLen = 1473; + vrLoc = 6788; + }; + 3A09E2F80FED6F4E003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 439"; + rLen = 0; + rLoc = 10859; + rType = 0; + vrLen = 1208; + vrLoc = 5612; + }; + 3A09E2F90FED6F4E003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 166"; + rLen = 0; + rLoc = 4872; + rType = 0; + vrLen = 1137; + vrLoc = 4373; + }; + 3A09E3020FED6F9E003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 314"; + rLen = 0; + rLoc = 7426; + rType = 0; + vrLen = 1229; + vrLoc = 6397; + }; + 3A09E3030FED6F9E003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 440"; + rLen = 0; + rLoc = 10859; + rType = 0; + vrLen = 1260; + vrLoc = 5612; + }; + 3A09E3040FED6F9E003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 166"; + rLen = 0; + rLoc = 4872; + rType = 0; + vrLen = 1209; + vrLoc = 4373; + }; + 3A09E3060FED6FBC003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 315"; + rLen = 0; + rLoc = 7517; + rType = 0; + vrLen = 1214; + vrLoc = 6397; + }; + 3A09E3070FED6FBC003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 440"; + rLen = 0; + rLoc = 10859; + rType = 0; + vrLen = 1208; + vrLoc = 5612; + }; + 3A09E3080FED6FBC003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 166"; + rLen = 0; + rLoc = 4872; + rType = 0; + vrLen = 1137; + vrLoc = 4373; + }; + 3A09E30A0FED6FCC003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 290"; + rLen = 7; + rLoc = 6757; + rType = 0; + vrLen = 1248; + vrLoc = 6397; + }; + 3A09E30B0FED6FCC003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 440"; + rLen = 0; + rLoc = 10859; + rType = 0; + vrLen = 1260; + vrLoc = 5612; + }; + 3A09E30C0FED6FCC003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 166"; + rLen = 0; + rLoc = 4872; + rType = 0; + vrLen = 1209; + vrLoc = 4373; + }; + 3A09E30D0FED6FEB003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 315"; + rLen = 0; + rLoc = 7474; + rType = 0; + vrLen = 1445; + vrLoc = 6894; + }; + 3A09E30E0FED6FEB003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 440"; + rLen = 0; + rLoc = 10859; + rType = 0; + vrLen = 1282; + vrLoc = 5612; + }; + 3A09E30F0FED6FEB003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 166"; + rLen = 0; + rLoc = 4872; + rType = 0; + vrLen = 1209; + vrLoc = 4373; + }; + 3A09E3110FED704A003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 315"; + rLen = 0; + rLoc = 7426; + rType = 0; + vrLen = 1338; + vrLoc = 6591; + }; + 3A09E3120FED704A003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 441"; + rLen = 0; + rLoc = 10859; + rType = 0; + vrLen = 1282; + vrLoc = 5612; + }; + 3A09E3130FED704A003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 166"; + rLen = 0; + rLoc = 4872; + rType = 0; + vrLen = 1209; + vrLoc = 4373; + }; + 3A09E3160FED706F003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 315"; + rLen = 0; + rLoc = 7426; + rType = 0; + vrLen = 1338; + vrLoc = 6591; + }; + 3A09E3170FED706F003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 441"; + rLen = 0; + rLoc = 10859; + rType = 0; + vrLen = 1282; + vrLoc = 5612; + }; + 3A09E3180FED706F003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 166"; + rLen = 0; + rLoc = 4872; + rType = 0; + vrLen = 1209; + vrLoc = 4373; + }; + 3A09E31B0FED708C003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + rLen = 8; + rLoc = 12611; + rType = 0; + }; + 3A09E31C0FED708C003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 499"; + rLen = 0; + rLoc = 12603; + rType = 0; + vrLen = 579; + vrLoc = 12331; + }; + 3A09E31E0FED70AD003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 316"; + rLen = 0; + rLoc = 7426; + rType = 0; + vrLen = 1258; + vrLoc = 6569; + }; + 3A09E31F0FED70AD003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 441"; + rLen = 0; + rLoc = 10859; + rType = 0; + vrLen = 1282; + vrLoc = 5612; + }; + 3A09E3200FED70AD003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 166"; + rLen = 0; + rLoc = 4872; + rType = 0; + vrLen = 1209; + vrLoc = 4373; + }; + 3A09E3210FED70E5003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 315"; + rLen = 0; + rLoc = 7517; + rType = 0; + vrLen = 1266; + vrLoc = 6569; + }; + 3A09E3220FED70E5003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 440"; + rLen = 0; + rLoc = 10859; + rType = 0; + vrLen = 1282; + vrLoc = 5612; + }; + 3A09E3230FED70E5003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 166"; + rLen = 0; + rLoc = 4872; + rType = 0; + vrLen = 1209; + vrLoc = 4373; + }; + 3A09E3240FED70FD003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 301"; + rLen = 0; + rLoc = 7062; + rType = 0; + vrLen = 1274; + vrLoc = 6569; + }; + 3A09E3250FED70FD003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 441"; + rLen = 0; + rLoc = 10859; + rType = 0; + vrLen = 1282; + vrLoc = 5612; + }; + 3A09E3260FED70FD003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 166"; + rLen = 0; + rLoc = 4872; + rType = 0; + vrLen = 1209; + vrLoc = 4373; + }; + 3A09E3270FED7121003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 316"; + rLen = 0; + rLoc = 7510; + rType = 0; + vrLen = 1268; + vrLoc = 6569; + }; + 3A09E3280FED7121003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 441"; + rLen = 0; + rLoc = 10859; + rType = 0; + vrLen = 1282; + vrLoc = 5612; + }; + 3A09E3290FED7121003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 166"; + rLen = 0; + rLoc = 4872; + rType = 0; + vrLen = 1209; + vrLoc = 4373; + }; + 3A09E32A0FED7130003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 313"; + rLen = 0; + rLoc = 7398; + rType = 0; + vrLen = 1261; + vrLoc = 6569; + }; + 3A09E32B0FED7130003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; + name = "supervisor_static_include.h: 440"; + rLen = 0; + rLoc = 10859; + rType = 0; + vrLen = 1282; + vrLoc = 5612; + }; + 3A09E32C0FED7130003FAB0D /* PBXTextBookmark */ = { + isa = PBXTextBookmark; + fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; + name = "supervisorCompler.c: 166"; + rLen = 0; + rLoc = 4872; + rType = 0; + vrLen = 1209; + vrLoc = 4373; + }; + 3A13FC180FDA5F3C0051F833 /* supervisorCompler.c:176 */ = { isa = PBXFileBreakpoint; actions = ( ); @@ -389,9 +1083,9 @@ functionName = "compileSupervisor()"; hitCount = 0; ignoreCount = 0; - lineNumber = 175; + lineNumber = 176; location = codegen; - modificationTime = 266773209.456915; + modificationTime = 267219111.612896; state = 2; }; 3A13FC1E0FDA5F810051F833 /* supervisor_static_include.h:279 */ = { @@ -408,7 +1102,7 @@ ignoreCount = 0; lineNumber = 279; location = codegen; - modificationTime = 266773209.456998; + modificationTime = 267219111.612992; state = 2; }; 3A13FC220FDA5F970051F833 /* supervisor_static_include.h:272 */ = { @@ -424,10 +1118,10 @@ ignoreCount = 0; lineNumber = 272; location = codegen; - modificationTime = 266773209.457105; + modificationTime = 267219111.613271; state = 2; }; - 3A13FC250FDA5FBA0051F833 /* supervisorCompler.c:173 */ = { + 3A13FC250FDA5FBA0051F833 /* supervisorCompler.c:174 */ = { isa = PBXFileBreakpoint; actions = ( ); @@ -438,9 +1132,9 @@ fileReference = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; hitCount = 0; ignoreCount = 0; - lineNumber = 173; + lineNumber = 174; location = codegen; - modificationTime = 266773209.457199; + modificationTime = 267219111.613516; state = 2; }; 3A13FC660FDA62D90051F833 /* supervisor_static_include.h:295 */ = { @@ -457,7 +1151,7 @@ ignoreCount = 0; lineNumber = 295; location = codegen; - modificationTime = 266773209.457274; + modificationTime = 267219111.613607; state = 2; }; 3A13FC680FDA62DA0051F833 /* supervisor_static_include.h:270 */ = { @@ -473,7 +1167,7 @@ ignoreCount = 0; lineNumber = 270; location = codegen; - modificationTime = 266773209.457368; + modificationTime = 267219111.613867; state = 2; }; 3A13FC750FDA64190051F833 /* supervisor_static_include.h:308 */ = { @@ -490,7 +1184,7 @@ ignoreCount = 0; lineNumber = 308; location = codegen; - modificationTime = 266773209.45746; + modificationTime = 267219111.614107; state = 2; }; 3A13FC780FDA64220051F833 /* supervisor_static_include.h:301 */ = { @@ -507,7 +1201,7 @@ ignoreCount = 0; lineNumber = 301; location = codegen; - modificationTime = 266773209.457556; + modificationTime = 267219111.614566; state = 2; }; 3A13FC800FDA64DC0051F833 /* supervisor_static_include.h:310 */ = { @@ -524,7 +1218,7 @@ ignoreCount = 0; lineNumber = 310; location = codegen; - modificationTime = 266773209.457642; + modificationTime = 267219111.614813; state = 2; }; 3A13FC830FDA66170051F833 /* supervisor_static_include.h:303 */ = { @@ -540,7 +1234,7 @@ hitCount = 0; ignoreCount = 0; lineNumber = 303; - modificationTime = 266773210.190378; + modificationTime = 267219111.768971; state = 0; }; 3A232C5F0FB214C800A5C7C2 /* codegen */ = { @@ -742,7 +1436,7 @@ sepNavWindowFrame = "{{150, 176}, {981, 639}}"; }; }; - 3A3A77380FC888EB00DB2D28 /* supervisorCompler.c:113 */ = { + 3A3A77380FC888EB00DB2D28 /* supervisorCompler.c:114 */ = { isa = PBXFileBreakpoint; actions = ( ); @@ -754,9 +1448,9 @@ functionName = "doCalculateWatchLabels()"; hitCount = 0; ignoreCount = 0; - lineNumber = 113; + lineNumber = 114; location = codegen; - modificationTime = 266773209.456778; + modificationTime = 267219111.612714; state = 2; }; 3A3A773C0FC8893000DB2D28 /* PBXTextBookmark */ = { @@ -783,10 +1477,10 @@ ignoreCount = 0; lineNumber = 33; location = codegen; - modificationTime = 266773209.4568419; + modificationTime = 267219111.612794; state = 2; }; - 3A3A783D0FC894C600DB2D28 /* supervisorCompler.c:115 */ = { + 3A3A783D0FC894C600DB2D28 /* supervisorCompler.c:116 */ = { isa = PBXFileBreakpoint; actions = ( ); @@ -798,8 +1492,8 @@ functionName = "doCalculateWatchLabels()"; hitCount = 0; ignoreCount = 0; - lineNumber = 115; - modificationTime = 266773209.456853; + lineNumber = 116; + modificationTime = 267219111.61281; state = 2; }; 3A5D84730FCCA60900465DF2 /* PBXTextBookmark */ = { @@ -980,12 +1674,19 @@ vrLen = 1379; vrLoc = 6066; }; + 3A752B7E0FE6A2B300091C76 /* pns.h */ = { + uiCtxt = { + sepNavIntBoundsRect = "{{0, 0}, {691, 4704}}"; + sepNavSelRange = "{13060, 10}"; + sepNavVisRange = "{9887, 2057}"; + }; + }; 3A752B860FE6A2DC00091C76 /* PBXTextBookmark */ = { isa = PBXTextBookmark; fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 384"; rLen = 0; - rLoc = 9113; + rLoc = 9172; rType = 0; vrLen = 1708; vrLoc = 10066; @@ -1015,7 +1716,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 384"; rLen = 0; - rLoc = 9113; + rLoc = 9172; rType = 0; vrLen = 1708; vrLoc = 10066; @@ -1055,7 +1756,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 439"; rLen = 0; - rLoc = 10800; + rLoc = 10859; rType = 0; vrLen = 1332; vrLoc = 5679; @@ -1065,7 +1766,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1127; vrLoc = 4441; @@ -1090,7 +1791,7 @@ vrLen = 626; vrLoc = 0; }; - 3A7DF4AD0FC7ECD900A18013 /* supervisorCompler.c:103 */ = { + 3A7DF4AD0FC7ECD900A18013 /* supervisorCompler.c:104 */ = { isa = PBXFileBreakpoint; actions = ( ); @@ -1102,9 +1803,9 @@ functionName = "doCalculateWatchLabels()"; hitCount = 0; ignoreCount = 0; - lineNumber = 103; + lineNumber = 104; location = codegen; - modificationTime = 266773209.456715; + modificationTime = 267219111.612634; state = 2; }; 3A7FCEED0FBC046D00EF8097 /* PBXTextBookmark */ = { @@ -1219,7 +1920,7 @@ 3A99A5B60FB8C45B00B1F47C /* text.c */ = { uiCtxt = { sepNavIntBoundsRect = "{{0, 0}, {1011, 700}}"; - sepNavSelRange = "{0, 0}"; + sepNavSelRange = "{263, 4}"; sepNavVisRange = "{0, 920}"; sepNavWindowFrame = "{{15, 384}, {981, 639}}"; }; @@ -1238,7 +1939,7 @@ ignoreCount = 0; lineNumber = 35; location = codegen; - modificationTime = 266773209.4567069; + modificationTime = 267219111.612561; state = 2; }; 3A99A5FA0FB8D5DF00B1F47C /* PBXTextBookmark */ = { @@ -1260,9 +1961,9 @@ }; 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */ = { uiCtxt = { - sepNavIntBoundsRect = "{{0, 0}, {968, 8498}}"; - sepNavSelRange = "{10800, 0}"; - sepNavVisRange = "{5610, 1262}"; + sepNavIntBoundsRect = "{{0, 0}, {968, 8540}}"; + sepNavSelRange = "{10859, 0}"; + sepNavVisRange = "{5612, 1282}"; sepNavWindowFrame = "{{422, -52}, {1027, 1024}}"; }; }; @@ -1271,7 +1972,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 15"; rLen = 0; - rLoc = 13228; + rLoc = 13289; rType = 0; vrLen = 292; vrLoc = 0; @@ -1338,7 +2039,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 439"; rLen = 0; - rLoc = 10800; + rLoc = 10859; rType = 0; vrLen = 1262; vrLoc = 5610; @@ -1348,7 +2049,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1210; vrLoc = 4359; @@ -1378,7 +2079,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 116"; rLen = 0; - rLoc = 4206; + rLoc = 4220; rType = 0; vrLen = 1261; vrLoc = 0; @@ -1396,7 +2097,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 571"; rLen = 0; - rLoc = 14790; + rLoc = 14851; rType = 0; vrLen = 1014; vrLoc = 2468; @@ -1406,7 +2107,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 63"; rLen = 0; - rLoc = 1956; + rLoc = 1970; rType = 0; vrLen = 1374; vrLoc = 0; @@ -1416,7 +2117,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 63"; rLen = 0; - rLoc = 1956; + rLoc = 1970; rType = 0; vrLen = 1374; vrLoc = 0; @@ -1480,7 +2181,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1067; vrLoc = 4506; @@ -1490,7 +2191,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 576"; rLen = 0; - rLoc = 14790; + rLoc = 14851; rType = 0; vrLen = 1467; vrLoc = 2800; @@ -1510,7 +2211,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 63"; rLen = 0; - rLoc = 1956; + rLoc = 1970; rType = 0; vrLen = 1291; vrLoc = 4282; @@ -1530,7 +2231,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 63"; rLen = 0; - rLoc = 1956; + rLoc = 1970; rType = 0; vrLen = 1291; vrLoc = 4282; @@ -1550,7 +2251,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -1560,7 +2261,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 576"; rLen = 0; - rLoc = 14790; + rLoc = 14851; rType = 0; vrLen = 1372; vrLoc = 2895; @@ -1580,7 +2281,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 449"; rLen = 0; - rLoc = 11724; + rLoc = 11783; rType = 0; vrLen = 1741; vrLoc = 10191; @@ -1590,7 +2291,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -1610,7 +2311,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 397"; rLen = 0; - rLoc = 9472; + rLoc = 9531; rType = 0; vrLen = 1995; vrLoc = 8614; @@ -1620,7 +2321,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -1640,7 +2341,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 399"; rLen = 0; - rLoc = 9472; + rLoc = 9531; rType = 0; vrLen = 2022; vrLoc = 8633; @@ -1650,7 +2351,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -1670,7 +2371,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 399"; rLen = 0; - rLoc = 9472; + rLoc = 9531; rType = 0; vrLen = 2022; vrLoc = 8633; @@ -1680,7 +2381,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -1700,7 +2401,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 399"; rLen = 0; - rLoc = 9472; + rLoc = 9531; rType = 0; vrLen = 2030; vrLoc = 8633; @@ -1710,7 +2411,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -1730,7 +2431,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 406"; rLen = 0; - rLoc = 9472; + rLoc = 9531; rType = 0; vrLen = 2079; vrLoc = 8633; @@ -1740,7 +2441,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -1760,7 +2461,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 397"; rLen = 0; - rLoc = 9472; + rLoc = 9531; rType = 0; vrLen = 2079; vrLoc = 8633; @@ -1770,7 +2471,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -1790,7 +2491,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 399"; rLen = 0; - rLoc = 9472; + rLoc = 9531; rType = 0; vrLen = 2074; vrLoc = 8633; @@ -1800,7 +2501,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -1820,7 +2521,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 397"; rLen = 0; - rLoc = 9472; + rLoc = 9531; rType = 0; vrLen = 1901; vrLoc = 8568; @@ -1830,7 +2531,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -1850,7 +2551,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 414"; rLen = 0; - rLoc = 10204; + rLoc = 10263; rType = 0; vrLen = 1906; vrLoc = 8568; @@ -1860,7 +2561,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -1880,7 +2581,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 414"; rLen = 0; - rLoc = 10204; + rLoc = 10263; rType = 0; vrLen = 1906; vrLoc = 8568; @@ -1890,7 +2591,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -1910,7 +2611,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 414"; rLen = 0; - rLoc = 10128; + rLoc = 10187; rType = 0; vrLen = 1884; vrLoc = 8568; @@ -1920,7 +2621,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -1940,7 +2641,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 414"; rLen = 0; - rLoc = 10086; + rLoc = 10145; rType = 0; vrLen = 1892; vrLoc = 8568; @@ -1950,7 +2651,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -1970,7 +2671,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 411"; rLen = 0; - rLoc = 9921; + rLoc = 9980; rType = 0; vrLen = 1894; vrLoc = 8568; @@ -1980,7 +2681,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -2000,7 +2701,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 414"; rLen = 0; - rLoc = 10166; + rLoc = 10225; rType = 0; vrLen = 1943; vrLoc = 8568; @@ -2010,7 +2711,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -2030,7 +2731,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 408"; rLen = 0; - rLoc = 9472; + rLoc = 9531; rType = 0; vrLen = 2070; vrLoc = 8483; @@ -2040,7 +2741,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -2060,7 +2761,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 408"; rLen = 0; - rLoc = 9472; + rLoc = 9531; rType = 0; vrLen = 2078; vrLoc = 8483; @@ -2070,7 +2771,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -2090,7 +2791,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 406"; rLen = 0; - rLoc = 9472; + rLoc = 9531; rType = 0; vrLen = 2163; vrLoc = 8486; @@ -2100,7 +2801,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -2120,7 +2821,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 406"; rLen = 0; - rLoc = 9472; + rLoc = 9531; rType = 0; vrLen = 2163; vrLoc = 8486; @@ -2130,7 +2831,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -2150,7 +2851,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 406"; rLen = 0; - rLoc = 9472; + rLoc = 9531; rType = 0; vrLen = 2170; vrLoc = 8486; @@ -2160,7 +2861,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -2180,7 +2881,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 413"; rLen = 0; - rLoc = 9863; + rLoc = 9922; rType = 0; vrLen = 2174; vrLoc = 8486; @@ -2190,7 +2891,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -2210,7 +2911,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 423"; rLen = 0; - rLoc = 10379; + rLoc = 10438; rType = 0; vrLen = 2191; vrLoc = 8783; @@ -2220,7 +2921,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -2240,7 +2941,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 423"; rLen = 0; - rLoc = 10296; + rLoc = 10355; rType = 0; vrLen = 2422; vrLoc = 9153; @@ -2250,7 +2951,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -2270,7 +2971,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 470"; rLen = 0; - rLoc = 12153; + rLoc = 12212; rType = 0; vrLen = 1435; vrLoc = 11317; @@ -2280,7 +2981,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -2300,7 +3001,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 462"; rLen = 0; - rLoc = 11827; + rLoc = 11886; rType = 0; vrLen = 1800; vrLoc = 10864; @@ -2310,7 +3011,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0; vrLen = 1066; vrLoc = 4506; @@ -2330,7 +3031,7 @@ fRef = 3A99A6500FB8E06100B1F47C /* supervisor_static_include.h */; name = "supervisor_static_include.h: 459"; rLen = 0; - rLoc = 11724; + rLoc = 11783; rType = 0; vrLen = 1798; vrLoc = 10864; @@ -2340,7 +3041,7 @@ fRef = 3AEAF9050FB2696400D61E73 /* supervisorCompler.c */; name = "supervisorCompler.c: 165"; rLen = 0; - rLoc = 4858; + rLoc = 4872; rType = 0... [truncated message content] |
From: <ee...@us...> - 2009-06-20 17:56:46
|
Revision: 86 http://pntool.svn.sourceforge.net/pntool/?rev=86&view=rev Author: eegs002 Date: 2009-06-20 17:56:44 +0000 (Sat, 20 Jun 2009) Log Message: ----------- Minor fixes related to messaging contract Modified Paths: -------------- codegen/src/plantCompiler.c Modified: codegen/src/plantCompiler.c =================================================================== --- codegen/src/plantCompiler.c 2009-06-20 02:22:24 UTC (rev 85) +++ codegen/src/plantCompiler.c 2009-06-20 17:56:44 UTC (rev 86) @@ -556,7 +556,7 @@ fprintf(plantFile,"\tupdatePns(&___pnsPlant,%d,"\ "___currentMarking);\n",i); - fprintf(plantFile,"\tprintf(\"___F%%d\\n\",pthread_self());\n"); + fprintf(plantFile,"\tprintf(\"\\n___F%%d\\n\",pthread_self());\n"); fprintf(plantFile,"\n\tgoto CM;\n"); fprintf(plantFile,"\n\t} //End if(isEnabled)\n"); @@ -792,7 +792,7 @@ //Alert the supervisor fprintf(plantFile,"\n\t//Alert the supervisor\n"); - fprintf(plantFile,"\tprintf(\"___?%%d:%%d-%%d\\n\",pthread_self(),"\ + fprintf(plantFile,"\tprintf(\"\\n___?%%d:%%d-%%d\\n\",pthread_self(),"\ "___lblNbr,___transNbr);\n"); //Suspend Until Response Received @@ -817,7 +817,7 @@ "\\n\",getpid());\n"); fprintf(plantFile,"\t\t#endif\n"); - fprintf(plantFile,"\t\tprintf(\"___?%%d:%%d-%%d\\n\",pthread_self(),"\ + fprintf(plantFile,"\t\tprintf(\"\\n___?%%d:%%d-%%d\\n\",pthread_self(),"\ "___lblNbr,___transNbr);\n"); fprintf(plantFile,"\t\tfgets(___buffer, MAX_MESSAGE_SIZE, stdin);\n"); fprintf(plantFile,"\t}//End while\n"); This was sent by the SourceForge.net collaborative development platform, the world's largest Open Source development site. |
From: bion o. <Bio...@le...> - 2009-06-20 06:31:59
|
I'm not sure if anyone is using the specs structure yet, but I'm trying to figure out how to set up the constraints array (constraint **constraint_array). It looks like it should be an array of pointers to constraint objects, but the data structure is set up like it should be used as a linked list. In addition, the spec structure does not store the number of constraints in the array, so I am confused as to how anyone would iterate over this array. Any insight would be appreciated... Bion Oren |
From: <Ste...@us...> - 2009-06-20 02:22:28
|
Revision: 85 http://pntool.svn.sourceforge.net/pntool/?rev=85&view=rev Author: StephenCamp Date: 2009-06-20 02:22:24 +0000 (Sat, 20 Jun 2009) Log Message: ----------- pn2acpn debugged and now passes all tests. test-pn2acpn.txt now has tests for all of pn2acpn's parameters. Modified Paths: -------------- spnbox/pn2acpn.c spnbox/tests/test-pn2acpn.txt Property Changed: ---------------- spnbox/tests/ Modified: spnbox/pn2acpn.c =================================================================== --- spnbox/pn2acpn.c 2009-06-19 23:25:44 UTC (rev 84) +++ spnbox/pn2acpn.c 2009-06-20 02:22:24 UTC (rev 85) @@ -112,26 +112,21 @@ */ void FinalizeResult(pn2acpn_r* result, matrix* L, matrix* Dm, int* ipl, int ipCount) { - int places, lrows, oldplaces, i, place; + int places, oldplaces, i, place, newplaces; /*Fill the incidence matrix.*/ result->Df = SubtractMatrix(&result->Dpf, &result->Dmf, (matrix*) 2); - if (L) - { - lrows = NumberOfRows(*L); - oldplaces = NumberOfColumns(*L); - } - else - { - lrows = 0; - oldplaces = NumberOfRows(*Dm); - } + oldplaces = NumberOfRows(*Dm); places = NumberOfRows(result->Df); - + newplaces = places - oldplaces; + /*The new L matrix should be the same as the old with columns of zeros added for all the new places.*/ - AllocateMatrixType(2, &result->LF, lrows, places); - CopyBlock(lrows, oldplaces, L, 0, 0, &result->LF, 0, 0); + if (L) + { + AllocateMatrixType(2, &result->LF, NumberOfRows(*L), NumberOfColumns(*L) + newplaces); + CopyBlock(NumberOfRows(*L), NumberOfColumns(*L), L, 0, 0, &result->LF, 0, 0); + } /*The new independent place list should contain all the places that were added and each of the old places.*/ @@ -250,7 +245,7 @@ { if (dpl[x] == i) break; } - if (x < dpCount) + if (x < dpCount && NumberOfRows(MX)) { SetMatrixEl(&MX, x, NumberOfColumns(MX) - ToAdd + j, -1); } @@ -564,30 +559,6 @@ } } - /*L0 - matrix, initial marking constraint. Not required. If present must have - the same number of columns as there are places.*/ - if (L0) - { - if (NumberOfColumns(*L0) != Places) - { - FreeMemory(mem); - merror(0, "PN2ACPN: The size of L0 and the Petri net matrices do not agree"); - return 0; - } - } - - /*L - matrix, marking constraint. Not required. If present must have the same - number of columns as there are places.*/ - if (L) - { - if (NumberOfColumns(*L) != Places) - { - FreeMemory(mem); - merror(0, "PN2ACPN: The size of L and the Petri net matrices do not agree"); - return 0; - } - } - /*ipl, dpl: unpredictable-length int arrays, holding indices of independent and dependent places. Not required. If either array pointer is null the count should be set to zero and vice-versa. @@ -626,7 +597,31 @@ merror(0, "PN2ACPN: The independent and dependent place list lengths do not agree with the number of places"); return 0; } + + /*L0 - matrix, initial marking constraint. Not required. If present must have + the same number of columns as there are independent places.*/ + if (L0) + { + if (NumberOfColumns(*L0) != *ipCount) + { + FreeMemory(mem); + merror(0, "PN2ACPN: The size of L0 and the independent place list do not agree"); + return 0; + } + } + /*L - matrix, marking constraint. Not required. If present must have the same + number of columns as there are independent places.*/ + if (L) + { + if (NumberOfColumns(*L) != *ipCount) + { + FreeMemory(mem); + merror(0, "PN2ACPN: The size of L and the independent place list do not agree"); + return 0; + } + } + /*MX - matrix, same meaning as in msplit: is the transformation matrix from the independent marking to the dependent marking. Not required. If present, must have the same number of rows as there are dependent places and the same @@ -636,7 +631,7 @@ if (NumberOfRows(*MX) != *dpCount || NumberOfColumns(*MX) != *ipCount) { FreeMemory(mem); - merror(0, "PN2ACPN: The size of the transformation matrix MX and the dependent and independent place counts do not agree"); + merror(0, "PN2ACPN: The size of the transformation matrix MX and the dependent and independent place lists do not agree"); return 0; } } Property changes on: spnbox/tests ___________________________________________________________________ Modified: svn:ignore - *.bsh *.exe *.stackdump out.txt test-pn2acpn-03.txt + *.bsh *.exe out.txt test-pn2acpn-03.txt Modified: spnbox/tests/test-pn2acpn.txt =================================================================== --- spnbox/tests/test-pn2acpn.txt 2009-06-19 23:25:44 UTC (rev 84) +++ spnbox/tests/test-pn2acpn.txt 2009-06-20 02:22:24 UTC (rev 85) @@ -17,7 +17,8 @@ rem ---------------------------------------------------------------------------- echo Problem 1 echo Example 5.2 from the thesis. - +echo The first three test problems are the problems of the original matlab test +echo file pn2acdem.m. Dp 3 5 0 1 0 1 0 0 0 1 0 1 @@ -69,4 +70,181 @@ done +rem ---------------------------------------------------------------------------- +echo New problems created for testing pn2acpn.c begin here. +echo Problem 4. +echo This problem duplicates problem 3 above but adds a mask disallowing +echo operations on the fourth and fifth places, thus eliminated one row and and +echo column pair from the result as well as moving entries previously made in +echo the fourth and fifth places to other places. +D 5 6 +-1 -1 0 0 0 0 +0 -1 -1 0 0 0 +0 0 -1 -1 0 0 +0 0 0 -1 -1 0 +0 0 0 -1 0 -1 + +Mask 5 +1 1 1 0 0 + +done + +rem ---------------------------------------------------------------------------- +echo Problem 5. +echo This problem introduces an initial marking constraint L0. +echo The modified constraint should be: +echo LOF: +echo 1 2 3 4 5 1 2 3 4 +echo 5 4 3 2 1 5 4 3 2 + +D 5 6 +-1 -1 0 0 0 0 +0 -1 -1 0 0 0 +0 0 -1 -1 0 0 +0 0 0 -1 -1 0 +0 0 0 -1 0 -1 + +L0 2 5 +1 2 3 4 5 +5 4 3 2 1 + +done + +rem ---------------------------------------------------------------------------- +echo Problem 6. +echo This problem keeps the initial marking constraint and introduces +echo dependent places. The third and fifth places are set as dependent +echo Modified independent place list should be: +echo iplf: 0 1 3 5 6 7 8 +echo The modified constraint should be: +echo LOF: +echo 1 2 3 1 2 0 3 +echo 4 3 2 4 3 0 2 + +D 5 6 +-1 -1 0 0 0 0 +0 -1 -1 0 0 0 +0 0 -1 -1 0 0 +0 0 0 -1 -1 0 +0 0 0 -1 0 -1 + +L0 2 3 +1 2 3 +4 3 2 + +ipl 3 +0 1 3 + +dpl 2 +2 4 + +done + +rem ---------------------------------------------------------------------------- +echo Problem 7. +echo This problem keeps the initial marking constraind and dependent place +echo lists. It adds a marking constraint L. Final marking constraint should be: +echo 1 2 3 0 0 0 0 +echo 3 2 1 0 0 0 0 +echo 9 8 7 0 0 0 0 + +D 5 6 +-1 -1 0 0 0 0 +0 -1 -1 0 0 0 +0 0 -1 -1 0 0 +0 0 0 -1 -1 0 +0 0 0 -1 0 -1 + +L0 2 3 +1 2 3 +4 3 2 + +L 3 3 +1 2 3 +3 2 1 +9 8 7 + +ipl 3 +0 1 3 + +dpl 2 +2 4 + +done + +rem ---------------------------------------------------------------------------- +echo Problem 8. +echo This problem is the same as the previous one but adds the independent-to- +echo dependent marking transformation MX. +echo the new MX should be: +echo 2 3 5 2 3 -1 5 +echo 7 9 11 7 9 0 11 + +D 5 6 +-1 -1 0 0 0 0 +0 -1 -1 0 0 0 +0 0 -1 -1 0 0 +0 0 0 -1 -1 0 +0 0 0 -1 0 -1 + +L0 2 3 +1 2 3 +4 3 2 + +L 3 3 +1 2 3 +3 2 1 +9 8 7 + +ipl 3 +0 1 3 + +dpl 2 +2 4 + +MX 2 3 +2 3 5 +7 9 11 + +done + +rem ---------------------------------------------------------------------------- +echo Problem 9. +echo This problem is identical to problem 8 but changes one value +echo in the incidence matrix, which should yield a result matrix +echo with a -2 at row 8, column 3 (numbering rows and columns from +echo 0) +echo 2 3 5 2 3 -1 5 +echo 7 9 11 7 9 0 11 + +D 5 6 +-1 -1 0 0 0 0 +0 -1 -1 0 0 0 +0 0 -1 -1 0 0 +0 0 0 -2 -1 0 +0 0 0 -1 0 -1 + +L0 2 3 +1 2 3 +4 3 2 + +L 3 3 +1 2 3 +3 2 1 +9 8 7 + +ipl 3 +0 1 3 + +dpl 2 +2 4 + +MX 2 3 +2 3 5 +7 9 11 + +done + quit + + This was sent by the SourceForge.net collaborative development platform, the world's largest Open Source development site. |
From: <Ste...@us...> - 2009-06-19 23:25:46
|
Revision: 84 http://pntool.svn.sourceforge.net/pntool/?rev=84&view=rev Author: StephenCamp Date: 2009-06-19 23:25:44 +0000 (Fri, 19 Jun 2009) Log Message: ----------- pn2acpn.c has been debugged and now passes first round of tests which test output incidence matrices only. StructuredIO.c modified slightly. test-pn2acpn.txt updated to include first round of tests. Modified Paths: -------------- spnbox/pn2acpn.c spnbox/tests/StructuredIO.c spnbox/tests/test-pn2acpn.txt Property Changed: ---------------- spnbox/tests/ Modified: spnbox/pn2acpn.c =================================================================== --- spnbox/pn2acpn.c 2009-06-19 21:15:17 UTC (rev 83) +++ spnbox/pn2acpn.c 2009-06-19 23:25:44 UTC (rev 84) @@ -306,10 +306,10 @@ } /*Otherwise, we do some other tests to eliminate one of the numbers.*/ /*If the qflags for both of the U indices are still 0...*/ - if (! (Qflag[U1] && Qflag[U2])) + if (! (Qflag[U1] || Qflag[U2])) { //If we are examining any but the last pair of place indexes: - if (Pair < NumberOfColumns(*U)) + if (Pair < NumberOfColumns(*U) - 1) { /*If the first index in the next pair is the same as the first index in this pair, return that index.*/ if (U1 == GetMatrixEl(U, 0, Pair + 1)) @@ -319,7 +319,7 @@ else { /*Otherwise, if there exist any pairs after the current one such that one of their indicies is the same as the second index of the current pair, return the second index of the current pair.*/ - for (i = Pair; i < NumberOfColumns(*U); i++) + for (i = Pair + 1; i < NumberOfColumns(*U); i++) { if (GetMatrixEl(U, 0, i) == U2 || GetMatrixEl(U, 1, i) == U2) { @@ -334,7 +334,7 @@ for (i = 0; i < NumberOfColumns(result->Dmf); i++) { if (GetMatrixEl(&result->Dmf, U1, i)) arcCount1++; - if (GetMatrixEl(&result->Dpf, U2, i)) arcCount1++; + if (GetMatrixEl(&result->Dmf, U2, i)) arcCount2++; } if (arcCount1 >= arcCount2) { @@ -359,6 +359,7 @@ { int *Row0, *Row1; int NextCol, ColCapacity, i, j, k, flag0, flag1, Transitions, dmi, dmj; + int iCount, jCount; Transitions = NumberOfColumns(result->Dmf); matrix U; @@ -374,59 +375,87 @@ NextCol = 0; ColCapacity = OriginalPlaces; - /*Iterate through all the places in the transition of interest.*/ - for (i = 0; i < OriginalPlaces - 1; i++) + /*Iterate through all the places in the transition of interest. Process only + the first n - 1 with nonzero output arcs, where n is the number that originally + had nonzero output arcs. Let i be the index of the place and iCount be the + number of arcs that will have been processed if the loop condition holds + and the loop is allowed to iterate.*/ + i = -1; + iCount = 0; + while (++iCount < cardbt[Transition]) { - //If the output arc here is nonzero... - if (GetMatrixEl(&result->Dmf, i, Transition)) + /*Find the next place for which the current transition has a nonzero output + arc. If we exceed the matrix boundaries looking for it, fail.*/ + while (! GetMatrixEl(&result->Dmf, ++i, Transition)) + { + if (i >= NumberOfRows(result->Dmf)) + { + merror(0, "PN2ACPN: Internal Error"); + /*Set U equal to an error value and return it.*/ + AllocateMatrix(&U, 0, 0); + return U; + } + } + + /*Iterate through all the remaining places with nonzero output arcs to the + transition of interest up to n many, for n, as before, the original number + of nonzero output arcs. Let j be the place index and jCount n for the nth + nonzero place.*/ + j = i; + jCount = iCount; + while (++jCount <= cardbt[Transition]) { - /*Iterate through all the remaining places*/ - for (j = i; j < OriginalPlaces; j++) + /*Find the next place for which the current transition has a nonzero output + arc. If we exceed the matrix boundaries looking for it, fail.*/ + while (! GetMatrixEl(&result->Dmf, ++j, Transition)) + { + if (j >= NumberOfRows(result->Dmf)) + { + merror(0, "PN2ACPN: Internal Error"); + /*Set U equal to an error value and return it.*/ + AllocateMatrix(&U, 0, 0); + return U; + } + } + /*The original Matlab algorithm set a flag according to this + algorithm: (some variable names changed to make it apparent in terms + of variables already used): + prj = Dmf(i,:) ~= 0; % p_j\bullet + prk = Dmf(j,:) ~= 0; % p_k\bullet + flag = sum((~prj) & (prj | prk)) & sum((~prk) & (prj | prk)); + The same operation can be reduced to a pair of examinations, one + to get the results of the operation logical of + sum((~prj) & (prj | prk)) and the next to get the results of the + operation logical of sum((~prk) & (prj | prk))*/ + flag0 = 0; + flag1 = 0; + for (k = 0; k < Transitions; k++) { - //If the output arc is nonzero... - if (GetMatrixEl(&result->Dmf, j, Transition)) + dmi = GetMatrixEl(&result->Dmf, i, k); + dmj = GetMatrixEl(&result->Dmf, j, k); + if ((! dmi) && dmj) { - /*The original Matlab algorithm set a flag according to this - algorithm: (some variable names changed to make it apparent in terms - of variables already used): - prj = Dmf(i,:) ~= 0; % p_j\bullet - prk = Dmf(j,:) ~= 0; % p_k\bullet - flag = sum((~prj) & (prj | prk)) & sum((~prk) & (prj | prk)); - The same operation can be reduced to a pair of examinations, one - to get the results of the operation logical of - sum((~prj) & (prj | prk)) and the next to get the results of the - operation logical of sum((~prk) & (prj | prk))*/ - flag0 = 0; - flag1 = 0; - for (k = 0; k < Transitions; k++) - { - dmi = GetMatrixEl(&result->Dmf, i, k); - dmj = GetMatrixEl(&result->Dmf, j, k); - if ((! dmi) && dmj) - { - flag0 = 1; - } - if ((! dmj) && dmi) - { - flag1 = 1; - } - } - /*If both flags are set, we add the current pair of places to the - U-matrix.*/ - if (flag0 && flag1) - { - /*If there is space left in the temporary holding places, use it. If - not, reallocate with more space.*/ - if (NextCol == ColCapacity) - { - Row0 = realloc(Row0, (ColCapacity += OriginalPlaces) * sizeof(int)); - Row1 = realloc(Row1, (ColCapacity += OriginalPlaces) * sizeof(int)); - } - Row0[NextCol] = i; - Row1[NextCol++] = j; - } + flag0 = 1; } + if ((! dmj) && dmi) + { + flag1 = 1; + } } + /*If both flags are set, we add the current pair of places to the + U-matrix.*/ + if (flag0 && flag1) + { + /*If there is space left in the temporary holding places, use it. If + not, reallocate with more space.*/ + if (NextCol == ColCapacity) + { + Row0 = realloc(Row0, (ColCapacity += OriginalPlaces) * sizeof(int)); + Row1 = realloc(Row1, (ColCapacity += OriginalPlaces) * sizeof(int)); + } + Row0[NextCol] = i; + Row1[NextCol++] = j; + } } } /*Copy the contents of Row0 and Row1 into the U-matrix.*/ @@ -438,6 +467,7 @@ } free(Row0); free(Row1); + return U; } Property changes on: spnbox/tests ___________________________________________________________________ Modified: svn:ignore - *.bsh *.exe *.stackdump + *.bsh *.exe *.stackdump out.txt test-pn2acpn-03.txt Modified: spnbox/tests/StructuredIO.c =================================================================== --- spnbox/tests/StructuredIO.c 2009-06-19 21:15:17 UTC (rev 83) +++ spnbox/tests/StructuredIO.c 2009-06-19 23:25:44 UTC (rev 84) @@ -225,7 +225,7 @@ { Matrix = va_arg(args, matrix*); /*If the matrix is zero-sized don't show it.*/ - if (Mask ? Mask[i] : 1 && NumberOfRows(*Matrix) && NumberOfColumns(*Matrix)) + if ((Mask ? Mask[i] : 1) && NumberOfRows(*Matrix) && NumberOfColumns(*Matrix)) { ShowMatrix(Matrix, Params[i].Name); } Modified: spnbox/tests/test-pn2acpn.txt =================================================================== --- spnbox/tests/test-pn2acpn.txt 2009-06-19 21:15:17 UTC (rev 83) +++ spnbox/tests/test-pn2acpn.txt 2009-06-19 23:25:44 UTC (rev 84) @@ -47,6 +47,26 @@ done -quit +rem ---------------------------------------------------------------------------- +echo Problem 3 +echo The solution matrix Df should be: +echo -1 0 0 0 0 0 -1 0 0 0 +echo 0 -1 0 0 0 0 0 -1 0 0 +echo 0 0 -1 0 0 0 0 0 -1 0 +echo 0 0 0 0 -1 0 0 0 0 -1 +echo 0 0 0 -1 0 -1 0 0 0 0 +echo 0 -1 0 0 0 0 1 0 0 0 +echo 0 0 -1 0 0 0 0 1 0 0 +echo 0 0 0 -1 0 0 0 0 1 0 +echo 0 0 0 -1 0 0 0 0 0 1 +D 5 6 +-1 -1 0 0 0 0 +0 -1 -1 0 0 0 +0 0 -1 -1 0 0 +0 0 0 -1 -1 0 +0 0 0 -1 0 -1 +done + +quit This was sent by the SourceForge.net collaborative development platform, the world's largest Open Source development site. |
From: <the...@us...> - 2009-06-19 21:15:21
|
Revision: 83 http://pntool.svn.sourceforge.net/pntool/?rev=83&view=rev Author: thecodeweasel Date: 2009-06-19 21:15:17 +0000 (Fri, 19 Jun 2009) Log Message: ----------- Updating documentation Decided to postpone handling '<' operator. The work would have to be redone once pncompactor does equation balancing anyway, and it will be much simpler to handle this scenario then. Patched version of pngenerator.c Modified Paths: -------------- translator/README.txt translator/docs/TODO.rtf translator/docs/test.txt translator/pncompactor.c translator/pncompactor.g translator/pncompactor.h translator/pngenerator.c translator/pnscript.g translator/pnscriptLexer.c translator/pnscriptLexer.h translator/pnscriptParser.c translator/pnscriptParser.h Modified: translator/README.txt =================================================================== --- translator/README.txt 2009-06-19 20:57:36 UTC (rev 82) +++ translator/README.txt 2009-06-19 21:15:17 UTC (rev 83) @@ -18,12 +18,16 @@ #USE run '/PATH/TO/FILE/pnscript [INPUT_FILE]' +#NOTES +A specs* structure is generated by pngenerator.c and returned to the main method in main.c. The main function should be easily adapted for use in the pns library's ScanInput() method + #OBTAINING ANTLR This grammar is currently maintained in ANTLRWorks 1.2.3, which uses ANTLR 3.1.2. ANTLRWorks can be obtained from antlr.org or by going directly to http://www.antlr.org/download.html. The C Runtime Libraries can be obtained from antlr.org or by going directly to http://www.antlr.org/download/C. Note that this code currently uses the 3.1.3 library, despite the fact that ANTLRWorks builds against the 3.1.2 library. #UPDATING ANTLR LIBRARIES To update the ANTLR C libraries, run 'make distclean'. Then, remove everything in the clibs folder, and extract the new C libraries into the clibs folder. Then run 'make'. +NOTE: The clibs.patch file may need to be updated. #UPDATING PN LIBRARIES To update the PN libraries, run make clean. Then, place your new files in the "pnheaders" folder, selecting overwrite if\when prompted. Modified: translator/docs/TODO.rtf =================================================================== --- translator/docs/TODO.rtf 2009-06-19 20:57:36 UTC (rev 82) +++ translator/docs/TODO.rtf 2009-06-19 21:15:17 UTC (rev 83) @@ -18,11 +18,13 @@ \strike \strikec0 Re-write Main.c to invoke everything properly\strike0\striked0 \ \strike \strikec0 Update README\strike0\striked0 \ \ -Implement a tree walker to "balance" the equations\ -Re-write Main.c to invoke everything properly?\ +\strike \strikec0 Re-write Main.c to invoke everything properly?\strike0\striked0 \ \strike \strikec0 Implement a Hashtable for the symbol table(s)\strike0\striked0 \ \strike \strikec0 Add predicates to check for extern related syntax restrictions, etc.\strike0\striked0 \ \strike \strikec0 Implement error handling(/recovery?) - use flags for warning levels?\strike0\striked0 \ -Update README\ +\strike \strikec0 Update README\strike0\striked0 \ Generate test data\ +Debug\ +Implement a tree walker to "balance" the equations\ +Generate test data\ Debug} \ No newline at end of file Modified: translator/docs/test.txt =================================================================== --- translator/docs/test.txt 2009-06-19 20:57:36 UTC (rev 82) +++ translator/docs/test.txt 2009-06-19 21:15:17 UTC (rev 83) @@ -69,7 +69,7 @@ //------------------------------------------------ w_group.constraints: pwr_1 <= 1; -pwr_2 < 2; +pwr_2 <= 2; live: all; //------------------------------------------------ global.constraints: Modified: translator/pncompactor.c =================================================================== --- translator/pncompactor.c 2009-06-19 20:57:36 UTC (rev 82) +++ translator/pncompactor.c 2009-06-19 21:15:17 UTC (rev 83) @@ -2,7 +2,7 @@ * This C source file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pncompactor.g - * - On : 2009-06-19 15:56:07 + * - On : 2009-06-19 16:07:30 * - for the tree parser : pncompactorTreeParser * * Editing it, at least manually, is not wise. * @@ -549,273 +549,273 @@ /* Declare the bitsets */ -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_definitions_in_pn79 */ -static ANTLR3_BITWORD FOLLOW_proc_definitions_in_pn79_bits[] = { ANTLR3_UINT64_LIT(0x0000000000C00400) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_definitions_in_pn79 = { FOLLOW_proc_definitions_in_pn79_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_pn82 */ -static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_pn82_bits[] = { ANTLR3_UINT64_LIT(0x0000000400C00402) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_pn82 = { FOLLOW_proc_instantiations_in_pn82_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraints_in_pn85 */ -static ANTLR3_BITWORD FOLLOW_constraints_in_pn85_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000402) }; -static ANTLR3_BITSET_LIST FOLLOW_constraints_in_pn85 = { FOLLOW_constraints_in_pn85_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_other_commands_in_pn88 */ -static ANTLR3_BITWORD FOLLOW_other_commands_in_pn88_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000002) }; -static ANTLR3_BITSET_LIST FOLLOW_other_commands_in_pn88 = { FOLLOW_other_commands_in_pn88_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_def_start_in_proc_definitions100 */ -static ANTLR3_BITWORD FOLLOW_def_start_in_proc_definitions100_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_def_start_in_proc_definitions100 = { FOLLOW_def_start_in_proc_definitions100_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_trans_defs_in_proc_definitions102 */ -static ANTLR3_BITWORD FOLLOW_trans_defs_in_proc_definitions102_bits[] = { ANTLR3_UINT64_LIT(0x0000200000200468) }; -static ANTLR3_BITSET_LIST FOLLOW_trans_defs_in_proc_definitions102 = { FOLLOW_trans_defs_in_proc_definitions102_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_select_functions_in_proc_definitions105 */ -static ANTLR3_BITWORD FOLLOW_select_functions_in_proc_definitions105_bits[] = { ANTLR3_UINT64_LIT(0x0000200000200008) }; -static ANTLR3_BITSET_LIST FOLLOW_select_functions_in_proc_definitions105 = { FOLLOW_select_functions_in_proc_definitions105_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_nondeterm_in_proc_definitions108 */ -static ANTLR3_BITWORD FOLLOW_nondeterm_in_proc_definitions108_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_nondeterm_in_proc_definitions108 = { FOLLOW_nondeterm_in_proc_definitions108_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_def_start119 */ -static ANTLR3_BITWORD FOLLOW_ID_in_def_start119_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_def_start119 = { FOLLOW_ID_in_def_start119_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_extern_trans_def_in_trans_defs127 */ -static ANTLR3_BITWORD FOLLOW_extern_trans_def_in_trans_defs127_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_extern_trans_def_in_trans_defs127 = { FOLLOW_extern_trans_def_in_trans_defs127_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_trans_def_in_trans_defs132 */ -static ANTLR3_BITWORD FOLLOW_trans_def_in_trans_defs132_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_trans_def_in_trans_defs132 = { FOLLOW_trans_def_in_trans_defs132_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_set_in_extern_trans_def142 */ -static ANTLR3_BITWORD FOLLOW_set_in_extern_trans_def142_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_set_in_extern_trans_def142 = { FOLLOW_set_in_extern_trans_def142_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_extern_trans_def150 */ -static ANTLR3_BITWORD FOLLOW_ID_in_extern_trans_def150_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_extern_trans_def150 = { FOLLOW_ID_in_extern_trans_def150_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def162 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def162_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def162 = { FOLLOW_ID_in_trans_def162_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def164 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def164_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def164 = { FOLLOW_CODE_BLOCK_in_trans_def164_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def171 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def171_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def171 = { FOLLOW_ID_in_trans_def171_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def173 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def173_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def173 = { FOLLOW_ID_in_trans_def173_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def176 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def176_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def176 = { FOLLOW_CODE_BLOCK_in_trans_def176_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def184 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def184_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def184 = { FOLLOW_ID_in_trans_def184_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def187 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def187_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def187 = { FOLLOW_ID_in_trans_def187_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def189 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def189_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def189 = { FOLLOW_ID_in_trans_def189_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def192 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def192_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def192 = { FOLLOW_CODE_BLOCK_in_trans_def192_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SELECT_DEF_in_select_functions204 */ -static ANTLR3_BITWORD FOLLOW_SELECT_DEF_in_select_functions204_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SELECT_DEF_in_select_functions204 = { FOLLOW_SELECT_DEF_in_select_functions204_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_select_functions206 */ -static ANTLR3_BITWORD FOLLOW_ID_in_select_functions206_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002000) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_select_functions206 = { FOLLOW_ID_in_select_functions206_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_select_functions208 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_select_functions208_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_select_functions208 = { FOLLOW_CODE_BLOCK_in_select_functions208_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_45_in_nondeterm219 */ -static ANTLR3_BITWORD FOLLOW_45_in_nondeterm219_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_45_in_nondeterm219 = { FOLLOW_45_in_nondeterm219_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_nondeterm221 */ -static ANTLR3_BITWORD FOLLOW_ID_in_nondeterm221_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_nondeterm221 = { FOLLOW_ID_in_nondeterm221_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_init_in_proc_instantiations233 */ -static ANTLR3_BITWORD FOLLOW_proc_init_in_proc_instantiations233_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_init_in_proc_instantiations233 = { FOLLOW_proc_init_in_proc_instantiations233_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_sync_def_in_proc_instantiations237 */ -static ANTLR3_BITWORD FOLLOW_sync_def_in_proc_instantiations237_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_sync_def_in_proc_instantiations237 = { FOLLOW_sync_def_in_proc_instantiations237_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_start_in_proc_instantiations241 */ -static ANTLR3_BITWORD FOLLOW_proc_start_in_proc_instantiations241_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_start_in_proc_instantiations241 = { FOLLOW_proc_start_in_proc_instantiations241_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init251 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_init251_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init251 = { FOLLOW_ID_in_proc_init251_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_numbered_ID_in_proc_init253 */ -static ANTLR3_BITWORD FOLLOW_numbered_ID_in_proc_init253_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_numbered_ID_in_proc_init253 = { FOLLOW_numbered_ID_in_proc_init253_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SYNC_TOK_in_sync_def265 */ -static ANTLR3_BITWORD FOLLOW_SYNC_TOK_in_sync_def265_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SYNC_TOK_in_sync_def265 = { FOLLOW_SYNC_TOK_in_sync_def265_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_sync_def267 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def267_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_sync_def267 = { FOLLOW_group_elements_in_sync_def267_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start279 */ -static ANTLR3_BITWORD FOLLOW_START_in_proc_start279_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start279 = { FOLLOW_START_in_proc_start279_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start281 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_start281_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start281 = { FOLLOW_ID_in_proc_start281_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints298 */ -static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints298_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints298 = { FOLLOW_constraint_block_in_constraints298_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints303 */ -static ANTLR3_BITWORD FOLLOW_eq_in_constraints303_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints303 = { FOLLOW_eq_in_constraints303_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints309 */ -static ANTLR3_BITWORD FOLLOW_live_def_in_constraints309_bits[] = { ANTLR3_UINT64_LIT(0x0000000300000008) }; -static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints309 = { FOLLOW_live_def_in_constraints309_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints312 */ -static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints312_bits[] = { ANTLR3_UINT64_LIT(0x0000000200000008) }; -static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints312 = { FOLLOW_uncontrol_in_constraints312_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints315 */ -static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints315_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints315 = { FOLLOW_unobserve_in_constraints315_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block325 */ -static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block325_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block325 = { FOLLOW_ID_in_constraint_block325_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq334 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq334_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq334 = { FOLLOW_relationalExpression_in_eq334_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq340 */ -static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq340_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq340 = { FOLLOW_EQS_OP_in_eq340_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq342 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq342_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq342 = { FOLLOW_eq_in_eq342_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq344 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq344_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq344 = { FOLLOW_eq_in_eq344_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression361 */ -static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression361_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression361 = { FOLLOW_EQ_OP_in_relationalExpression361_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression366 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression366_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression366 = { FOLLOW_relationalExpression_in_relationalExpression366_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression368 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression368_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression368 = { FOLLOW_additiveExpression_in_relationalExpression368_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression374 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression374_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression374 = { FOLLOW_relationalExpression_in_relationalExpression374_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression376 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression376_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression376 = { FOLLOW_additiveExpression_in_relationalExpression376_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression398 */ -static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression398_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression398 = { FOLLOW_primary_in_additiveExpression398_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_PLUS_in_additiveExpression408 */ -static ANTLR3_BITWORD FOLLOW_PLUS_in_additiveExpression408_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_PLUS_in_additiveExpression408 = { FOLLOW_PLUS_in_additiveExpression408_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression412 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression412_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression412 = { FOLLOW_additiveExpression_in_additiveExpression412_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression429 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression429_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression429 = { FOLLOW_additiveExpression_in_additiveExpression429_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_additiveExpression479 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_additiveExpression479_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_additiveExpression479 = { FOLLOW_MINUS_in_additiveExpression479_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression483 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression483_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression483 = { FOLLOW_additiveExpression_in_additiveExpression483_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression499 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression499_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression499 = { FOLLOW_additiveExpression_in_additiveExpression499_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_primary560 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_primary560_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_primary560 = { FOLLOW_MINUS_in_primary560_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary564 */ -static ANTLR3_BITWORD FOLLOW_eq_in_primary564_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary564 = { FOLLOW_eq_in_primary564_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary579 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_primary579_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary579 = { FOLLOW_group_elements_in_primary579_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary620 */ -static ANTLR3_BITWORD FOLLOW_number_in_primary620_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_primary620 = { FOLLOW_number_in_primary620_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary631 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_primary631_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary631 = { FOLLOW_MULT_in_primary631_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary633 */ -static ANTLR3_BITWORD FOLLOW_number_in_primary633_bits[] = { ANTLR3_UINT64_LIT(0x0000000021040088) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_primary633 = { FOLLOW_number_in_primary633_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary635 */ -static ANTLR3_BITWORD FOLLOW_primary_in_primary635_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary635 = { FOLLOW_primary_in_primary635_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary670 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_primary670_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary670 = { FOLLOW_MULT_in_primary670_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary672 */ -static ANTLR3_BITWORD FOLLOW_number_in_primary672_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_primary672 = { FOLLOW_number_in_primary672_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary676 */ -static ANTLR3_BITWORD FOLLOW_eq_in_primary676_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary676 = { FOLLOW_eq_in_primary676_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def700 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def700_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def700 = { FOLLOW_LIVE_in_live_def700_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def702 */ -static ANTLR3_BITWORD FOLLOW_ALL_in_live_def702_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def702 = { FOLLOW_ALL_in_live_def702_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def704 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def704_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def704 = { FOLLOW_ID_in_live_def704_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def712 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def712_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def712 = { FOLLOW_LIVE_in_live_def712_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def714 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def714_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def714 = { FOLLOW_ID_in_live_def714_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol726 */ -static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol726_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol726 = { FOLLOW_UNCONTROL_in_uncontrol726_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol728 */ -static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol728_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol728 = { FOLLOW_ID_in_uncontrol728_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve740 */ -static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve740_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve740 = { FOLLOW_UNOBSERVE_in_unobserve740_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve742 */ -static ANTLR3_BITWORD FOLLOW_ID_in_unobserve742_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve742 = { FOLLOW_ID_in_unobserve742_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands754 */ -static ANTLR3_BITWORD FOLLOW_print_in_other_commands754_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands754 = { FOLLOW_print_in_other_commands754_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print764 */ -static ANTLR3_BITWORD FOLLOW_PRINT_in_print764_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print764 = { FOLLOW_PRINT_in_print764_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print766 */ -static ANTLR3_BITWORD FOLLOW_ID_in_print766_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_print766 = { FOLLOW_ID_in_print766_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print768 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_print768_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print768 = { FOLLOW_group_elements_in_print768_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number787 */ -static ANTLR3_BITWORD FOLLOW_INT_in_number787_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_number787 = { FOLLOW_INT_in_number787_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_number800 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_number800_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_number800 = { FOLLOW_MINUS_in_number800_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number802 */ -static ANTLR3_BITWORD FOLLOW_INT_in_number802_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_number802 = { FOLLOW_INT_in_number802_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_GROUP_in_group_elements820 */ -static ANTLR3_BITWORD FOLLOW_GROUP_in_group_elements820_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_GROUP_in_group_elements820 = { FOLLOW_GROUP_in_group_elements820_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements822 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements822_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements822 = { FOLLOW_ID_in_group_elements822_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID833 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID833_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID833 = { FOLLOW_ID_in_numbered_ID833_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID839 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID839_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID839 = { FOLLOW_ID_in_numbered_ID839_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID841 */ -static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID841_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID841 = { FOLLOW_INT_in_numbered_ID841_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_definitions_in_pn78 */ +static ANTLR3_BITWORD FOLLOW_proc_definitions_in_pn78_bits[] = { ANTLR3_UINT64_LIT(0x0000000000C00400) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_definitions_in_pn78 = { FOLLOW_proc_definitions_in_pn78_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_pn81 */ +static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_pn81_bits[] = { ANTLR3_UINT64_LIT(0x0000000400C00402) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_pn81 = { FOLLOW_proc_instantiations_in_pn81_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraints_in_pn84 */ +static ANTLR3_BITWORD FOLLOW_constraints_in_pn84_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000402) }; +static ANTLR3_BITSET_LIST FOLLOW_constraints_in_pn84 = { FOLLOW_constraints_in_pn84_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_other_commands_in_pn87 */ +static ANTLR3_BITWORD FOLLOW_other_commands_in_pn87_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000002) }; +static ANTLR3_BITSET_LIST FOLLOW_other_commands_in_pn87 = { FOLLOW_other_commands_in_pn87_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_def_start_in_proc_definitions99 */ +static ANTLR3_BITWORD FOLLOW_def_start_in_proc_definitions99_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_def_start_in_proc_definitions99 = { FOLLOW_def_start_in_proc_definitions99_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_trans_defs_in_proc_definitions101 */ +static ANTLR3_BITWORD FOLLOW_trans_defs_in_proc_definitions101_bits[] = { ANTLR3_UINT64_LIT(0x0000200000200468) }; +static ANTLR3_BITSET_LIST FOLLOW_trans_defs_in_proc_definitions101 = { FOLLOW_trans_defs_in_proc_definitions101_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_select_functions_in_proc_definitions104 */ +static ANTLR3_BITWORD FOLLOW_select_functions_in_proc_definitions104_bits[] = { ANTLR3_UINT64_LIT(0x0000200000200008) }; +static ANTLR3_BITSET_LIST FOLLOW_select_functions_in_proc_definitions104 = { FOLLOW_select_functions_in_proc_definitions104_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_nondeterm_in_proc_definitions107 */ +static ANTLR3_BITWORD FOLLOW_nondeterm_in_proc_definitions107_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_nondeterm_in_proc_definitions107 = { FOLLOW_nondeterm_in_proc_definitions107_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_def_start118 */ +static ANTLR3_BITWORD FOLLOW_ID_in_def_start118_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_def_start118 = { FOLLOW_ID_in_def_start118_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_extern_trans_def_in_trans_defs126 */ +static ANTLR3_BITWORD FOLLOW_extern_trans_def_in_trans_defs126_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_extern_trans_def_in_trans_defs126 = { FOLLOW_extern_trans_def_in_trans_defs126_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_trans_def_in_trans_defs131 */ +static ANTLR3_BITWORD FOLLOW_trans_def_in_trans_defs131_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_trans_def_in_trans_defs131 = { FOLLOW_trans_def_in_trans_defs131_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_set_in_extern_trans_def141 */ +static ANTLR3_BITWORD FOLLOW_set_in_extern_trans_def141_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_set_in_extern_trans_def141 = { FOLLOW_set_in_extern_trans_def141_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_extern_trans_def149 */ +static ANTLR3_BITWORD FOLLOW_ID_in_extern_trans_def149_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_extern_trans_def149 = { FOLLOW_ID_in_extern_trans_def149_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def161 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def161_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def161 = { FOLLOW_ID_in_trans_def161_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def163 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def163_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def163 = { FOLLOW_CODE_BLOCK_in_trans_def163_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def170 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def170_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def170 = { FOLLOW_ID_in_trans_def170_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def172 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def172_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def172 = { FOLLOW_ID_in_trans_def172_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def175 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def175_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def175 = { FOLLOW_CODE_BLOCK_in_trans_def175_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def183 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def183_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def183 = { FOLLOW_ID_in_trans_def183_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def186 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def186_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def186 = { FOLLOW_ID_in_trans_def186_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def188 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def188_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def188 = { FOLLOW_ID_in_trans_def188_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def191 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def191_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def191 = { FOLLOW_CODE_BLOCK_in_trans_def191_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SELECT_DEF_in_select_functions203 */ +static ANTLR3_BITWORD FOLLOW_SELECT_DEF_in_select_functions203_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SELECT_DEF_in_select_functions203 = { FOLLOW_SELECT_DEF_in_select_functions203_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_select_functions205 */ +static ANTLR3_BITWORD FOLLOW_ID_in_select_functions205_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002000) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_select_functions205 = { FOLLOW_ID_in_select_functions205_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_select_functions207 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_select_functions207_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_select_functions207 = { FOLLOW_CODE_BLOCK_in_select_functions207_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_45_in_nondeterm218 */ +static ANTLR3_BITWORD FOLLOW_45_in_nondeterm218_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_45_in_nondeterm218 = { FOLLOW_45_in_nondeterm218_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_nondeterm220 */ +static ANTLR3_BITWORD FOLLOW_ID_in_nondeterm220_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_nondeterm220 = { FOLLOW_ID_in_nondeterm220_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_init_in_proc_instantiations232 */ +static ANTLR3_BITWORD FOLLOW_proc_init_in_proc_instantiations232_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_init_in_proc_instantiations232 = { FOLLOW_proc_init_in_proc_instantiations232_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_sync_def_in_proc_instantiations236 */ +static ANTLR3_BITWORD FOLLOW_sync_def_in_proc_instantiations236_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_sync_def_in_proc_instantiations236 = { FOLLOW_sync_def_in_proc_instantiations236_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_start_in_proc_instantiations240 */ +static ANTLR3_BITWORD FOLLOW_proc_start_in_proc_instantiations240_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_start_in_proc_instantiations240 = { FOLLOW_proc_start_in_proc_instantiations240_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init250 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_init250_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init250 = { FOLLOW_ID_in_proc_init250_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_numbered_ID_in_proc_init252 */ +static ANTLR3_BITWORD FOLLOW_numbered_ID_in_proc_init252_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_numbered_ID_in_proc_init252 = { FOLLOW_numbered_ID_in_proc_init252_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SYNC_TOK_in_sync_def264 */ +static ANTLR3_BITWORD FOLLOW_SYNC_TOK_in_sync_def264_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SYNC_TOK_in_sync_def264 = { FOLLOW_SYNC_TOK_in_sync_def264_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_sync_def266 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def266_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_sync_def266 = { FOLLOW_group_elements_in_sync_def266_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start278 */ +static ANTLR3_BITWORD FOLLOW_START_in_proc_start278_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start278 = { FOLLOW_START_in_proc_start278_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start280 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_start280_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start280 = { FOLLOW_ID_in_proc_start280_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints297 */ +static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints297_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints297 = { FOLLOW_constraint_block_in_constraints297_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints302 */ +static ANTLR3_BITWORD FOLLOW_eq_in_constraints302_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints302 = { FOLLOW_eq_in_constraints302_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints308 */ +static ANTLR3_BITWORD FOLLOW_live_def_in_constraints308_bits[] = { ANTLR3_UINT64_LIT(0x0000000300000008) }; +static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints308 = { FOLLOW_live_def_in_constraints308_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints311 */ +static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints311_bits[] = { ANTLR3_UINT64_LIT(0x0000000200000008) }; +static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints311 = { FOLLOW_uncontrol_in_constraints311_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints314 */ +static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints314_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints314 = { FOLLOW_unobserve_in_constraints314_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block324 */ +static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block324_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block324 = { FOLLOW_ID_in_constraint_block324_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq333 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq333_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq333 = { FOLLOW_relationalExpression_in_eq333_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq339 */ +static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq339_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq339 = { FOLLOW_EQS_OP_in_eq339_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq341 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq341_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq341 = { FOLLOW_eq_in_eq341_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq343 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq343_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq343 = { FOLLOW_eq_in_eq343_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression365 */ +static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression365_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression365 = { FOLLOW_EQ_OP_in_relationalExpression365_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression368 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression368_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression368 = { FOLLOW_relationalExpression_in_relationalExpression368_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression370 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression370_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression370 = { FOLLOW_additiveExpression_in_relationalExpression370_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression376 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression376_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression376 = { FOLLOW_relationalExpression_in_relationalExpression376_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression378 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression378_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression378 = { FOLLOW_additiveExpression_in_relationalExpression378_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression400 */ +static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression400_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression400 = { FOLLOW_primary_in_additiveExpression400_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_PLUS_in_additiveExpression410 */ +static ANTLR3_BITWORD FOLLOW_PLUS_in_additiveExpression410_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_PLUS_in_additiveExpression410 = { FOLLOW_PLUS_in_additiveExpression410_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression414 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression414_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression414 = { FOLLOW_additiveExpression_in_additiveExpression414_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression431 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression431_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression431 = { FOLLOW_additiveExpression_in_additiveExpression431_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_additiveExpression481 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_additiveExpression481_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_additiveExpression481 = { FOLLOW_MINUS_in_additiveExpression481_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression485 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression485_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression485 = { FOLLOW_additiveExpression_in_additiveExpression485_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression501 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression501_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression501 = { FOLLOW_additiveExpression_in_additiveExpression501_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_primary562 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_primary562_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_primary562 = { FOLLOW_MINUS_in_primary562_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary566 */ +static ANTLR3_BITWORD FOLLOW_eq_in_primary566_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary566 = { FOLLOW_eq_in_primary566_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary581 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_primary581_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary581 = { FOLLOW_group_elements_in_primary581_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary622 */ +static ANTLR3_BITWORD FOLLOW_number_in_primary622_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_primary622 = { FOLLOW_number_in_primary622_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary633 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_primary633_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary633 = { FOLLOW_MULT_in_primary633_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary635 */ +static ANTLR3_BITWORD FOLLOW_number_in_primary635_bits[] = { ANTLR3_UINT64_LIT(0x0000000021040088) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_primary635 = { FOLLOW_number_in_primary635_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary637 */ +static ANTLR3_BITWORD FOLLOW_primary_in_primary637_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary637 = { FOLLOW_primary_in_primary637_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary672 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_primary672_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary672 = { FOLLOW_MULT_in_primary672_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary674 */ +static ANTLR3_BITWORD FOLLOW_number_in_primary674_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_primary674 = { FOLLOW_number_in_primary674_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary678 */ +static ANTLR3_BITWORD FOLLOW_eq_in_primary678_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary678 = { FOLLOW_eq_in_primary678_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def702 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def702_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def702 = { FOLLOW_LIVE_in_live_def702_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def704 */ +static ANTLR3_BITWORD FOLLOW_ALL_in_live_def704_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def704 = { FOLLOW_ALL_in_live_def704_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def706 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def706_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def706 = { FOLLOW_ID_in_live_def706_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def714 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def714_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def714 = { FOLLOW_LIVE_in_live_def714_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def716 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def716_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def716 = { FOLLOW_ID_in_live_def716_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol728 */ +static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol728_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol728 = { FOLLOW_UNCONTROL_in_uncontrol728_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol730 */ +static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol730_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol730 = { FOLLOW_ID_in_uncontrol730_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve742 */ +static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve742_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve742 = { FOLLOW_UNOBSERVE_in_unobserve742_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve744 */ +static ANTLR3_BITWORD FOLLOW_ID_in_unobserve744_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve744 = { FOLLOW_ID_in_unobserve744_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands756 */ +static ANTLR3_BITWORD FOLLOW_print_in_other_commands756_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands756 = { FOLLOW_print_in_other_commands756_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print766 */ +static ANTLR3_BITWORD FOLLOW_PRINT_in_print766_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print766 = { FOLLOW_PRINT_in_print766_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print768 */ +static ANTLR3_BITWORD FOLLOW_ID_in_print768_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_print768 = { FOLLOW_ID_in_print768_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print770 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_print770_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print770 = { FOLLOW_group_elements_in_print770_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number789 */ +static ANTLR3_BITWORD FOLLOW_INT_in_number789_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_number789 = { FOLLOW_INT_in_number789_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_number802 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_number802_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_number802 = { FOLLOW_MINUS_in_number802_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number804 */ +static ANTLR3_BITWORD FOLLOW_INT_in_number804_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_number804 = { FOLLOW_INT_in_number804_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_GROUP_in_group_elements822 */ +static ANTLR3_BITWORD FOLLOW_GROUP_in_group_elements822_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_GROUP_in_group_elements822 = { FOLLOW_GROUP_in_group_elements822_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements824 */ +static ANTLR3_BITWORD FOLLOW_ID_in_group_elements824_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements824 = { FOLLOW_ID_in_group_elements824_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID835 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID835_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numb... [truncated message content] |
From: <the...@us...> - 2009-06-19 20:57:39
|
Revision: 82 http://pntool.svn.sourceforge.net/pntool/?rev=82&view=rev Author: thecodeweasel Date: 2009-06-19 20:57:36 +0000 (Fri, 19 Jun 2009) Log Message: ----------- No more backtracking! Modified Paths: -------------- translator/pncompactor.c translator/pncompactor.g translator/pncompactor.h Modified: translator/pncompactor.c =================================================================== --- translator/pncompactor.c 2009-06-19 20:41:23 UTC (rev 81) +++ translator/pncompactor.c 2009-06-19 20:57:36 UTC (rev 82) @@ -2,7 +2,7 @@ * This C source file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pncompactor.g - * - On : 2009-06-19 00:34:50 + * - On : 2009-06-19 15:56:07 * - for the tree parser : pncompactorTreeParser * * Editing it, at least manually, is not wise. * @@ -387,10 +387,6 @@ static pncompactor_number_return number (ppncompactor ctx); static pncompactor_group_elements_return group_elements (ppncompactor ctx); static pncompactor_numbered_ID_return numbered_ID (ppncompactor ctx); -static ANTLR3_BOOLEAN synpred29_pncompactor (ppncompactor ctx); -static ANTLR3_BOOLEAN synpred31_pncompactor (ppncompactor ctx); -static ANTLR3_BOOLEAN synpred33_pncompactor (ppncompactor ctx); -static ANTLR3_BOOLEAN synpred34_pncompactor (ppncompactor ctx); static void pncompactorFree(ppncompactor ctx); /* For use in tree output where we are accumulating rule labels via label += ruleRef * we need a function that knows how to free a return scope when the list is destroyed. @@ -487,10 +483,6 @@ ctx->number = number; ctx->group_elements = group_elements; ctx->numbered_ID = numbered_ID; - ctx->synpred29_pncompactor = synpred29_pncompactor; - ctx->synpred31_pncompactor = synpred31_pncompactor; - ctx->synpred33_pncompactor = synpred33_pncompactor; - ctx->synpred34_pncompactor = synpred34_pncompactor; ctx->free = pncompactorFree; ctx->getGrammarFileName = getGrammarFileName; @@ -557,301 +549,385 @@ /* Declare the bitsets */ -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_definitions_in_pn87 */ -static ANTLR3_BITWORD FOLLOW_proc_definitions_in_pn87_bits[] = { ANTLR3_UINT64_LIT(0x0000000000C00400) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_definitions_in_pn87 = { FOLLOW_proc_definitions_in_pn87_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_pn90 */ -static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_pn90_bits[] = { ANTLR3_UINT64_LIT(0x0000000400C00402) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_pn90 = { FOLLOW_proc_instantiations_in_pn90_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraints_in_pn93 */ -static ANTLR3_BITWORD FOLLOW_constraints_in_pn93_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000402) }; -static ANTLR3_BITSET_LIST FOLLOW_constraints_in_pn93 = { FOLLOW_constraints_in_pn93_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_other_commands_in_pn96 */ -static ANTLR3_BITWORD FOLLOW_other_commands_in_pn96_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000002) }; -static ANTLR3_BITSET_LIST FOLLOW_other_commands_in_pn96 = { FOLLOW_other_commands_in_pn96_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_def_start_in_proc_definitions108 */ -static ANTLR3_BITWORD FOLLOW_def_start_in_proc_definitions108_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_def_start_in_proc_definitions108 = { FOLLOW_def_start_in_proc_definitions108_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_trans_defs_in_proc_definitions110 */ -static ANTLR3_BITWORD FOLLOW_trans_defs_in_proc_definitions110_bits[] = { ANTLR3_UINT64_LIT(0x0000200000200468) }; -static ANTLR3_BITSET_LIST FOLLOW_trans_defs_in_proc_definitions110 = { FOLLOW_trans_defs_in_proc_definitions110_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_select_functions_in_proc_definitions113 */ -static ANTLR3_BITWORD FOLLOW_select_functions_in_proc_definitions113_bits[] = { ANTLR3_UINT64_LIT(0x0000200000200008) }; -static ANTLR3_BITSET_LIST FOLLOW_select_functions_in_proc_definitions113 = { FOLLOW_select_functions_in_proc_definitions113_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_nondeterm_in_proc_definitions116 */ -static ANTLR3_BITWORD FOLLOW_nondeterm_in_proc_definitions116_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_nondeterm_in_proc_definitions116 = { FOLLOW_nondeterm_in_proc_definitions116_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_def_start127 */ -static ANTLR3_BITWORD FOLLOW_ID_in_def_start127_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_def_start127 = { FOLLOW_ID_in_def_start127_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_extern_trans_def_in_trans_defs135 */ -static ANTLR3_BITWORD FOLLOW_extern_trans_def_in_trans_defs135_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_extern_trans_def_in_trans_defs135 = { FOLLOW_extern_trans_def_in_trans_defs135_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_trans_def_in_trans_defs140 */ -static ANTLR3_BITWORD FOLLOW_trans_def_in_trans_defs140_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_trans_def_in_trans_defs140 = { FOLLOW_trans_def_in_trans_defs140_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_set_in_extern_trans_def150 */ -static ANTLR3_BITWORD FOLLOW_set_in_extern_trans_def150_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_set_in_extern_trans_def150 = { FOLLOW_set_in_extern_trans_def150_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_extern_trans_def158 */ -static ANTLR3_BITWORD FOLLOW_ID_in_extern_trans_def158_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_extern_trans_def158 = { FOLLOW_ID_in_extern_trans_def158_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def170 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def170_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def170 = { FOLLOW_ID_in_trans_def170_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def172 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def172_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def172 = { FOLLOW_CODE_BLOCK_in_trans_def172_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def179 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def179_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def179 = { FOLLOW_ID_in_trans_def179_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def181 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def181_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def181 = { FOLLOW_ID_in_trans_def181_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def184 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def184_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def184 = { FOLLOW_CODE_BLOCK_in_trans_def184_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def192 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def192_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def192 = { FOLLOW_ID_in_trans_def192_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def195 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def195_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def195 = { FOLLOW_ID_in_trans_def195_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def197 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def197_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def197 = { FOLLOW_ID_in_trans_def197_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def200 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def200_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def200 = { FOLLOW_CODE_BLOCK_in_trans_def200_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SELECT_DEF_in_select_functions212 */ -static ANTLR3_BITWORD FOLLOW_SELECT_DEF_in_select_functions212_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SELECT_DEF_in_select_functions212 = { FOLLOW_SELECT_DEF_in_select_functions212_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_select_functions214 */ -static ANTLR3_BITWORD FOLLOW_ID_in_select_functions214_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002000) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_select_functions214 = { FOLLOW_ID_in_select_functions214_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_select_functions216 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_select_functions216_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_select_functions216 = { FOLLOW_CODE_BLOCK_in_select_functions216_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_45_in_nondeterm227 */ -static ANTLR3_BITWORD FOLLOW_45_in_nondeterm227_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_45_in_nondeterm227 = { FOLLOW_45_in_nondeterm227_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_nondeterm229 */ -static ANTLR3_BITWORD FOLLOW_ID_in_nondeterm229_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_nondeterm229 = { FOLLOW_ID_in_nondeterm229_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_init_in_proc_instantiations241 */ -static ANTLR3_BITWORD FOLLOW_proc_init_in_proc_instantiations241_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_init_in_proc_instantiations241 = { FOLLOW_proc_init_in_proc_instantiations241_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_sync_def_in_proc_instantiations245 */ -static ANTLR3_BITWORD FOLLOW_sync_def_in_proc_instantiations245_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_sync_def_in_proc_instantiations245 = { FOLLOW_sync_def_in_proc_instantiations245_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_start_in_proc_instantiations249 */ -static ANTLR3_BITWORD FOLLOW_proc_start_in_proc_instantiations249_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_start_in_proc_instantiations249 = { FOLLOW_proc_start_in_proc_instantiations249_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init259 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_init259_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init259 = { FOLLOW_ID_in_proc_init259_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_numbered_ID_in_proc_init261 */ -static ANTLR3_BITWORD FOLLOW_numbered_ID_in_proc_init261_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_numbered_ID_in_proc_init261 = { FOLLOW_numbered_ID_in_proc_init261_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SYNC_TOK_in_sync_def273 */ -static ANTLR3_BITWORD FOLLOW_SYNC_TOK_in_sync_def273_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SYNC_TOK_in_sync_def273 = { FOLLOW_SYNC_TOK_in_sync_def273_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_sync_def275 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def275_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_sync_def275 = { FOLLOW_group_elements_in_sync_def275_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start287 */ -static ANTLR3_BITWORD FOLLOW_START_in_proc_start287_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start287 = { FOLLOW_START_in_proc_start287_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start289 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_start289_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start289 = { FOLLOW_ID_in_proc_start289_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints306 */ -static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints306_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints306 = { FOLLOW_constraint_block_in_constraints306_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints311 */ -static ANTLR3_BITWORD FOLLOW_eq_in_constraints311_bits[] = { ANTLR3_UINT64_LIT(0x000000037D040088) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints311 = { FOLLOW_eq_in_constraints311_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints317 */ -static ANTLR3_BITWORD FOLLOW_live_def_in_constraints317_bits[] = { ANTLR3_UINT64_LIT(0x0000000300000008) }; -static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints317 = { FOLLOW_live_def_in_constraints317_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints320 */ -static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints320_bits[] = { ANTLR3_UINT64_LIT(0x0000000200000008) }; -static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints320 = { FOLLOW_uncontrol_in_constraints320_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints323 */ -static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints323_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints323 = { FOLLOW_unobserve_in_constraints323_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block333 */ -static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block333_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block333 = { FOLLOW_ID_in_constraint_block333_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq342 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq342_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq342 = { FOLLOW_relationalExpression_in_eq342_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq348 */ -static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq348_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq348 = { FOLLOW_EQS_OP_in_eq348_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq350 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq350_bits[] = { ANTLR3_UINT64_LIT(0x000000037D040088) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq350 = { FOLLOW_eq_in_eq350_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq352 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq352_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq352 = { FOLLOW_eq_in_eq352_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_definitions_in_pn79 */ +static ANTLR3_BITWORD FOLLOW_proc_definitions_in_pn79_bits[] = { ANTLR3_UINT64_LIT(0x0000000000C00400) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_definitions_in_pn79 = { FOLLOW_proc_definitions_in_pn79_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_pn82 */ +static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_pn82_bits[] = { ANTLR3_UINT64_LIT(0x0000000400C00402) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_pn82 = { FOLLOW_proc_instantiations_in_pn82_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraints_in_pn85 */ +static ANTLR3_BITWORD FOLLOW_constraints_in_pn85_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000402) }; +static ANTLR3_BITSET_LIST FOLLOW_constraints_in_pn85 = { FOLLOW_constraints_in_pn85_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_other_commands_in_pn88 */ +static ANTLR3_BITWORD FOLLOW_other_commands_in_pn88_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000002) }; +static ANTLR3_BITSET_LIST FOLLOW_other_commands_in_pn88 = { FOLLOW_other_commands_in_pn88_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_def_start_in_proc_definitions100 */ +static ANTLR3_BITWORD FOLLOW_def_start_in_proc_definitions100_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_def_start_in_proc_definitions100 = { FOLLOW_def_start_in_proc_definitions100_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_trans_defs_in_proc_definitions102 */ +static ANTLR3_BITWORD FOLLOW_trans_defs_in_proc_definitions102_bits[] = { ANTLR3_UINT64_LIT(0x0000200000200468) }; +static ANTLR3_BITSET_LIST FOLLOW_trans_defs_in_proc_definitions102 = { FOLLOW_trans_defs_in_proc_definitions102_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_select_functions_in_proc_definitions105 */ +static ANTLR3_BITWORD FOLLOW_select_functions_in_proc_definitions105_bits[] = { ANTLR3_UINT64_LIT(0x0000200000200008) }; +static ANTLR3_BITSET_LIST FOLLOW_select_functions_in_proc_definitions105 = { FOLLOW_select_functions_in_proc_definitions105_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_nondeterm_in_proc_definitions108 */ +static ANTLR3_BITWORD FOLLOW_nondeterm_in_proc_definitions108_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_nondeterm_in_proc_definitions108 = { FOLLOW_nondeterm_in_proc_definitions108_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_def_start119 */ +static ANTLR3_BITWORD FOLLOW_ID_in_def_start119_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_def_start119 = { FOLLOW_ID_in_def_start119_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_extern_trans_def_in_trans_defs127 */ +static ANTLR3_BITWORD FOLLOW_extern_trans_def_in_trans_defs127_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_extern_trans_def_in_trans_defs127 = { FOLLOW_extern_trans_def_in_trans_defs127_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_trans_def_in_trans_defs132 */ +static ANTLR3_BITWORD FOLLOW_trans_def_in_trans_defs132_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_trans_def_in_trans_defs132 = { FOLLOW_trans_def_in_trans_defs132_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_set_in_extern_trans_def142 */ +static ANTLR3_BITWORD FOLLOW_set_in_extern_trans_def142_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_set_in_extern_trans_def142 = { FOLLOW_set_in_extern_trans_def142_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_extern_trans_def150 */ +static ANTLR3_BITWORD FOLLOW_ID_in_extern_trans_def150_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_extern_trans_def150 = { FOLLOW_ID_in_extern_trans_def150_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def162 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def162_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def162 = { FOLLOW_ID_in_trans_def162_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def164 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def164_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def164 = { FOLLOW_CODE_BLOCK_in_trans_def164_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def171 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def171_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def171 = { FOLLOW_ID_in_trans_def171_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def173 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def173_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def173 = { FOLLOW_ID_in_trans_def173_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def176 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def176_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def176 = { FOLLOW_CODE_BLOCK_in_trans_def176_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def184 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def184_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def184 = { FOLLOW_ID_in_trans_def184_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def187 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def187_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def187 = { FOLLOW_ID_in_trans_def187_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def189 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def189_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def189 = { FOLLOW_ID_in_trans_def189_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def192 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def192_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def192 = { FOLLOW_CODE_BLOCK_in_trans_def192_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SELECT_DEF_in_select_functions204 */ +static ANTLR3_BITWORD FOLLOW_SELECT_DEF_in_select_functions204_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SELECT_DEF_in_select_functions204 = { FOLLOW_SELECT_DEF_in_select_functions204_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_select_functions206 */ +static ANTLR3_BITWORD FOLLOW_ID_in_select_functions206_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002000) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_select_functions206 = { FOLLOW_ID_in_select_functions206_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_select_functions208 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_select_functions208_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_select_functions208 = { FOLLOW_CODE_BLOCK_in_select_functions208_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_45_in_nondeterm219 */ +static ANTLR3_BITWORD FOLLOW_45_in_nondeterm219_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_45_in_nondeterm219 = { FOLLOW_45_in_nondeterm219_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_nondeterm221 */ +static ANTLR3_BITWORD FOLLOW_ID_in_nondeterm221_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_nondeterm221 = { FOLLOW_ID_in_nondeterm221_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_init_in_proc_instantiations233 */ +static ANTLR3_BITWORD FOLLOW_proc_init_in_proc_instantiations233_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_init_in_proc_instantiations233 = { FOLLOW_proc_init_in_proc_instantiations233_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_sync_def_in_proc_instantiations237 */ +static ANTLR3_BITWORD FOLLOW_sync_def_in_proc_instantiations237_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_sync_def_in_proc_instantiations237 = { FOLLOW_sync_def_in_proc_instantiations237_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_start_in_proc_instantiations241 */ +static ANTLR3_BITWORD FOLLOW_proc_start_in_proc_instantiations241_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_start_in_proc_instantiations241 = { FOLLOW_proc_start_in_proc_instantiations241_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init251 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_init251_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init251 = { FOLLOW_ID_in_proc_init251_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_numbered_ID_in_proc_init253 */ +static ANTLR3_BITWORD FOLLOW_numbered_ID_in_proc_init253_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_numbered_ID_in_proc_init253 = { FOLLOW_numbered_ID_in_proc_init253_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SYNC_TOK_in_sync_def265 */ +static ANTLR3_BITWORD FOLLOW_SYNC_TOK_in_sync_def265_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SYNC_TOK_in_sync_def265 = { FOLLOW_SYNC_TOK_in_sync_def265_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_sync_def267 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def267_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_sync_def267 = { FOLLOW_group_elements_in_sync_def267_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start279 */ +static ANTLR3_BITWORD FOLLOW_START_in_proc_start279_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start279 = { FOLLOW_START_in_proc_start279_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start281 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_start281_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start281 = { FOLLOW_ID_in_proc_start281_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints298 */ +static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints298_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints298 = { FOLLOW_constraint_block_in_constraints298_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints303 */ +static ANTLR3_BITWORD FOLLOW_eq_in_constraints303_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints303 = { FOLLOW_eq_in_constraints303_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints309 */ +static ANTLR3_BITWORD FOLLOW_live_def_in_constraints309_bits[] = { ANTLR3_UINT64_LIT(0x0000000300000008) }; +static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints309 = { FOLLOW_live_def_in_constraints309_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints312 */ +static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints312_bits[] = { ANTLR3_UINT64_LIT(0x0000000200000008) }; +static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints312 = { FOLLOW_uncontrol_in_constraints312_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints315 */ +static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints315_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints315 = { FOLLOW_unobserve_in_constraints315_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block325 */ +static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block325_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block325 = { FOLLOW_ID_in_constraint_block325_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq334 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq334_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq334 = { FOLLOW_relationalExpression_in_eq334_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq340 */ +static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq340_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq340 = { FOLLOW_EQS_OP_in_eq340_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq342 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq342_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq342 = { FOLLOW_eq_in_eq342_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq344 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq344_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq344 = { FOLLOW_eq_in_eq344_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression361 */ +static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression361_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression361 = { FOLLOW_EQ_OP_in_relationalExpression361_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression366 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression366_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression366 = { FOLLOW_relationalExpression_in_relationalExpression366_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression368 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression368_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression368_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression368 = { FOLLOW_additiveExpression_in_relationalExpression368_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression377 */ -static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression377_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression377 = { FOLLOW_EQ_OP_in_relationalExpression377_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression379 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression379_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression379 = { FOLLOW_relationalExpression_in_relationalExpression379_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression383 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression383_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression383 = { FOLLOW_relationalExpression_in_relationalExpression383_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression404 */ -static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression404_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression404 = { FOLLOW_primary_in_additiveExpression404_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_PLUS_in_additiveExpression414 */ -static ANTLR3_BITWORD FOLLOW_PLUS_in_additiveExpression414_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_PLUS_in_additiveExpression414 = { FOLLOW_PLUS_in_additiveExpression414_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression418 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression418_bits[] = { ANTLR3_UINT64_LIT(0x0000000031040088) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression418 = { FOLLOW_additiveExpression_in_additiveExpression418_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression435 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression435_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression435 = { FOLLOW_additiveExpression_in_additiveExpression435_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_additiveExpression485 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_additiveExpression485_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_additiveExpression485 = { FOLLOW_MINUS_in_additiveExpression485_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression489 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression489_bits[] = { ANTLR3_UINT64_LIT(0x0000000031040088) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression489 = { FOLLOW_additiveExpression_in_additiveExpression489_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression505 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression505_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression505 = { FOLLOW_additiveExpression_in_additiveExpression505_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_primary566 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_primary566_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_primary566 = { FOLLOW_MINUS_in_primary566_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary570 */ -static ANTLR3_BITWORD FOLLOW_eq_in_primary570_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary570 = { FOLLOW_eq_in_primary570_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary585 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_primary585_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary585 = { FOLLOW_group_elements_in_primary585_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary626 */ -static ANTLR3_BITWORD FOLLOW_number_in_primary626_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_primary626 = { FOLLOW_number_in_primary626_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary635 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_primary635_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary635 = { FOLLOW_MULT_in_primary635_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary637 */ -static ANTLR3_BITWORD FOLLOW_number_in_primary637_bits[] = { ANTLR3_UINT64_LIT(0x0000000021040088) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_primary637 = { FOLLOW_number_in_primary637_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary639 */ -static ANTLR3_BITWORD FOLLOW_primary_in_primary639_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary639 = { FOLLOW_primary_in_primary639_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary674 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_primary674_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary674 = { FOLLOW_MULT_in_primary674_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary676 */ -static ANTLR3_BITWORD FOLLOW_number_in_primary676_bits[] = { ANTLR3_UINT64_LIT(0x000000037D040088) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_primary676 = { FOLLOW_number_in_primary676_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary680 */ -static ANTLR3_BITWORD FOLLOW_eq_in_primary680_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary680 = { FOLLOW_eq_in_primary680_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def704 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def704_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def704 = { FOLLOW_LIVE_in_live_def704_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def706 */ -static ANTLR3_BITWORD FOLLOW_ALL_in_live_def706_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def706 = { FOLLOW_ALL_in_live_def706_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def708 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def708_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def708 = { FOLLOW_ID_in_live_def708_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def716 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def716_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def716 = { FOLLOW_LIVE_in_live_def716_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def718 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def718_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def718 = { FOLLOW_ID_in_live_def718_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol730 */ -static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol730_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol730 = { FOLLOW_UNCONTROL_in_uncontrol730_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol732 */ -static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol732_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol732 = { FOLLOW_ID_in_uncontrol732_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve744 */ -static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve744_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve744 = { FOLLOW_UNOBSERVE_in_unobserve744_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve746 */ -static ANTLR3_BITWORD FOLLOW_ID_in_unobserve746_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve746 = { FOLLOW_ID_in_unobserve746_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands758 */ -static ANTLR3_BITWORD FOLLOW_print_in_other_commands758_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands758 = { FOLLOW_print_in_other_commands758_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print768 */ -static ANTLR3_BITWORD FOLLOW_PRINT_in_print768_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print768 = { FOLLOW_PRINT_in_print768_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print770 */ -static ANTLR3_BITWORD FOLLOW_ID_in_print770_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_print770 = { FOLLOW_ID_in_print770_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print772 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_print772_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print772 = { FOLLOW_group_elements_in_print772_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number791 */ -static ANTLR3_BITWORD FOLLOW_INT_in_number791_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_number791 = { FOLLOW_INT_in_number791_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_number804 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_number804_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_number804 = { FOLLOW_MINUS_in_number804_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number806 */ -static ANTLR3_BITWORD FOLLOW_INT_in_number806_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_number806 = { FOLLOW_INT_in_number806_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_GROUP_in_group_elements824 */ -static ANTLR3_BITWORD FOLLOW_GROUP_in_group_elements824_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_GROUP_in_group_elements824 = { FOLLOW_GROUP_in_group_elements824_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements826 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements826_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements826 = { FOLLOW_ID_in_group_elements826_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID837 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID837_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID837 = { FOLLOW_ID_in_numbered_ID837_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID843 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID843_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID843 = { FOLLOW_ID_in_numbered_ID843_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID845 */ -static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID845_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID845 = { FOLLOW_INT_in_numbered_ID845_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred29_pncompactor404 */ -static ANTLR3_BITWORD FOLLOW_primary_in_synpred29_pncompactor404_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred29_pncompactor404 = { FOLLOW_primary_in_synpred29_pncompactor404_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_synpred31_pncompactor566 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_synpred31_pncompactor566_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_synpred31_pncompactor566 = { FOLLOW_MINUS_in_synpred31_pncompactor566_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_synpred31_pncompactor570 */ -static ANTLR3_BITWORD FOLLOW_eq_in_synpred31_pncompactor570_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_synpred31_pncompactor570 = { FOLLOW_eq_in_synpred31_pncompactor570_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_synpred33_pncompactor626 */ -static ANTLR3_BITWORD FOLLOW_number_in_synpred33_pncompactor626_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_synpred33_pncompactor626 = { FOLLOW_number_in_synpred33_pncompactor626_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_synpred34_pncompactor635 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_synpred34_pncompactor635_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_synpred34_pncompactor635 = { FOLLOW_MULT_in_synpred34_pncompactor635_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_synpred34_pncompactor637 */ -static ANTLR3_BITWORD FOLLOW_number_in_synpred34_pncompactor637_bits[] = { ANTLR3_UINT64_LIT(0x0000000021040088) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_synpred34_pncompactor637 = { FOLLOW_number_in_synpred34_pncompactor637_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred34_pncompactor639 */ -static ANTLR3_BITWORD FOLLOW_primary_in_synpred34_pncompactor639_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred34_pncompactor639 = { FOLLOW_primary_in_synpred34_pncompactor639_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression374 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression374_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression374 = { FOLLOW_relationalExpression_in_relationalExpression374_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression376 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression376_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression376 = { FOLLOW_additiveExpression_in_relationalExpression376_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression398 */ +static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression398_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression398 = { FOLLOW_primary_in_additiveExpression398_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_PLUS_in_additiveExpression408 */ +static ANTLR3_BITWORD FOLLOW_PLUS_in_additiveExpression408_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_PLUS_in_additiveExpression408 = { FOLLOW_PLUS_in_additiveExpression408_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression412 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression412_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression412 = { FOLLOW_additiveExpression_in_additiveExpression412_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression429 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression429_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression429 = { FOLLOW_additiveExpression_in_additiveExpression429_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_additiveExpression479 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_additiveExpression479_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_additiveExpression479 = { FOLLOW_MINUS_in_additiveExpression479_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression483 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression483_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression483 = { FOLLOW_additiveExpression_in_additiveExpression483_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression499 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression499_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression499 = { FOLLOW_additiveExpression_in_additiveExpression499_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_primary560 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_primary560_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_primary560 = { FOLLOW_MINUS_in_primary560_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary564 */ +static ANTLR3_BITWORD FOLLOW_eq_in_primary564_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary564 = { FOLLOW_eq_in_primary564_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary579 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_primary579_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary579 = { FOLLOW_group_elements_in_primary579_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary620 */ +static ANTLR3_BITWORD FOLLOW_number_in_primary620_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_primary620 = { FOLLOW_number_in_primary620_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary631 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_primary631_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary631 = { FOLLOW_MULT_in_primary631_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary633 */ +static ANTLR3_BITWORD FOLLOW_number_in_primary633_bits[] = { ANTLR3_UINT64_LIT(0x0000000021040088) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_primary633 = { FOLLOW_number_in_primary633_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary635 */ +static ANTLR3_BITWORD FOLLOW_primary_in_primary635_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary635 = { FOLLOW_primary_in_primary635_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary670 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_primary670_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary670 = { FOLLOW_MULT_in_primary670_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary672 */ +static ANTLR3_BITWORD FOLLOW_number_in_primary672_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_primary672 = { FOLLOW_number_in_primary672_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary676 */ +static ANTLR3_BITWORD FOLLOW_eq_in_primary676_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary676 = { FOLLOW_eq_in_primary676_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def700 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def700_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def700 = { FOLLOW_LIVE_in_live_def700_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def702 */ +static ANTLR3_BITWORD FOLLOW_ALL_in_live_def702_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def702 = { FOLLOW_ALL_in_live_def702_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def704 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def704_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def704 = { FOLLOW_ID_in_live_def704_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def712 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def712_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def712 = { FOLLOW_LIVE_in_live_def712_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def714 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def714_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def714 = { FOLLOW_ID_in_live_def714_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol726 */ +static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol726_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol726 = { FOLLOW_UNCONTROL_in_uncontrol726_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol728 */ +static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol728_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol728 = { FOLLOW_ID_in_uncontrol728_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve740 */ +static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve740_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve740 = { FOLLOW_UNOBSERVE_in_unobserve740_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve742 */ +static ANTLR3_BITWORD FOLLOW_ID_in_unobserve742_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve742 = { FOLLOW_ID_in_unobserve742_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands754 */ +static ANTLR3_BITWORD FOLLOW_print_in_other_commands754_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands754 = { FOLLOW_print_in_other_commands754_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print764 */ +static ANTLR3_BITWORD FOLLOW_PRINT_in_print764_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print764 = { FOLLOW_PRINT_in_print764_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print766 */ +static ANTLR3_BITWORD FOLLOW_ID_in_print766_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_print766 = { FOLLOW_ID_in_print766_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print768 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_print768_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print768 = { FOLLOW_group_elements_in_print768_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number787 */ +static ANTLR3_BITWORD FOLLOW_INT_in_number787_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_number787 = { FOLLOW_INT_in_number787_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_number800 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_number800_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_number800 = { FOLLOW_MINUS_in_number800_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number802 */ +static ANTLR3_BITWORD FOLLOW_INT_in_number802_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_number802 = { FOLLOW_INT_in_number802_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_GROUP_in_group_elements820 */ +static ANTLR3_BITWORD FOLLOW_GROUP_in_group_elements820_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_GROUP_in_group_elements820 = { FOLLOW_GROUP_in_group_elements820_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements822 */ +static ANTLR3_BITWORD FOLLOW_ID_in_group_elements822_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements822 = { FOLLOW_ID_in_group_elements822_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID833 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID833_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID833 = { FOLLOW_ID_in_numbered_ID833_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID839 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID839_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID839 = { FOLLOW_ID_in_numbered_ID839_bits, 1 }; ... [truncated message content] |
From: <the...@us...> - 2009-06-19 20:41:28
|
Revision: 81 http://pntool.svn.sourceforge.net/pntool/?rev=81&view=rev Author: thecodeweasel Date: 2009-06-19 20:41:23 +0000 (Fri, 19 Jun 2009) Log Message: ----------- Optimized the generator based on assumptions that can be made when the compactor completed. Updated test file for greater code coverage. Modified Paths: -------------- translator/docs/test.txt translator/pngenerator.c translator/pngenerator.g translator/pngenerator.h Modified: translator/docs/test.txt =================================================================== --- translator/docs/test.txt 2009-06-19 19:57:39 UTC (rev 80) +++ translator/docs/test.txt 2009-06-19 20:41:23 UTC (rev 81) @@ -69,7 +69,7 @@ //------------------------------------------------ w_group.constraints: pwr_1 <= 1; -pwr_2 <= 1; +pwr_2 < 2; live: all; //------------------------------------------------ global.constraints: Modified: translator/pngenerator.c =================================================================== --- translator/pngenerator.c 2009-06-19 19:57:39 UTC (rev 80) +++ translator/pngenerator.c 2009-06-19 20:41:23 UTC (rev 81) @@ -2,7 +2,7 @@ * This C source file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pngenerator.g - * - On : 2009-06-19 14:12:26 + * - On : 2009-06-19 15:39:38 * - for the tree parser : pngeneratorTreeParser * * Editing it, at least manually, is not wise. * @@ -535,9 +535,9 @@ // // If the user supplied the scope entries with a free function,then call it first // - if (SCOPE_TOP(proc_definitions)->free != NULL) + if (SCOPE_TOP(proc_definitions)>free != NULL) { - SCOPE_TOP(proc_definitions)->free(SCOPE_TOP(proc_definitions)); + SCOPE_TOP(proc_definitions)>->free(SCOPE_TOP(proc_definitions)); } // Now we decrement the scope's upper limit bound. We do not actually pop the scope as @@ -559,9 +559,9 @@ // // If the user supplied the scope entries with a free function,then call it first // - if (SCOPE_TOP(proc_instantiations)->free != NULL) + if (SCOPE_TOP(proc_instantiations)>free != NULL) { - SCOPE_TOP(proc_instantiations)->free(SCOPE_TOP(proc_instantiations)); + SCOPE_TOP(proc_instantiations)>->free(SCOPE_TOP(proc_instantiations)); } // Now we decrement the scope's upper limit bound. We do not actually pop the scope as @@ -583,9 +583,9 @@ // // If the user supplied the scope entries with a free function,then call it first // - if (SCOPE_TOP(constraints)->free != NULL) + if (SCOPE_TOP(constraints)>free != NULL) { - SCOPE_TOP(constraints)->free(SCOPE_TOP(constraints)); + SCOPE_TOP(constraints)>->free(SCOPE_TOP(constraints)); } // Now we decrement the scope's upper limit bound. We do not actually pop the scope as @@ -624,9 +624,6 @@ static void print (ppngenerator ctx); static pANTLR3_VECTOR group_elements (ppngenerator ctx); static int* numbered_ID (ppngenerator ctx, ASSOC_ARRAY* places); -static ANTLR3_BOOLEAN synpred2_pngenerator (ppngenerator ctx); -static ANTLR3_BOOLEAN synpred29_pngenerator (ppngenerator ctx); -static ANTLR3_BOOLEAN synpred30_pngenerator (ppngenerator ctx); static void pngeneratorFree(ppngenerator ctx); /* For use in tree output where we are accumulating rule labels via label += ruleRef * we need a function that knows how to free a return scope when the list is destroyed. @@ -722,9 +719,6 @@ ctx->print = print; ctx->group_elements = group_elements; ctx->numbered_ID = numbered_ID; - ctx->synpred2_pngenerator = synpred2_pngenerator; - ctx->synpred29_pngenerator = synpred29_pngenerator; - ctx->synpred30_pngenerator = synpred30_pngenerator; ctx->free = pngeneratorFree; ctx->getGrammarFileName = getGrammarFileName; @@ -843,441 +837,259 @@ /* Declare the bitsets */ -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_definitions_in_pn75 */ -static ANTLR3_BITWORD FOLLOW_proc_definitions_in_pn75_bits[] = { ANTLR3_UINT64_LIT(0x0000000000C00400) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_definitions_in_pn75 = { FOLLOW_proc_definitions_in_pn75_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_pn78 */ -static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_pn78_bits[] = { ANTLR3_UINT64_LIT(0x0000000400C00402) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_pn78 = { FOLLOW_proc_instantiations_in_pn78_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraints_in_pn81 */ -static ANTLR3_BITWORD FOLLOW_constraints_in_pn81_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000402) }; -static ANTLR3_BITSET_LIST FOLLOW_constraints_in_pn81 = { FOLLOW_constraints_in_pn81_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_other_commands_in_pn84 */ -static ANTLR3_BITWORD FOLLOW_other_commands_in_pn84_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000002) }; -static ANTLR3_BITSET_LIST FOLLOW_other_commands_in_pn84 = { FOLLOW_other_commands_in_pn84_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_def_start_in_proc_definitions102 */ -static ANTLR3_BITWORD FOLLOW_def_start_in_proc_definitions102_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_def_start_in_proc_definitions102 = { FOLLOW_def_start_in_proc_definitions102_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_trans_defs_in_proc_definitions104 */ -static ANTLR3_BITWORD FOLLOW_trans_defs_in_proc_definitions104_bits[] = { ANTLR3_UINT64_LIT(0x0000200000200468) }; -static ANTLR3_BITSET_LIST FOLLOW_trans_defs_in_proc_definitions104 = { FOLLOW_trans_defs_in_proc_definitions104_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_select_functions_in_proc_definitions107 */ -static ANTLR3_BITWORD FOLLOW_select_functions_in_proc_definitions107_bits[] = { ANTLR3_UINT64_LIT(0x0000200000200008) }; -static ANTLR3_BITSET_LIST FOLLOW_select_functions_in_proc_definitions107 = { FOLLOW_select_functions_in_proc_definitions107_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_nondeterm_in_proc_definitions110 */ -static ANTLR3_BITWORD FOLLOW_nondeterm_in_proc_definitions110_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_nondeterm_in_proc_definitions110 = { FOLLOW_nondeterm_in_proc_definitions110_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_def_start126 */ -static ANTLR3_BITWORD FOLLOW_ID_in_def_start126_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_def_start126 = { FOLLOW_ID_in_def_start126_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_extern_trans_def_in_trans_defs136 */ -static ANTLR3_BITWORD FOLLOW_extern_trans_def_in_trans_defs136_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_extern_trans_def_in_trans_defs136 = { FOLLOW_extern_trans_def_in_trans_defs136_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_trans_def_in_trans_defs141 */ -static ANTLR3_BITWORD FOLLOW_trans_def_in_trans_defs141_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_trans_def_in_trans_defs141 = { FOLLOW_trans_def_in_trans_defs141_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_TO_in_extern_trans_def157 */ -static ANTLR3_BITWORD FOLLOW_TO_in_extern_trans_def157_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_TO_in_extern_trans_def157 = { FOLLOW_TO_in_extern_trans_def157_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_FROM_in_extern_trans_def163 */ -static ANTLR3_BITWORD FOLLOW_FROM_in_extern_trans_def163_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_FROM_in_extern_trans_def163 = { FOLLOW_FROM_in_extern_trans_def163_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_extern_trans_def169 */ -static ANTLR3_BITWORD FOLLOW_ID_in_extern_trans_def169_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_extern_trans_def169 = { FOLLOW_ID_in_extern_trans_def169_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def189 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def189_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def189 = { FOLLOW_ID_in_trans_def189_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def191 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def191_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def191 = { FOLLOW_CODE_BLOCK_in_trans_def191_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def205 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def205_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def205 = { FOLLOW_ID_in_trans_def205_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def212 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def212_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def212 = { FOLLOW_ID_in_trans_def212_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def221 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def221_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def221 = { FOLLOW_CODE_BLOCK_in_trans_def221_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def239 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def239_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def239 = { FOLLOW_ID_in_trans_def239_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def246 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def246_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def246 = { FOLLOW_ID_in_trans_def246_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def253 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def253_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def253 = { FOLLOW_ID_in_trans_def253_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def262 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def262_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def262 = { FOLLOW_CODE_BLOCK_in_trans_def262_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SELECT_DEF_in_select_functions279 */ -static ANTLR3_BITWORD FOLLOW_SELECT_DEF_in_select_functions279_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SELECT_DEF_in_select_functions279 = { FOLLOW_SELECT_DEF_in_select_functions279_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_select_functions281 */ -static ANTLR3_BITWORD FOLLOW_ID_in_select_functions281_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002000) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_select_functions281 = { FOLLOW_ID_in_select_functions281_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_select_functions283 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_select_functions283_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_select_functions283 = { FOLLOW_CODE_BLOCK_in_select_functions283_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_45_in_nondeterm296 */ -static ANTLR3_BITWORD FOLLOW_45_in_nondeterm296_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_45_in_nondeterm296 = { FOLLOW_45_in_nondeterm296_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_nondeterm299 */ -static ANTLR3_BITWORD FOLLOW_ID_in_nondeterm299_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_nondeterm299 = { FOLLOW_ID_in_nondeterm299_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_init_in_proc_instantiations318 */ -static ANTLR3_BITWORD FOLLOW_proc_init_in_proc_instantiations318_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_init_in_proc_instantiations318 = { FOLLOW_proc_init_in_proc_instantiations318_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_sync_def_in_proc_instantiations322 */ -static ANTLR3_BITWORD FOLLOW_sync_def_in_proc_instantiations322_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_sync_def_in_proc_instantiations322 = { FOLLOW_sync_def_in_proc_instantiations322_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_start_in_proc_instantiations326 */ -static ANTLR3_BITWORD FOLLOW_proc_start_in_proc_instantiations326_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_start_in_proc_instantiations326 = { FOLLOW_proc_start_in_proc_instantiations326_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init341 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_init341_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init341 = { FOLLOW_ID_in_proc_init341_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_numbered_ID_in_proc_init346 */ -static ANTLR3_BITWORD FOLLOW_numbered_ID_in_proc_init346_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_numbered_ID_in_proc_init346 = { FOLLOW_numbered_ID_in_proc_init346_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SYNC_TOK_in_sync_def369 */ -static ANTLR3_BITWORD FOLLOW_SYNC_TOK_in_sync_def369_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SYNC_TOK_in_sync_def369 = { FOLLOW_SYNC_TOK_in_sync_def369_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_sync_def372 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def372_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_sync_def372 = { FOLLOW_group_elements_in_sync_def372_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start389 */ -static ANTLR3_BITWORD FOLLOW_START_in_proc_start389_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start389 = { FOLLOW_START_in_proc_start389_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start392 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_start392_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start392 = { FOLLOW_ID_in_proc_start392_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints412 */ -static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints412_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints412 = { FOLLOW_constraint_block_in_constraints412_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints414 */ -static ANTLR3_BITWORD FOLLOW_eq_in_constraints414_bits[] = { ANTLR3_UINT64_LIT(0x000380034C040488) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints414 = { FOLLOW_eq_in_constraints414_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints417 */ -static ANTLR3_BITWORD FOLLOW_live_def_in_constraints417_bits[] = { ANTLR3_UINT64_LIT(0x0000000300000008) }; -static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints417 = { FOLLOW_live_def_in_constraints417_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints420 */ -static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints420_bits[] = { ANTLR3_UINT64_LIT(0x0000000200000008) }; -static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints420 = { FOLLOW_uncontrol_in_constraints420_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints423 */ -static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints423_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints423 = { FOLLOW_unobserve_in_constraints423_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block433 */ -static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block433_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block433 = { FOLLOW_ID_in_constraint_block433_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq445 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq445_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq445 = { FOLLOW_relationalExpression_in_eq445_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq451 */ -static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq451_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq451 = { FOLLOW_EQS_OP_in_eq451_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq453 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq453_bits[] = { ANTLR3_UINT64_LIT(0x000380034C040488) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq453 = { FOLLOW_eq_in_eq453_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq455 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq455_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq455 = { FOLLOW_eq_in_eq455_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression471 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression471_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression471 = { FOLLOW_additiveExpression_in_relationalExpression471_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression480 */ -static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression480_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression480 = { FOLLOW_EQ_OP_in_relationalExpression480_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression482 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression482_bits[] = { ANTLR3_UINT64_LIT(0x0003800008040488) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression482 = { FOLLOW_relationalExpression_in_relationalExpression482_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression484 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression484_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression484 = { FOLLOW_relationalExpression_in_relationalExpression484_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression500 */ -static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression500_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression500 = { FOLLOW_primary_in_additiveExpression500_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_additiveExpression509 */ -static ANTLR3_BITWORD FOLLOW_ADD_in_additiveExpression509_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ADD_in_additiveExpression509 = { FOLLOW_ADD_in_additiveExpression509_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression511 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression511_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression511 = { FOLLOW_additiveExpression_in_additiveExpression511_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression513 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression513_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression513 = { FOLLOW_additiveExpression_in_additiveExpression513_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SUB_in_additiveExpression523 */ -static ANTLR3_BITWORD FOLLOW_SUB_in_additiveExpression523_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SUB_in_additiveExpression523 = { FOLLOW_SUB_in_additiveExpression523_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression525 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression525_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression525 = { FOLLOW_additiveExpression_in_additiveExpression525_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression527 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression527_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression527 = { FOLLOW_additiveExpression_in_additiveExpression527_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_primary542 */ -static ANTLR3_BITWORD FOLLOW_ID_in_primary542_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_primary542 = { FOLLOW_ID_in_primary542_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary550 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_primary550_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary550 = { FOLLOW_group_elements_in_primary550_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_primary558 */ -static ANTLR3_BITWORD FOLLOW_NUM_in_primary558_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_NUM_in_primary558 = { FOLLOW_NUM_in_primary558_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary567 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_primary567_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary567 = { FOLLOW_MULT_in_primary567_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_primary569 */ -static ANTLR3_BITWORD FOLLOW_NUM_in_primary569_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; -static ANTLR3_BITSET_LIST FOLLOW_NUM_in_primary569 = { FOLLOW_NUM_in_primary569_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary571 */ -static ANTLR3_BITWORD FOLLOW_primary_in_primary571_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary571 = { FOLLOW_primary_in_primary571_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_primary581 */ -static ANTLR3_BITWORD FOLLOW_ADD_in_primary581_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ADD_in_primary581 = { FOLLOW_ADD_in_primary581_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary583 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary583_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary583 = { FOLLOW_additiveExpression_in_primary583_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary585 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary585_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary585 = { FOLLOW_additiveExpression_in_primary585_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SUB_in_primary595 */ -static ANTLR3_BITWORD FOLLOW_SUB_in_primary595_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SUB_in_primary595 = { FOLLOW_SUB_in_primary595_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary597 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary597_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary597 = { FOLLOW_additiveExpression_in_primary597_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary599 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary599_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary599 = { FOLLOW_additiveExpression_in_primary599_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def610 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def610_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def610 = { FOLLOW_LIVE_in_live_def610_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def612 */ -static ANTLR3_BITWORD FOLLOW_ALL_in_live_def612_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def612 = { FOLLOW_ALL_in_live_def612_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def617 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def617_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def617 = { FOLLOW_ID_in_live_def617_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def628 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def628_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def628 = { FOLLOW_LIVE_in_live_def628_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def631 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def631_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def631 = { FOLLOW_ID_in_live_def631_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol646 */ -static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol646_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol646 = { FOLLOW_UNCONTROL_in_uncontrol646_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol649 */ -static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol649_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol649 = { FOLLOW_ID_in_uncontrol649_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve664 */ -static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve664_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve664 = { FOLLOW_UNOBSERVE_in_unobserve664_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve667 */ -static ANTLR3_BITWORD FOLLOW_ID_in_unobserve667_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve667 = { FOLLOW_ID_in_unobserve667_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands682 */ -static ANTLR3_BITWORD FOLLOW_print_in_other_commands682_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands682 = { FOLLOW_print_in_other_commands682_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print693 */ -static ANTLR3_BITWORD FOLLOW_PRINT_in_print693_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print693 = { FOLLOW_PRINT_in_print693_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print695 */ -static ANTLR3_BITWORD FOLLOW_ID_in_print695_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_print695 = { FOLLOW_ID_in_print695_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print697 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_print697_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print697 = { FOLLOW_group_elements_in_print697_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_GROUP_in_group_elements718 */ -static ANTLR3_BITWORD FOLLOW_GROUP_in_group_elements718_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_GROUP_in_group_elements718 = { FOLLOW_GROUP_in_group_elements718_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements721 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements721_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements721 = { FOLLOW_ID_in_group_elements721_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID740 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID740_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID740 = { FOLLOW_ID_in_numbered_ID740_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID748 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID748_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID748 = { FOLLOW_ID_in_numbered_ID748_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID750 */ -static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID750_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID750 = { FOLLOW_INT_in_numbered_ID750_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_synpred2_pngenerator78 */ -static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_synpred2_pngenerator78_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_synpred2_pngenerator78 = { FOLLOW_proc_instantiations_in_synpred2_pngenerator78_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred29_pngenerator500 */ -static ANTLR3_BITWORD FOLLOW_primary_in_synpred29_pngenerator500_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred29_pngenerator500 = { FOLLOW_primary_in_synpred29_pngenerator500_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_synpred30_pngenerator509 */ -static ANTLR3_BITWORD FOLLOW_ADD_in_synpred30_pngenerator509_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ADD_in_synpred30_pngenerator509 = { FOLLOW_ADD_in_synpred30_pngenerator509_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_synpred30_pngenerator511 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_synpred30_pngenerator511_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_synpred30_pngenerator511 = { FOLLOW_additiveExpression_in_synpred30_pngenerator511_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_synpred30_pngenerator513 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_synpred30_pngenerator513_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_synpred30_pngenerator513 = { FOLLOW_additiveExpression_in_synpred30_pngenerator513_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_definitions_in_pn67 */ +static ANTLR3_BITWORD FOLLOW_proc_definitions_in_pn67_bits[] = { ANTLR3_UINT64_LIT(0x0000000000C00400) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_definitions_in_pn67 = { FOLLOW_proc_definitions_in_pn67_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_pn70 */ +static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_pn70_bits[] = { ANTLR3_UINT64_LIT(0x0000000400C00402) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_pn70 = { FOLLOW_proc_instantiations_in_pn70_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraints_in_pn73 */ +static ANTLR3_BITWORD FOLLOW_constraints_in_pn73_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000402) }; +static ANTLR3_BITSET_LIST FOLLOW_constraints_in_pn73 = { FOLLOW_constraints_in_pn73_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_other_commands_in_pn76 */ +static ANTLR3_BITWORD FOLLOW_other_commands_in_pn76_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000002) }; +static ANTLR3_BITSET_LIST FOLLOW_other_commands_in_pn76 = { FOLLOW_other_commands_in_pn76_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_def_start_in_proc_definitions94 */ +static ANTLR3_BITWORD FOLLOW_def_start_in_proc_definitions94_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_def_start_in_proc_definitions94 = { FOLLOW_def_start_in_proc_definitions94_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_trans_defs_in_proc_definitions96 */ +static ANTLR3_BITWORD FOLLOW_trans_defs_in_proc_definitions96_bits[] = { ANTLR3_UINT64_LIT(0x0000200000200468) }; +static ANTLR3_BITSET_LIST FOLLOW_trans_defs_in_proc_definitions96 = { FOLLOW_trans_defs_in_proc_definitions96_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_select_functions_in_proc_definitions99 */ +static ANTLR3_BITWORD FOLLOW_select_functions_in_proc_definitions99_bits[] = { ANTLR3_UINT64_LIT(0x0000200000200008) }; +static ANTLR3_BITSET_LIST FOLLOW_select_functions_in_proc_definitions99 = { FOLLOW_select_functions_in_proc_definitions99_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_nondeterm_in_proc_definitions102 */ +static ANTLR3_BITWORD FOLLOW_nondeterm_in_proc_definitions102_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_nondeterm_in_proc_definitions102 = { FOLLOW_nondeterm_in_proc_definitions102_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_def_start118 */ +static ANTLR3_BITWORD FOLLOW_ID_in_def_start118_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_def_start118 = { FOLLOW_ID_in_def_start118_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_extern_trans_def_in_trans_defs128 */ +static ANTLR3_BITWORD FOLLOW_extern_trans_def_in_trans_defs128_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_extern_trans_def_in_trans_defs128 = { FOLLOW_extern_trans_def_in_trans_defs128_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_trans_def_in_trans_defs133 */ +static ANTLR3_BITWORD FOLLOW_trans_def_in_trans_defs133_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_trans_def_in_trans_defs133 = { FOLLOW_trans_def_in_trans_defs133_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_TO_in_extern_trans_def149 */ +static ANTLR3_BITWORD FOLLOW_TO_in_extern_trans_def149_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_TO_in_extern_trans_def149 = { FOLLOW_TO_in_extern_trans_def149_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_FROM_in_extern_trans_def155 */ +static ANTLR3_BITWORD FOLLOW_FROM_in_extern_trans_def155_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_FROM_in_extern_trans_def155 = { FOLLOW_FROM_in_extern_trans_def155_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_extern_trans_def161 */ +static ANTLR3_BITWORD FOLLOW_ID_in_extern_trans_def161_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_extern_trans_def161 = { FOLLOW_ID_in_extern_trans_def161_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def181 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def181_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def181 = { FOLLOW_ID_in_trans_def181_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def183 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def183_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def183 = { FOLLOW_CODE_BLOCK_in_trans_def183_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def197 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def197_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def197 = { FOLLOW_ID_in_trans_def197_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def204 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def204_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def204 = { FOLLOW_ID_in_trans_def204_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def213 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def213_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def213 = { FOLLOW_CODE_BLOCK_in_trans_def213_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def231 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def231_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def231 = { FOLLOW_ID_in_trans_def231_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def238 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def238_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def238 = { FOLLOW_ID_in_trans_def238_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def245 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def245_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def245 = { FOLLOW_ID_in_trans_def245_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def254 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def254_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def254 = { FOLLOW_CODE_BLOCK_in_trans_def254_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SELECT_DEF_in_select_functions271 */ +static ANTLR3_BITWORD FOLLOW_SELECT_DEF_in_select_functions271_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SELECT_DEF_in_select_functions271 = { FOLLOW_SELECT_DEF_in_select_functions271_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_select_functions273 */ +static ANTLR3_BITWORD FOLLOW_ID_in_select_functions273_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002000) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_select_functions273 = { FOLLOW_ID_in_select_functions273_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_select_functions275 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_select_functions275_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_select_functions275 = { FOLLOW_CODE_BLOCK_in_select_functions275_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_45_in_nondeterm288 */ +static ANTLR3_BITWORD FOLLOW_45_in_nondeterm288_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_45_in_nondeterm288 = { FOLLOW_45_in_nondeterm288_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_nondeterm291 */ +static ANTLR3_BITWORD FOLLOW_ID_in_nondeterm291_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_nondeterm291 = { FOLLOW_ID_in_nondeterm291_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_init_in_proc_instantiations310 */ +static ANTLR3_BITWORD FOLLOW_proc_init_in_proc_instantiations310_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_init_in_proc_instantiations310 = { FOLLOW_proc_init_in_proc_instantiations310_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_sync_def_in_proc_instantiations314 */ +static ANTLR3_BITWORD FOLLOW_sync_def_in_proc_instantiations314_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_sync_def_in_proc_instantiations314 = { FOLLOW_sync_def_in_proc_instantiations314_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_start_in_proc_instantiations318 */ +static ANTLR3_BITWORD FOLLOW_proc_start_in_proc_instantiations318_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_start_in_proc_instantiations318 = { FOLLOW_proc_start_in_proc_instantiations318_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init333 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_init333_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init333 = { FOLLOW_ID_in_proc_init333_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_numbered_ID_in_proc_init338 */ +static ANTLR3_BITWORD FOLLOW_numbered_ID_in_proc_init338_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_numbered_ID_in_proc_init338 = { FOLLOW_numbered_ID_in_proc_init338_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SYNC_TOK_in_sync_def361 */ +static ANTLR3_BITWORD FOLLOW_SYNC_TOK_in_sync_def361_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SYNC_TOK_in_sync_def361 = { FOLLOW_SYNC_TOK_in_sync_def361_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_sync_def364 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def364_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_sync_def364 = { FOLLOW_group_elements_in_sync_def364_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start381 */ +static ANTLR3_BITWORD FOLLOW_START_in_proc_start381_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start381 = { FOLLOW_START_in_proc_start381_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start384 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_start384_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start384 = { FOLLOW_ID_in_proc_start384_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints404 */ +static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints404_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints404 = { FOLLOW_constraint_block_in_constraints404_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints406 */ +static ANTLR3_BITWORD FOLLOW_eq_in_constraints406_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints406 = { FOLLOW_eq_in_constraints406_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints409 */ +static ANTLR3_BITWORD FOLLOW_live_def_in_constraints409_bits[] = { ANTLR3_UINT64_LIT(0x0000000300000008) }; +static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints409 = { FOLLOW_live_def_in_constraints409_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints412 */ +static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints412_bits[] = { ANTLR3_UINT64_LIT(0x0000000200000008) }; +static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints412 = { FOLLOW_uncontrol_in_constraints412_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints415 */ +static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints415_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints415 = { FOLLOW_unobserve_in_constraints415_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block425 */ +static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block425_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block425 = { FOLLOW_ID_in_constraint_block425_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq436 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq436_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq436 = { FOLLOW_relationalExpression_in_eq436_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq442 */ +static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq442_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq442 = { FOLLOW_EQS_OP_in_eq442_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq444 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq444_bits[] = { ANTLR3_UINT64_LIT(0x000000034C000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq444 = { FOLLOW_eq_in_eq444_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq446 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq446_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq446 = { FOLLOW_eq_in_eq446_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression463 */ +static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression463_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression463 = { FOLLOW_EQ_OP_in_relationalExpression463_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression465 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression465_bits[] = { ANTLR3_UINT64_LIT(0x0002000000000000) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression465 = { FOLLOW_additiveExpression_in_relationalExpression465_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_relationalExpression467 */ +static ANTLR3_BITWORD FOLLOW_NUM_in_relationalExpression467_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_NUM_in_relationalExpression467 = { FOLLOW_NUM_in_relationalExpression467_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression483 */ +static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression483_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression483 = { FOLLOW_primary_in_additiveExpression483_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_additiveExpression492 */ +static ANTLR3_BITWORD FOLLOW_ADD_in_additiveExpression492_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ADD_in_additiveExpression492 = { FOLLOW_ADD_in_additiveExpression492_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression494 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression494_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression494 = { FOLLOW_additiveExpression_in_additiveExpression494_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression496 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression496_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression496 = { FOLLOW_additiveExpression_in_additiveExpression496_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SUB_in_additiveExpression506 */ +static ANTLR3_BITWORD FOLLOW_SUB_in_additiveExpression506_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SUB_in_additiveExpression506 = { FOLLOW_SUB_in_additiveExpression506_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression508 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression508_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression508 = { FOLLOW_additiveExpression_in_additiveExpression508_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression510 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression510_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression510 = { FOLLOW_additiveExpression_in_additiveExpression510_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_primary525 */ +static ANTLR3_BITWORD FOLLOW_ID_in_primary525_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_primary525 = { FOLLOW_ID_in_primary525_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary533 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_primary533_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary533 = { FOLLOW_group_elements_in_primary533_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_primary541 */ +static ANTLR3_BITWORD FOLLOW_NUM_in_primary541_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_NUM_in_primary541 = { FOLLOW_NUM_in_primary541_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary550 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_primary550_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary550 = { FOLLOW_MULT_in_primary550_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_primary552 */ +static ANTLR3_BITWORD FOLLOW_NUM_in_primary552_bits[] = { ANTLR3_UINT64_LIT(0x0002000000040488) }; +static ANTLR3_BITSET_LIST FOLLOW_NUM_in_primary552 = { FOLLOW_NUM_in_primary552_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary554 */ +static ANTLR3_BITWORD FOLLOW_primary_in_primary554_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary554 = { FOLLOW_primary_in_primary554_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def565 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def565_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def565 = { FOLLOW_LIVE_in_live_def565_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def567 */ +static ANTLR3_BITWORD FOLLOW_ALL_in_live_def567_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def567 = { FOLLOW_ALL_in_live_def567_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def572 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def572_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def572 = { FOLLOW_ID_in_live_def572_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def583 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def583_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def583 = { FOLLOW_LIVE_in_live_def583_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def586 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def586_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def586 = { FOLLOW_ID_in_live_def586_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol601 */ +static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol601_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol601 = { FOLLOW_UNCONTROL_in_uncontrol601_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol604 */ +static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol604_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol604 = { FOLLOW_ID_in_uncontrol604_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve619 */ +static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve619_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve619 = { FOLLOW_UNOBSERVE_in_unobserve619_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve622 */ +static ANTLR3_BITWORD FOLLOW_ID_in_unobserve622_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve622 = { FOLLOW_ID_in_unobserve622_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands637 */ +static ANTLR3_BITWORD FOLLOW_print_in_other_commands637_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands637 = { FOLLOW_print_in_other_commands637_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print648 */ +static ANTLR3_BITWORD FOLLOW_PRINT_in_print648_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print648 = { FOLLOW_PRINT_in_print648_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print650 */ +static ANTLR3_BITWORD FOLLOW_ID_in_print650_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_print650 = { FOLLOW_ID_in_print650_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print652 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_print652_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print652 = { FOLLOW_group_elements_in_print652_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_GROUP_in_group_elements673 */ +static ANTLR3_BITWORD FOLLOW_GROUP_in_group_elements673_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_GROUP_in_group_elements673 = { FOLLOW_GROUP_in_group_elements673_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements676 */ +static ANTLR3_BITWORD FOLLOW_ID_in_group_elements676_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements676 = { FOLLOW_ID_in_group_elements676_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID695 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID695_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID695 = { FOLLOW_ID_in_numbered_ID695_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID703 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID703_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID703 = { FOLLOW_ID_in_numbered_ID703_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID705 */ +static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID705_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID705 = { FOLLOW_INT_in_numbered_ID705_bits, 1 }; - -/* ========================================================================= - * DFA tables for the parser - */ -/** Static dfa state tables for Cyclic dfa: - * ()+ loopback of 83:22: ( proc_instantiations )+ - */ -static const ANTLR3_INT32 dfa2_eot[7] = - { - -1, -1, -1, -1, -1, -1, -1 - }; -static const ANTLR3_INT32 dfa2_eof[7] = - { - 2, -1, -1, -1, -1, -1, -1 - }; -static const ANTLR3_INT32 dfa2_min[7] = - { - 10, 2, -1, -1, 3, 2, 0 - }; -static const ANTLR3_INT32 dfa2_max[7] = - { - 34, 2, -1, -1, 49, 49, 0 - }; -static const ANTLR3_INT32... [truncated message content] |
From: <the...@us...> - 2009-06-19 19:57:48
|
Revision: 80 http://pntool.svn.sourceforge.net/pntool/?rev=80&view=rev Author: thecodeweasel Date: 2009-06-19 19:57:39 +0000 (Fri, 19 Jun 2009) Log Message: ----------- Removing parser support for several constraint operators. Hopefully we'll get them back eventually. Commented out some constraint test cases that test the parser but are currently not fully reflowed to be pns-compatible. Modified Paths: -------------- translator/docs/test.txt translator/pnscript.g translator/pnscriptLexer.c translator/pnscriptLexer.h translator/pnscriptParser.c translator/pnscriptParser.h Modified: translator/docs/test.txt =================================================================== --- translator/docs/test.txt 2009-06-19 19:16:29 UTC (rev 79) +++ translator/docs/test.txt 2009-06-19 19:57:39 UTC (rev 80) @@ -77,8 +77,8 @@ (r_group.p1b <= 0 || w_group.pwr_1 <= 0) && (reader1.p2 <= 0 || writer1.pwr2 <= 0); q.reader1.t1 - writer1.p <= 0; 2*reader1.t1 - 2*reader1.t2 + w_group.pwr_2 <= 2; -reader1.t1 - (reader1.t2 + w_group.pwr_2) > -1; -(reader1.t1 - (reader1.t2 + w_group.pwr_2) > -1) || (r_group.p1b <= 0 && (w_group.pwr_1 <= 0)); --3*((reader1.p2+2)-2*w_group.pwr_2) < -(4*r_group.p1b-2*(3*writer1.pwr2-2)); +//reader1.t1 - (reader1.t2 + w_group.pwr_2) > -1; +//(reader1.t1 - (reader1.t2 + w_group.pwr_2) > -1) || (r_group.p1b <= 0 && (w_group.pwr_1 <= 0)); +//-3*((reader1.p2+2)-2*w_group.pwr_2) < -(4*r_group.p1b-2*(3*writer1.pwr2-2)); //################################################ print supervisor to debug.log; \ No newline at end of file Modified: translator/pnscript.g =================================================================== --- translator/pnscript.g 2009-06-19 19:16:29 UTC (rev 79) +++ translator/pnscript.g 2009-06-19 19:57:39 UTC (rev 80) @@ -539,7 +539,7 @@ EQS_OP : '||'|'&&'|'or'|'OR'|'and'|'AND'; EQ_OP - : '<'|'<='|'='|'!='|'>='|'>'; + : '<'|'<='; //|'='|'!='|'>='|'>'; MULT : '*'; LIVE Modified: translator/pnscriptLexer.c =================================================================== --- translator/pnscriptLexer.c 2009-06-19 19:16:29 UTC (rev 79) +++ translator/pnscriptLexer.c 2009-06-19 19:57:39 UTC (rev 80) @@ -2,7 +2,7 @@ * This C source file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pnscript.g - * - On : 2009-06-19 13:34:29 + * - On : 2009-06-19 14:55:03 * - for the lexer : pnscriptLexerLexer * * Editing it, at least manually, is not wise. * @@ -75,20 +75,18 @@ static ANTLR3_UCHAR lit_21[] = { 0x61, 0x6E, 0x64, ANTLR3_STRING_TERMINATOR}; static ANTLR3_UCHAR lit_22[] = { 0x41, 0x4E, 0x44, ANTLR3_STRING_TERMINATOR}; static ANTLR3_UCHAR lit_23[] = { 0x3C, 0x3D, ANTLR3_STRING_TERMINATOR}; -static ANTLR3_UCHAR lit_24[] = { 0x21, 0x3D, ANTLR3_STRING_TERMINATOR}; -static ANTLR3_UCHAR lit_25[] = { 0x3E, 0x3D, ANTLR3_STRING_TERMINATOR}; -static ANTLR3_UCHAR lit_26[] = { 0x6C, 0x69, 0x76, 0x65, 0x3A, ANTLR3_STRING_TERMINATOR}; -static ANTLR3_UCHAR lit_27[] = { 0x61, 0x6C, 0x6C, ANTLR3_STRING_TERMINATOR}; -static ANTLR3_UCHAR lit_28[] = { 0x41, 0x6C, 0x6C, ANTLR3_STRING_TERMINATOR}; -static ANTLR3_UCHAR lit_29[] = { 0x41, 0x4C, 0x4C, ANTLR3_STRING_TERMINATOR}; -static ANTLR3_UCHAR lit_30[] = { 0x75, 0x6E, 0x63, 0x6F, 0x6E, 0x74, 0x72, 0x6F, 0x6C, 0x6C, 0x61, 0x62, 0x6C, 0x65, 0x3A, 0x20, ANTLR3_STRING_TERMINATOR}; -static ANTLR3_UCHAR lit_31[] = { 0x75, 0x6E, 0x6F, 0x62, 0x73, 0x65, 0x72, 0x76, 0x61, 0x62, 0x6C, 0x65, 0x3A, 0x20, ANTLR3_STRING_TERMINATOR}; -static ANTLR3_UCHAR lit_32[] = { 0x70, 0x72, 0x69, 0x6E, 0x74, ANTLR3_STRING_TERMINATOR}; -static ANTLR3_UCHAR lit_33[] = { 0x5C, 0x27, ANTLR3_STRING_TERMINATOR}; -static ANTLR3_UCHAR lit_34[] = { 0x5C, 0x22, ANTLR3_STRING_TERMINATOR}; -static ANTLR3_UCHAR lit_35[] = { 0x2F, 0x2F, ANTLR3_STRING_TERMINATOR}; -static ANTLR3_UCHAR lit_36[] = { 0x2F, 0x2A, ANTLR3_STRING_TERMINATOR}; -static ANTLR3_UCHAR lit_37[] = { 0x2A, 0x2F, ANTLR3_STRING_TERMINATOR}; +static ANTLR3_UCHAR lit_24[] = { 0x6C, 0x69, 0x76, 0x65, 0x3A, ANTLR3_STRING_TERMINATOR}; +static ANTLR3_UCHAR lit_25[] = { 0x61, 0x6C, 0x6C, ANTLR3_STRING_TERMINATOR}; +static ANTLR3_UCHAR lit_26[] = { 0x41, 0x6C, 0x6C, ANTLR3_STRING_TERMINATOR}; +static ANTLR3_UCHAR lit_27[] = { 0x41, 0x4C, 0x4C, ANTLR3_STRING_TERMINATOR}; +static ANTLR3_UCHAR lit_28[] = { 0x75, 0x6E, 0x63, 0x6F, 0x6E, 0x74, 0x72, 0x6F, 0x6C, 0x6C, 0x61, 0x62, 0x6C, 0x65, 0x3A, 0x20, ANTLR3_STRING_TERMINATOR}; +static ANTLR3_UCHAR lit_29[] = { 0x75, 0x6E, 0x6F, 0x62, 0x73, 0x65, 0x72, 0x76, 0x61, 0x62, 0x6C, 0x65, 0x3A, 0x20, ANTLR3_STRING_TERMINATOR}; +static ANTLR3_UCHAR lit_30[] = { 0x70, 0x72, 0x69, 0x6E, 0x74, ANTLR3_STRING_TERMINATOR}; +static ANTLR3_UCHAR lit_31[] = { 0x5C, 0x27, ANTLR3_STRING_TERMINATOR}; +static ANTLR3_UCHAR lit_32[] = { 0x5C, 0x22, ANTLR3_STRING_TERMINATOR}; +static ANTLR3_UCHAR lit_33[] = { 0x2F, 0x2F, ANTLR3_STRING_TERMINATOR}; +static ANTLR3_UCHAR lit_34[] = { 0x2F, 0x2A, ANTLR3_STRING_TERMINATOR}; +static ANTLR3_UCHAR lit_35[] = { 0x2A, 0x2F, ANTLR3_STRING_TERMINATOR}; @@ -562,355 +560,355 @@ static const ANTLR3_INT32 dfa16_T0[] = { - 71 + 115 };static const ANTLR3_INT32 dfa16_T1[] = { - 55 + 90 };static const ANTLR3_INT32 dfa16_T2[] = { - 72 + 100 };static const ANTLR3_INT32 dfa16_T3[] = { - 138 + 48 };static const ANTLR3_INT32 dfa16_T4[] = { - 141 + 81 };static const ANTLR3_INT32 dfa16_T5[] = { - 151 + 117 };static const ANTLR3_INT32 dfa16_T6[] = { + 66 + };static const ANTLR3_INT32 dfa16_T7[] = + { 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, -1, -1, -1, -1, -1, -1, -1, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, -1, -1, -1, -1, 28, -1, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28 - };static const ANTLR3_INT32 dfa16_T7[] = - { - 59 };static const ANTLR3_INT32 dfa16_T8[] = { - 75 + 157 };static const ANTLR3_INT32 dfa16_T9[] = { - 58, -1, -1, -1, -1, 57 + 131 };static const ANTLR3_INT32 dfa16_T10[] = { - 113, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, - -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, - -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 112 + 104 };static const ANTLR3_INT32 dfa16_T11[] = { - 150 + 95 };static const ANTLR3_INT32 dfa16_T12[] = { - 45, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 47, -1, -1, - -1, -1, 46 + 154 };static const ANTLR3_INT32 dfa16_T13[] = { - 137 + 76 };static const ANTLR3_INT32 dfa16_T14[] = { - 123 + 146 };static const ANTLR3_INT32 dfa16_T15[] = { - 54, -1, 52, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, - -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 53 + 78, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 79 };static const ANTLR3_INT32 dfa16_T16[] = { - 92 + 45, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 47, -1, -1, + -1, -1, 46 };static const ANTLR3_INT32 dfa16_T17[] = { - 69 + 85 };static const ANTLR3_INT32 dfa16_T18[] = { - 131 + 152 };static const ANTLR3_INT32 dfa16_T19[] = { - 142 + 56 };static const ANTLR3_INT32 dfa16_T20[] = { - 66 + 149 };static const ANTLR3_INT32 dfa16_T21[] = { - 95 + 62 };static const ANTLR3_INT32 dfa16_T22[] = { - 42, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, - -1, 43 + 83 };static const ANTLR3_INT32 dfa16_T23[] = { - 34 + 139 };static const ANTLR3_INT32 dfa16_T24[] = { - 117 + 55 };static const ANTLR3_INT32 dfa16_T25[] = { - 156 + 64, -1, -1, -1, -1, -1, 63 };static const ANTLR3_INT32 dfa16_T26[] = { - 146 + 101 };static const ANTLR3_INT32 dfa16_T27[] = { - 84 + 143 };static const ANTLR3_INT32 dfa16_T28[] = { - 134 + 161 };static const ANTLR3_INT32 dfa16_T29[] = { - 80 + 160 };static const ANTLR3_INT32 dfa16_T30[] = { - 122 + 35, -1, -1, 36 };static const ANTLR3_INT32 dfa16_T31[] = { - 56 + 80 };static const ANTLR3_INT32 dfa16_T32[] = { 145 };static const ANTLR3_INT32 dfa16_T33[] = { - 70 + 128 };static const ANTLR3_INT32 dfa16_T34[] = { - 77 + 72 };static const ANTLR3_INT32 dfa16_T35[] = { - 125 + 75 };static const ANTLR3_INT32 dfa16_T36[] = { - 153 + 108 };static const ANTLR3_INT32 dfa16_T37[] = { - 40 + 159 };static const ANTLR3_INT32 dfa16_T38[] = { - 128 + 91 };static const ANTLR3_INT32 dfa16_T39[] = { - 91 + 86 };static const ANTLR3_INT32 dfa16_T40[] = { - 113 + 127 };static const ANTLR3_INT32 dfa16_T41[] = { - 76 + 140 };static const ANTLR3_INT32 dfa16_T42[] = { - 87 + 58, -1, -1, -1, -1, 57 };static const ANTLR3_INT32 dfa16_T43[] = { - 104 + 136 };static const ANTLR3_INT32 dfa16_T44[] = { - 109 + 133 };static const ANTLR3_INT32 dfa16_T45[] = { - 152 + 37 };static const ANTLR3_INT32 dfa16_T46[] = { - 61 + 42, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, + -1, 43 };static const ANTLR3_INT32 dfa16_T47[] = { - 159 + 92 };static const ANTLR3_INT32 dfa16_T48[] = { - 120 + 142 };static const ANTLR3_INT32 dfa16_T49[] = { - 118 + 94 };static const ANTLR3_INT32 dfa16_T50[] = { - 100 + 96 };static const ANTLR3_INT32 dfa16_T51[] = { - 162 + 110 };static const ANTLR3_INT32 dfa16_T52[] = { - 97 + 107 };static const ANTLR3_INT32 dfa16_T53[] = { - 149 + 156 };static const ANTLR3_INT32 dfa16_T54[] = { - 110 + 70 };static const ANTLR3_INT32 dfa16_T55[] = { - 103 + 155 };static const ANTLR3_INT32 dfa16_T56[] = { - 83 + 134 };static const ANTLR3_INT32 dfa16_T57[] = { - 133 + 129 };static const ANTLR3_INT32 dfa16_T58[] = { - 30, 30, -1, -1, 30, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, - -1, -1, -1, -1, -1, 30, 19, 23, -1, -1, -1, 14, 23, 3, 5, 2, 25, 4, 26, - 12, 31, 27, 27, 27, 27, 27, 27, 27, 27, 27, 27, 1, 29, 19, 19, 19, -1, - -1, 18, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 16, 28, 28, - 28, 28, 28, 28, 28, 28, 28, 28, 28, -1, 24, -1, -1, -1, -1, 17, 10, 28, - 28, 8, 28, 28, 28, 11, 28, 28, 20, 28, 6, 15, 9, 28, 28, 13, 7, 21, 28, - 28, 28, 28, 28, 22, 14 + 59 };static const ANTLR3_INT32 dfa16_T59[] = { - 78, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 79 + 124 };static const ANTLR3_INT32 dfa16_T60[] = { - 99 + 118 };static const ANTLR3_INT32 dfa16_T61[] = { - 67 + 71 };static const ANTLR3_INT32 dfa16_T62[] = { - 96 + 65 };static const ANTLR3_INT32 dfa16_T63[] = { - 39, -1, -1, -1, -1, -1, 38 + 151 };static const ANTLR3_INT32 dfa16_T64[] = { - 86 + 39, -1, -1, -1, -1, -1, 38 };static const ANTLR3_INT32 dfa16_T65[] = { - 155 + 54, -1, 52, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, + -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 53 };static const ANTLR3_INT32 dfa16_T66[] = { - 115 + 158 };static const ANTLR3_INT32 dfa16_T67[] = { - 101 + 138 };static const ANTLR3_INT32 dfa16_T68[] = { - 140 + 77 };static const ANTLR3_INT32 dfa16_T69[] = { - 158 + 113 };static const ANTLR3_INT32 dfa16_T70[] = { - 62 + 34 };static const ANTLR3_INT32 dfa16_T71[] = { - 35, -1, -1, 36 + 141 };static const ANTLR3_INT32 dfa16_T72[] = { - 108 + 132 };static const ANTLR3_INT32 dfa16_T73[] = { - 64, -1, -1, -1, -1, -1, 63 + 41 };static const ANTLR3_INT32 dfa16_T74[] = { - 73 + 99 };static const ANTLR3_INT32 dfa16_T75[] = { - 102 + 73 };static const ANTLR3_INT32 dfa16_T76[] = { - 51, -1, 50 + 109 };static const ANTLR3_INT32 dfa16_T77[] = { - 98 + 147 };static const ANTLR3_INT32 dfa16_T78[] = { - 81 + 98 };static const ANTLR3_INT32 dfa16_T79[] = { - 85 + 123 };static const ANTLR3_INT32 dfa16_T80[] = { - 160 + 130 };static const ANTLR3_INT32 dfa16_T81[] = { - 37 + 114 };static const ANTLR3_INT32 dfa16_T82[] = { - 154 + 102 };static const ANTLR3_INT32 dfa16_T83[] = { - 129 + 144 };static const ANTLR3_INT32 dfa16_T84[] = { - 144 + 122 };static const ANTLR3_INT32 dfa16_T85[] = { - 32 + 153 };static const ANTLR3_INT32 dfa16_T86[] = { - 132 + 148 };static const ANTLR3_INT32 dfa16_T87[] = { - 105 + 97 };static const ANTLR3_INT32 dfa16_T88[] = { - 65 + 49 };static const ANTLR3_INT32 dfa16_T89[] = { - 148 + 84 };static const ANTLR3_INT32 dfa16_T90[] = { - 107 + 150 };static const ANTLR3_INT32 dfa16_T91[] = { - 119 + 82 };static const ANTLR3_INT32 dfa16_T92[] = { - 114 + 113, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, + -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, + -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 112 };static const ANTLR3_INT32 dfa16_T93[] = { - 127 + 111 };static const ANTLR3_INT32 dfa16_T94[] = { - 124 + 87 };static const ANTLR3_INT32 dfa16_T95[] = { - 82 + 69 };static const ANTLR3_INT32 dfa16_T96[] = { - 94 + 68 };static const ANTLR3_INT32 dfa16_T97[] = { - 143 + 67 };static const ANTLR3_INT32 dfa16_T98[] = { - 130 + 74 };static const ANTLR3_INT32 dfa16_T99[] = { - 41 + 103 };static const ANTLR3_INT32 dfa16_T100[] = { - 111 + 32 };static const ANTLR3_INT32 dfa16_T101[] = { - 68 + 51, -1, 50 };static const ANTLR3_INT32 dfa16_T102[] = { - 139 + 125 };static const ANTLR3_INT32 dfa16_T103[] = { - 90 + 119 };static const ANTLR3_INT32 dfa16_T104[] = { - 74 + 120 };static const ANTLR3_INT32 dfa16_T105[] = { - 49 + 88, -1, -1, -1, -1, -1, -1, -1, -1, -1, 89 };static const ANTLR3_INT32 dfa16_T106[] = { - 161 + 40 };static const ANTLR3_INT32 dfa16_T107[] = { - 136 + 30, 30, -1, -1, 30, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, + -1, -1, -1, -1, -1, 30, -1, 23, -1, -1, -1, 14, 23, 3, 5, 2, 25, 4, 26, + 12, 31, 27, 27, 27, 27, 27, 27, 27, 27, 27, 27, 1, 29, 19, -1, -1, -1, + -1, 18, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 28, 16, 28, 28, + 28, 28, 28, 28, 28, 28, 28, 28, 28, -1, 24, -1, -1, -1, -1, 17, 10, 28, + 28, 8, 28, 28, 28, 11, 28, 28, 20, 28, 6, 15, 9, 28, 28, 13, 7, 21, 28, + 28, 28, 28, 28, 22, 14 };static const ANTLR3_INT32 dfa16_T108[] = { - 48 + 61 };static const ANTLR3_INT32 dfa16_T109[] = { - 88, -1, -1, -1, -1, -1, -1, -1, -1, -1, 89 + 162 };static const ANTLR3_INT32 dfa16_T110[] = { - 147 + 105 };static const ANTLR3_INT32 dfa16_T111[] = { - 157 + 137 }; /* Transition tables are a table of sub tables, with some tables @@ -918,32 +916,33 @@ */ static const ANTLR3_INT32 * const dfa16_transitions[] = { - dfa16_T58, dfa16_T_empty, dfa16_T85, dfa16_T_empty, dfa16_T_empty, dfa16_T_empty, - dfa16_T23, dfa16_T71, dfa16_T81, dfa16_T63, dfa16_T37, dfa16_T99, dfa16_T22, - dfa16_T12, dfa16_T_empty, dfa16_T108, dfa16_T105, dfa16_T76, dfa16_T15, - dfa16_T_empty, dfa16_T1, dfa16_T31, dfa16_T_empty, dfa16_T_empty, dfa16_T_empty, + dfa16_T107, dfa16_T_empty, dfa16_T100, dfa16_T_empty, dfa16_T_empty, + dfa16_T_empty, dfa16_T70, dfa16_T30, dfa16_T45, dfa16_T64, dfa16_T106, + dfa16_T73, dfa16_T46, dfa16_T16, dfa16_T_empty, dfa16_T3, dfa16_T88, + dfa16_T101, dfa16_T65, dfa16_T_empty, dfa16_T24, dfa16_T19, dfa16_T_empty, dfa16_T_empty, dfa16_T_empty, dfa16_T_empty, dfa16_T_empty, dfa16_T_empty, - dfa16_T_empty, dfa16_T9, dfa16_T_empty, dfa16_T_empty, dfa16_T7, dfa16_T6, - dfa16_T46, dfa16_T70, dfa16_T73, dfa16_T88, dfa16_T20, dfa16_T61, dfa16_T_empty, - dfa16_T101, dfa16_T_empty, dfa16_T17, dfa16_T33, dfa16_T0, dfa16_T6, - dfa16_T6, dfa16_T2, dfa16_T74, dfa16_T104, dfa16_T8, dfa16_T41, dfa16_T34, - dfa16_T59, dfa16_T_empty, dfa16_T_empty, dfa16_T29, dfa16_T_empty, dfa16_T78, - dfa16_T95, dfa16_T56, dfa16_T27, dfa16_T79, dfa16_T64, dfa16_T42, dfa16_T109, - dfa16_T103, dfa16_T39, dfa16_T16, dfa16_T6, dfa16_T6, dfa16_T6, dfa16_T6, - dfa16_T6, dfa16_T96, dfa16_T21, dfa16_T62, dfa16_T52, dfa16_T77, dfa16_T60, - dfa16_T50, dfa16_T67, dfa16_T75, dfa16_T55, dfa16_T43, dfa16_T_empty, - dfa16_T_empty, dfa16_T87, dfa16_T6, dfa16_T90, dfa16_T_empty, dfa16_T72, - dfa16_T44, dfa16_T54, dfa16_T100, dfa16_T10, dfa16_T92, dfa16_T66, dfa16_T6, - dfa16_T24, dfa16_T49, dfa16_T91, dfa16_T48, dfa16_T_empty, dfa16_T6, - dfa16_T_empty, dfa16_T30, dfa16_T14, dfa16_T94, dfa16_T35, dfa16_T_empty, - dfa16_T6, dfa16_T93, dfa16_T_empty, dfa16_T38, dfa16_T_empty, dfa16_T83, - dfa16_T98, dfa16_T_empty, dfa16_T18, dfa16_T86, dfa16_T57, dfa16_T28, - dfa16_T_empty, dfa16_T6, dfa16_T_empty, dfa16_T107, dfa16_T_empty, dfa16_T13, - dfa16_T3, dfa16_T102, dfa16_T68, dfa16_T_empty, dfa16_T_empty, dfa16_T4, - dfa16_T19, dfa16_T97, dfa16_T84, dfa16_T32, dfa16_T26, dfa16_T110, dfa16_T89, - dfa16_T53, dfa16_T11, dfa16_T5, dfa16_T40, dfa16_T45, dfa16_T36, dfa16_T82, - dfa16_T65, dfa16_T25, dfa16_T111, dfa16_T69, dfa16_T_empty, dfa16_T47, - dfa16_T80, dfa16_T106, dfa16_T_empty, dfa16_T51, dfa16_T_empty + dfa16_T_empty, dfa16_T_empty, dfa16_T_empty, dfa16_T42, dfa16_T_empty, + dfa16_T_empty, dfa16_T58, dfa16_T7, dfa16_T108, dfa16_T21, dfa16_T25, + dfa16_T62, dfa16_T6, dfa16_T97, dfa16_T_empty, dfa16_T96, dfa16_T_empty, + dfa16_T95, dfa16_T54, dfa16_T61, dfa16_T7, dfa16_T7, dfa16_T34, dfa16_T75, + dfa16_T98, dfa16_T35, dfa16_T13, dfa16_T68, dfa16_T15, dfa16_T_empty, + dfa16_T_empty, dfa16_T31, dfa16_T_empty, dfa16_T4, dfa16_T91, dfa16_T22, + dfa16_T89, dfa16_T17, dfa16_T39, dfa16_T94, dfa16_T105, dfa16_T1, dfa16_T38, + dfa16_T47, dfa16_T7, dfa16_T7, dfa16_T7, dfa16_T7, dfa16_T7, dfa16_T49, + dfa16_T11, dfa16_T50, dfa16_T87, dfa16_T78, dfa16_T74, dfa16_T2, dfa16_T26, + dfa16_T82, dfa16_T99, dfa16_T10, dfa16_T_empty, dfa16_T_empty, dfa16_T110, + dfa16_T7, dfa16_T52, dfa16_T_empty, dfa16_T36, dfa16_T76, dfa16_T51, + dfa16_T93, dfa16_T92, dfa16_T81, dfa16_T0, dfa16_T7, dfa16_T5, dfa16_T60, + dfa16_T103, dfa16_T104, dfa16_T_empty, dfa16_T7, dfa16_T_empty, dfa16_T84, + dfa16_T79, dfa16_T59, dfa16_T102, dfa16_T_empty, dfa16_T7, dfa16_T40, + dfa16_T_empty, dfa16_T33, dfa16_T_empty, dfa16_T57, dfa16_T80, dfa16_T_empty, + dfa16_T9, dfa16_T72, dfa16_T44, dfa16_T56, dfa16_T_empty, dfa16_T7, + dfa16_T_empty, dfa16_T43, dfa16_T_empty, dfa16_T111, dfa16_T67, dfa16_T23, + dfa16_T41, dfa16_T_empty, dfa16_T_empty, dfa16_T71, dfa16_T48, dfa16_T27, + dfa16_T83, dfa16_T32, dfa16_T14, dfa16_T77, dfa16_T86, dfa16_T20, dfa16_T90, + dfa16_T63, dfa16_T69, dfa16_T18, dfa16_T85, dfa16_T12, dfa16_T55, dfa16_T53, + dfa16_T8, dfa16_T66, dfa16_T_empty, dfa16_T37, dfa16_T29, dfa16_T28, + dfa16_T_empty, dfa16_T109, dfa16_T_empty }; @@ -2008,7 +2007,7 @@ } // $ANTLR end EQS_OP -// Comes from: 542:2: ( '<' | '<=' | '=' | '!=' | '>=' | '>' ) +// Comes from: 542:2: ( '<' | '<=' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start EQ_OP @@ -2029,66 +2028,42 @@ { - // /Users/bion/projects/iordache/translator/pnscript.g:542:2: ( '<' | '<=' | '=' | '!=' | '>=' | '>' ) + // /Users/bion/projects/iordache/translator/pnscript.g:542:2: ( '<' | '<=' ) ANTLR3_UINT32 alt3; - alt3=6; + alt3=2; - switch ( LA(1) ) + { - case '<': - { + int LA3_0 = LA(1); + if ( (LA3_0 == '<') ) + { - { - int LA3_1 = LA(2); - if ( (LA3_1 == '=') ) - { - alt3=2; - } - else - { - alt3=1; } - } - } - break; - case '=': - { - alt3=3; - } - break; - case '!': - { - alt3=4; - } - break; - case '>': - { + { + int LA3_1 = LA(2); + if ( (LA3_1 == '=') ) + { + alt3=2; + } + else + { + alt3=1; } + } + } + else + { + + CONSTRUCTEX(); + EXCEPTION->type = ANTLR3_NO_VIABLE_ALT_EXCEPTION; + EXCEPTION->message = (void *)""; + EXCEPTION->decisionNum = 3; + EXCEPTION->state = 0; - { - int LA3_4 = LA(2); - if ( (LA3_4 == '=') ) - { - alt3=5; - } - else - { - alt3=6; } - } - } - break; - default: - CONSTRUCTEX(); - EXCEPTION->type = ANTLR3_NO_VIABLE_ALT_EXCEPTION; - EXCEPTION->message = (void *)""; - EXCEPTION->decisionNum = 3; - EXCEPTION->state = 0; - - - goto ruleEQ_OPEx; + goto ruleEQ_OPEx; + } } - switch (alt3) { case 1: @@ -2116,57 +2091,7 @@ } break; - case 3: - // /Users/bion/projects/iordache/translator/pnscript.g:542:13: '=' - { - MATCHC('='); - if (HASEXCEPTION()) - { - goto ruleEQ_OPEx; - } - - } - break; - case 4: - // /Users/bion/projects/iordache/translator/pnscript.g:542:17: '!=' - { - MATCHS(lit_24); - if (HASEXCEPTION()) - { - goto ruleEQ_OPEx; - } - - - - } - break; - case 5: - // /Users/bion/projects/iordache/translator/pnscript.g:542:22: '>=' - { - MATCHS(lit_25); - if (HASEXCEPTION()) - { - goto ruleEQ_OPEx; - } - - - - } - break; - case 6: - // /Users/bion/projects/iordache/translator/pnscript.g:542:27: '>' - { - MATCHC('>'); - if (HASEXCEPTION()) - { - goto ruleEQ_OPEx; - } - - - } - break; - } } LEXSTATE->type = _type; @@ -2244,7 +2169,7 @@ // /Users/bion/projects/iordache/translator/pnscript.g:546:2: ( 'live:' ) // /Users/bion/projects/iordache/translator/pnscript.g:546:4: 'live:' { - MATCHS(lit_26); + MATCHS(lit_24); if (HASEXCEPTION()) { goto ruleLIVEEx; @@ -2343,7 +2268,7 @@ case 1: // /Users/bion/projects/iordache/translator/pnscript.g:547:7: 'all' { - MATCHS(lit_27); + MATCHS(lit_25); if (HASEXCEPTION()) { goto ruleALLEx; @@ -2356,7 +2281,7 @@ case 2: // /Users/bion/projects/iordache/translator/pnscript.g:547:13: 'All' { - MATCHS(lit_28); + MATCHS(lit_26); if (HASEXCEPTION()) { goto ruleALLEx; @@ -2369,7 +2294,7 @@ case 3: // /Users/bion/projects/iordache/translator/pnscript.g:547:19: 'ALL' { - MATCHS(lit_29); + MATCHS(lit_27); if (HASEXCEPTION()) { goto ruleALLEx; @@ -2415,7 +2340,7 @@ // /Users/bion/projects/iordache/translator/pnscript.g:549:2: ( 'uncontrollable: ' ) // /Users/bion/projects/iordache/translator/pnscript.g:549:4: 'uncontrollable: ' { - MATCHS(lit_30); + MATCHS(lit_28); if (HASEXCEPTION()) { goto ruleUNCONTROLEx; @@ -2458,7 +2383,7 @@ // /Users/bion/projects/iordache/translator/pnscript.g:551:2: ( 'unobservable: ' ) // /Users/bion/projects/iordache/translator/pnscript.g:551:4: 'unobservable: ' { - MATCHS(lit_31); + MATCHS(lit_29); if (HASEXCEPTION()) { goto ruleUNOBSERVEEx; @@ -2501,7 +2426,7 @@ // /Users/bion/projects/iordache/translator/pnscript.g:554:2: ( 'print' ) // /Users/bion/projects/iordache/translator/pnscript.g:554:4: 'print' { - MATCHS(lit_32); + MATCHS(lit_30); if (HASEXCEPTION()) { goto rulePRINTEx; @@ -2956,7 +2881,7 @@ case 1: // /Users/bion/projects/iordache/translator/pnscript.g:565:4: '\\\\\\'' { - MATCHS(lit_33); + MATCHS(lit_31); if (HASEXCEPTION()) { goto ruleCHAR_ESCEx; @@ -2969,7 +2894,7 @@ case 2: // /Users/bion/projects/iordache/translator/pnscript.g:566:4: '\\\\\\\"' { - MATCHS(lit_34); + MATCHS(lit_32); if (HASEXCEPTION()) { goto ruleCHAR_ESCEx; @@ -3535,7 +3460,7 @@ // /Users/bion/projects/iordache/translator/pnscript.g:589:2: ( '//' ( . )* '\\n' ) // /Users/bion/projects/iordache/translator/pnscript.g:589:5: '//' ( . )* '\\n' { - MATCHS(lit_35); + MATCHS(lit_33); if (HASEXCEPTION()) { goto ruleCOMMENTEx; @@ -3629,7 +3554,7 @@ // /Users/bion/projects/iordache/translator/pnscript.g:592:2: ( '/*' ( . )* '*/' ) // /Users/bion/projects/iordache/translator/pnscript.g:592:5: '/*' ( . )* '*/' { - MATCHS(lit_36); + MATCHS(lit_34); if (HASEXCEPTION()) { goto ruleBLOCK_COMMENTEx; @@ -3691,7 +3616,7 @@ } loop15: ; /* Jump out to here if this rule does not match */ - MATCHS(lit_37); + MATCHS(lit_35); if (HASEXCEPTION()) { goto ruleBLOCK_COMMENTEx; Modified: translator/pnscriptLexer.h =================================================================== --- translator/pnscriptLexer.h 2009-06-19 19:16:29 UTC (rev 79) +++ translator/pnscriptLexer.h 2009-06-19 19:57:39 UTC (rev 80) @@ -2,7 +2,7 @@ * This C header file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pnscript.g - * - On : 2009-06-19 13:34:29 + * - On : 2009-06-19 14:55:03 * - for the lexer : pnscriptLexerLexer * * Editing it, at least manually, is not wise. * Modified: translator/pnscriptParser.c =================================================================== --- translator/pnscriptParser.c 2009-06-19 19:16:29 UTC (rev 79) +++ translator/pnscriptParser.c 2009-06-19 19:57:39 UTC (rev 80) @@ -2,7 +2,7 @@ * This C source file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pnscript.g - * - On : 2009-06-19 13:34:29 + * - On : 2009-06-19 14:55:03 * - for the parser : pnscriptParserParser * * Editing it, at least manually, is not wise. * @@ -2214,7 +2214,7 @@ /* AST REWRITE - * elements : CODE_BLOCK, INCLUDE + * elements : INCLUDE, CODE_BLOCK * token labels : * rule labels : retval * token list labels : @@ -3027,7 +3027,7 @@ /* AST REWRITE - * elements : ID, TRANS + * elements : TRANS, ID * token labels : * rule labels : retval * token list labels : @@ -3910,7 +3910,7 @@ /* AST REWRITE - * elements : ID, CODE_BLOCK + * elements : CODE_BLOCK, ID * token labels : * rule labels : retval * token list labels : @@ -4114,7 +4114,7 @@ /* AST REWRITE - * elements : CODE_BLOCK, ID, CODE_BLOCK, ID, items, ID, items + * elements : items, ID, CODE_BLOCK, items, ID, ID, CODE_BLOCK * token labels : * rule labels : retval * token list labels : items @@ -4584,7 +4584,7 @@ /* AST REWRITE - * elements : text, ID + * elements : ID, text * token labels : text * rule labels : retval * token list labels : @@ -5030,7 +5030,7 @@ /* AST REWRITE - * elements : ids, name + * elements : name, ids * token labels : name * rule labels : retval * token list labels : @@ -5245,7 +5245,7 @@ /* AST REWRITE - * elements : SYNC_TOK, group_elements + * elements : group_elements, SYNC_TOK * token labels : * rule labels : retval * token list labels : @@ -5560,7 +5560,7 @@ /* AST REWRITE - * elements : INT, ID + * elements : ID, INT * token labels : * rule labels : retval * token list labels : @@ -5886,7 +5886,7 @@ /* AST REWRITE - * elements : eq, constraint_block, live_def, unobserve, uncontrol + * elements : uncontrol, unobserve, constraint_block, live_def, eq * token labels : * rule labels : retval * token list labels : @@ -7136,7 +7136,7 @@ /* AST REWRITE - * elements : LIVE, ALL, ID + * elements : ID, LIVE, ALL * token labels : * rule labels : retval * token list labels : @@ -7249,7 +7249,7 @@ /* AST REWRITE - * elements : LIVE, ID + * elements : ID, LIVE * token labels : * rule labels : retval * token list labels : @@ -7930,7 +7930,7 @@ /* AST REWRITE - * elements : PRINT, ID, group_elements + * elements : group_elements, ID, PRINT * token labels : * rule labels : retval * token list labels : Modified: translator/pnscriptParser.h =================================================================== --- translator/pnscriptParser.h 2009-06-19 19:16:29 UTC (rev 79) +++ translator/pnscriptParser.h 2009-06-19 19:57:39 UTC (rev 80) @@ -2,7 +2,7 @@ * This C header file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pnscript.g - * - On : 2009-06-19 13:34:29 + * - On : 2009-06-19 14:55:03 * - for the parser : pnscriptParserParser * * Editing it, at least manually, is not wise. * This was sent by the SourceForge.net collaborative development platform, the world's largest Open Source development site. |
From: <the...@us...> - 2009-06-19 19:16:45
|
Revision: 79 http://pntool.svn.sourceforge.net/pntool/?rev=79&view=rev Author: thecodeweasel Date: 2009-06-19 19:16:29 +0000 (Fri, 19 Jun 2009) Log Message: ----------- Uncontrollable and unobservable support. Adding process list and count into the specs structure Output specs structure back to main. Currently, everything but the constraints array is built and working. Modified Paths: -------------- translator/main.c translator/pngenerator.c translator/pngenerator.g translator/pngenerator.h Modified: translator/main.c =================================================================== --- translator/main.c 2009-06-19 19:02:56 UTC (rev 78) +++ translator/main.c 2009-06-19 19:16:29 UTC (rev 79) @@ -245,6 +245,7 @@ if (treePsr->pTreeParser->rec->state->errorCount > 0) { fprintf(stderr, "The parser returned %d error(s), tree walking aborted.\n", treePsr->pTreeParser->rec->state->errorCount); } else { + specs* output; nodes = antlr3CommonTreeNodeStreamNewTree(pncompactAST.tree, ANTLR3_SIZE_HINT); // sIZE HINT WILL SOON BE DEPRECATED!! //print tree structure from the initial parsing @@ -258,7 +259,7 @@ printf("Done.\n"); fflush(stdout); printf("Generating Petri Nets...\n"); - generator->pn(generator, processes, threads, (char*) fName); + output = generator->pn(generator, processes, threads, (char*) fName); if (generator->pTreeParser->rec->state->errorCount > 0) { fprintf(stderr, "The parser returned %d error(s), code generation aborted.\n", generator->pTreeParser->rec->state->errorCount); } @@ -266,8 +267,6 @@ nodes ->free (nodes); nodes = NULL; generator ->free (generator); generator = NULL; } - - treePsr->free (treePsr); treePsr = NULL; } // We did not return anything from this parser rule, so we can finish. It only remains Modified: translator/pngenerator.c =================================================================== --- translator/pngenerator.c 2009-06-19 19:02:56 UTC (rev 78) +++ translator/pngenerator.c 2009-06-19 19:16:29 UTC (rev 79) @@ -2,7 +2,7 @@ * This C source file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pngenerator.g - * - On : 2009-06-19 13:53:39 + * - On : 2009-06-19 14:12:26 * - for the tree parser : pngeneratorTreeParser * * Editing it, at least manually, is not wise. * @@ -599,7 +599,7 @@ // Forward declare the locally static matching functions we have generated. // -static void pn (ppngenerator ctx, ASSOC_ARRAY* procData, ASSOC_ARRAY* threadData, char* fileName); +static specs* pn (ppngenerator ctx, ASSOC_ARRAY* procData, ASSOC_ARRAY* threadData, char* fileName); static void proc_definitions (ppngenerator ctx); static void def_start (ppngenerator ctx); static void trans_defs (ppngenerator ctx); @@ -843,18 +843,18 @@ /* Declare the bitsets */ -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_definitions_in_pn77 */ -static ANTLR3_BITWORD FOLLOW_proc_definitions_in_pn77_bits[] = { ANTLR3_UINT64_LIT(0x0000000000C00400) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_definitions_in_pn77 = { FOLLOW_proc_definitions_in_pn77_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_pn80 */ -static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_pn80_bits[] = { ANTLR3_UINT64_LIT(0x0000000400C00402) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_pn80 = { FOLLOW_proc_instantiations_in_pn80_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraints_in_pn83 */ -static ANTLR3_BITWORD FOLLOW_constraints_in_pn83_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000402) }; -static ANTLR3_BITSET_LIST FOLLOW_constraints_in_pn83 = { FOLLOW_constraints_in_pn83_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_other_commands_in_pn86 */ -static ANTLR3_BITWORD FOLLOW_other_commands_in_pn86_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000002) }; -static ANTLR3_BITSET_LIST FOLLOW_other_commands_in_pn86 = { FOLLOW_other_commands_in_pn86_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_definitions_in_pn75 */ +static ANTLR3_BITWORD FOLLOW_proc_definitions_in_pn75_bits[] = { ANTLR3_UINT64_LIT(0x0000000000C00400) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_definitions_in_pn75 = { FOLLOW_proc_definitions_in_pn75_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_pn78 */ +static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_pn78_bits[] = { ANTLR3_UINT64_LIT(0x0000000400C00402) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_pn78 = { FOLLOW_proc_instantiations_in_pn78_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraints_in_pn81 */ +static ANTLR3_BITWORD FOLLOW_constraints_in_pn81_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000402) }; +static ANTLR3_BITSET_LIST FOLLOW_constraints_in_pn81 = { FOLLOW_constraints_in_pn81_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_other_commands_in_pn84 */ +static ANTLR3_BITWORD FOLLOW_other_commands_in_pn84_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000002) }; +static ANTLR3_BITSET_LIST FOLLOW_other_commands_in_pn84 = { FOLLOW_other_commands_in_pn84_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_def_start_in_proc_definitions102 */ static ANTLR3_BITWORD FOLLOW_def_start_in_proc_definitions102_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; static ANTLR3_BITSET_LIST FOLLOW_def_start_in_proc_definitions102 = { FOLLOW_def_start_in_proc_definitions102_bits, 1 }; @@ -1071,45 +1071,45 @@ /** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol646 */ static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol646_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol646 = { FOLLOW_UNCONTROL_in_uncontrol646_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol648 */ -static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol648_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol648 = { FOLLOW_ID_in_uncontrol648_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve660 */ -static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve660_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve660 = { FOLLOW_UNOBSERVE_in_unobserve660_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve662 */ -static ANTLR3_BITWORD FOLLOW_ID_in_unobserve662_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve662 = { FOLLOW_ID_in_unobserve662_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands674 */ -static ANTLR3_BITWORD FOLLOW_print_in_other_commands674_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands674 = { FOLLOW_print_in_other_commands674_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print684 */ -static ANTLR3_BITWORD FOLLOW_PRINT_in_print684_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print684 = { FOLLOW_PRINT_in_print684_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print686 */ -static ANTLR3_BITWORD FOLLOW_ID_in_print686_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_print686 = { FOLLOW_ID_in_print686_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print688 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_print688_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print688 = { FOLLOW_group_elements_in_print688_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_GROUP_in_group_elements709 */ -static ANTLR3_BITWORD FOLLOW_GROUP_in_group_elements709_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_GROUP_in_group_elements709 = { FOLLOW_GROUP_in_group_elements709_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements712 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements712_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements712 = { FOLLOW_ID_in_group_elements712_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID731 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID731_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID731 = { FOLLOW_ID_in_numbered_ID731_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID739 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID739_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID739 = { FOLLOW_ID_in_numbered_ID739_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID741 */ -static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID741_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID741 = { FOLLOW_INT_in_numbered_ID741_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_synpred2_pngenerator80 */ -static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_synpred2_pngenerator80_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_synpred2_pngenerator80 = { FOLLOW_proc_instantiations_in_synpred2_pngenerator80_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol649 */ +static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol649_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol649 = { FOLLOW_ID_in_uncontrol649_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve664 */ +static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve664_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve664 = { FOLLOW_UNOBSERVE_in_unobserve664_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve667 */ +static ANTLR3_BITWORD FOLLOW_ID_in_unobserve667_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve667 = { FOLLOW_ID_in_unobserve667_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands682 */ +static ANTLR3_BITWORD FOLLOW_print_in_other_commands682_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands682 = { FOLLOW_print_in_other_commands682_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print693 */ +static ANTLR3_BITWORD FOLLOW_PRINT_in_print693_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print693 = { FOLLOW_PRINT_in_print693_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print695 */ +static ANTLR3_BITWORD FOLLOW_ID_in_print695_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_print695 = { FOLLOW_ID_in_print695_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print697 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_print697_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print697 = { FOLLOW_group_elements_in_print697_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_GROUP_in_group_elements718 */ +static ANTLR3_BITWORD FOLLOW_GROUP_in_group_elements718_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_GROUP_in_group_elements718 = { FOLLOW_GROUP_in_group_elements718_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements721 */ +static ANTLR3_BITWORD FOLLOW_ID_in_group_elements721_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements721 = { FOLLOW_ID_in_group_elements721_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID740 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID740_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID740 = { FOLLOW_ID_in_numbered_ID740_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID748 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID748_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID748 = { FOLLOW_ID_in_numbered_ID748_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID750 */ +static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID750_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID750 = { FOLLOW_INT_in_numbered_ID750_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_synpred2_pngenerator78 */ +static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_synpred2_pngenerator78_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_synpred2_pngenerator78 = { FOLLOW_proc_instantiations_in_synpred2_pngenerator78_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred29_pngenerator500 */ static ANTLR3_BITWORD FOLLOW_primary_in_synpred29_pngenerator500_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred29_pngenerator500 = { FOLLOW_primary_in_synpred29_pngenerator500_bits, 1 }; @@ -1129,7 +1129,7 @@ * DFA tables for the parser */ /** Static dfa state tables for Cyclic dfa: - * ()+ loopback of 86:22: ( proc_instantiations )+ + * ()+ loopback of 83:22: ( proc_instantiations )+ */ static const ANTLR3_INT32 dfa2_eot[7] = { @@ -1161,20 +1161,20 @@ static const ANTLR3_INT32 dfa2_T0[] = { - 3, 6, -1, -1, -1, 2, -1, -1, 5, -1, -1, -1, -1, -1, -1, -1, 2, -1, -1, - -1, -1, -1, -1, -1, 2, 2, -1, -1, 2, -1, 2, 2, -1, -1, -1, -1, -1, -1, - -1, -1, -1, -1, -1, -1, -1, 2, 2, 2 - };static const ANTLR3_INT32 dfa2_T1[] = - { 2, -1, -1, -1, 2, -1, -1, 5, -1, -1, -1, -1, -1, -1, -1, 2, -1, -1, -1, -1, -1, -1, -1, 2, 2, -1, -1, 2, -1, 2, 2, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 2, 2, 2 + };static const ANTLR3_INT32 dfa2_T1[] = + { + 4 };static const ANTLR3_INT32 dfa2_T2[] = { - 4 + -1 };static const ANTLR3_INT32 dfa2_T3[] = { - -1 + 3, 6, -1, -1, -1, 2, -1, -1, 5, -1, -1, -1, -1, -1, -1, -1, 2, -1, -1, + -1, -1, -1, -1, -1, 2, 2, -1, -1, 2, -1, 2, 2, -1, -1, -1, -1, -1, -1, + -1, -1, -1, -1, -1, -1, -1, 2, 2, 2 };static const ANTLR3_INT32 dfa2_T4[] = { 1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 3, 3, -1, -1, -1, -1, -1, @@ -1186,7 +1186,7 @@ */ static const ANTLR3_INT32 * const dfa2_transitions[] = { - dfa2_T4, dfa2_T2, dfa2_T_empty, dfa2_T_empty, dfa2_T1, dfa2_T0, dfa2_T3 + dfa2_T4, dfa2_T1, dfa2_T_empty, dfa2_T_empty, dfa2_T0, dfa2_T3, dfa2_T2 }; static ANTLR3_INT32 dfa2_sst(ppngenerator ctx, pANTLR3_BASE_RECOGNIZER recognizer, pANTLR3_INT_STREAM is, pANTLR3_CYCLIC_DFA dfa, ANTLR3_INT32 s) @@ -1239,7 +1239,7 @@ } CONSTRUCTEX(); EXCEPTION->type = ANTLR3_NO_VIABLE_ALT_EXCEPTION; - EXCEPTION->message = (void *)"()+ loopback of 86:22: ( proc_instantiations )+"; + EXCEPTION->message = (void *)"()+ loopback of 83:22: ( proc_instantiations )+"; EXCEPTION->decisionNum = 2; EXCEPTION->state = _s; return -1; @@ -1252,7 +1252,7 @@ = { 2, /* Decision number of this dfa */ /* Which decision this represents: */ - (const pANTLR3_UCHAR)"()+ loopback of 86:22: ( proc_instantiations )+", + (const pANTLR3_UCHAR)"()+ loopback of 83:22: ( proc_instantiations )+", (CDFA_SPECIAL_FUNC) dfa2_sst, antlr3dfaspecialTransition, /* DFA specialTransition is currently just a default function in the runtime */ antlr3dfapredict, /* DFA simulator function is in the runtime */ @@ -1277,11 +1277,13 @@ */ /** * $ANTLR start pn - * /Users/bion/projects/iordache/translator/pngenerator.g:75:1: pn[ASSOC_ARRAY* procData, ASSOC_ARRAY* threadData, char* fileName] : ( proc_definitions )+ ( proc_instantiations )+ ( constraints )* ( other_commands )* ; + * /Users/bion/projects/iordache/translator/pngenerator.g:75:1: pn[ASSOC_ARRAY* procData, ASSOC_ARRAY* threadData, char* fileName] returns [specs* ret] : ( proc_definitions )+ ( proc_instantiations )+ ( constraints )* ( other_commands )* ; */ -static void +static specs* pn(ppngenerator ctx, ASSOC_ARRAY* procData, ASSOC_ARRAY* threadData, char* fileName) { + specs* ret = NULL; + /* Initialize rule variables */ @@ -1294,10 +1296,10 @@ output->name = fileName; { - // /Users/bion/projects/iordache/translator/pngenerator.g:86:2: ( ( proc_definitions )+ ( proc_instantiations )+ ( constraints )* ( other_commands )* ) - // /Users/bion/projects/iordache/translator/pngenerator.g:86:4: ( proc_definitions )+ ( proc_instantiations )+ ( constraints )* ( other_commands )* + // /Users/bion/projects/iordache/translator/pngenerator.g:83:2: ( ( proc_definitions )+ ( proc_instantiations )+ ( constraints )* ( other_commands )* ) + // /Users/bion/projects/iordache/translator/pngenerator.g:83:4: ( proc_definitions )+ ( proc_instantiations )+ ( constraints )* ( other_commands )* { - // /Users/bion/projects/iordache/translator/pngenerator.g:86:4: ( proc_definitions )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:83:4: ( proc_definitions )+ { int cnt1=0; @@ -1359,7 +1361,7 @@ case 1: // /Users/bion/projects/iordache/translator/pngenerator.g:0:0: proc_definitions { - FOLLOWPUSH(FOLLOW_proc_definitions_in_pn77); + FOLLOWPUSH(FOLLOW_proc_definitions_in_pn75); proc_definitions(ctx); FOLLOWPOP(); @@ -1369,7 +1371,7 @@ } if (HASFAILED()) { - return ; + return ret; } } @@ -1384,7 +1386,7 @@ if (BACKTRACKING>0) { FAILEDFLAG = ANTLR3_TRUE; - return ; + return ret; } /* mismatchedSetEx() */ @@ -1399,7 +1401,7 @@ } loop1: ; /* Jump to here if this rule does not match */ } - // /Users/bion/projects/iordache/translator/pngenerator.g:86:22: ( proc_instantiations )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:83:22: ( proc_instantiations )+ { int cnt2=0; @@ -1413,14 +1415,14 @@ } if (HASFAILED()) { - return ; + return ret; } switch (alt2) { case 1: // /Users/bion/projects/iordache/translator/pngenerator.g:0:0: proc_instantiations { - FOLLOWPUSH(FOLLOW_proc_instantiations_in_pn80); + FOLLOWPUSH(FOLLOW_proc_instantiations_in_pn78); proc_instantiations(ctx); FOLLOWPOP(); @@ -1430,7 +1432,7 @@ } if (HASFAILED()) { - return ; + return ret; } } @@ -1445,7 +1447,7 @@ if (BACKTRACKING>0) { FAILEDFLAG = ANTLR3_TRUE; - return ; + return ret; } /* mismatchedSetEx() */ @@ -1461,7 +1463,7 @@ loop2: ; /* Jump to here if this rule does not match */ } - // /Users/bion/projects/iordache/translator/pngenerator.g:86:43: ( constraints )* + // /Users/bion/projects/iordache/translator/pngenerator.g:83:43: ( constraints )* for (;;) { @@ -1481,7 +1483,7 @@ case 1: // /Users/bion/projects/iordache/translator/pngenerator.g:0:0: constraints { - FOLLOWPUSH(FOLLOW_constraints_in_pn83); + FOLLOWPUSH(FOLLOW_constraints_in_pn81); constraints(ctx); FOLLOWPOP(); @@ -1491,7 +1493,7 @@ } if (HASFAILED()) { - return ; + return ret; } } @@ -1505,7 +1507,7 @@ loop3: ; /* Jump out to here if this rule does not match */ - // /Users/bion/projects/iordache/translator/pngenerator.g:86:56: ( other_commands )* + // /Users/bion/projects/iordache/translator/pngenerator.g:83:56: ( other_commands )* for (;;) { @@ -1525,7 +1527,7 @@ case 1: // /Users/bion/projects/iordache/translator/pngenerator.g:0:0: other_commands { - FOLLOWPUSH(FOLLOW_other_commands_in_pn86); + FOLLOWPUSH(FOLLOW_other_commands_in_pn84); other_commands(ctx); FOLLOWPOP(); @@ -1535,7 +1537,7 @@ } if (HASFAILED()) { - return ; + return ret; } } @@ -1548,7 +1550,23 @@ } loop4: ; /* Jump out to here if this rule does not match */ + if ( BACKTRACKING==0 ) + { + //put everything in the specs and ship it out! + pANTLR3_LIST list; + int i; + + output->process_num = threads->size(threads); + output->process_array = tcalloc(output->process_num, sizeof(process)); + for(i = 0; i < output->process_num; i++) { + list = (pANTLR3_LIST) threads->iter(threads, i); + output->process_array[i] = (process*) list->get(list, kPROC); + } + ret= output; + + } + } } @@ -1564,23 +1582,14 @@ PREPORTERROR(); PRECOVER(); } - else - { - if ( BACKTRACKING==0 ) - { - free(output); - - } - } - - return ; + return ret; } /* $ANTLR end pn */ /** * $ANTLR start proc_definitions - * /Users/bion/projects/iordache/translator/pngenerator.g:88:1: proc_definitions : ^( def_start ( trans_defs )* ( select_functions )* ( nondeterm )? ) ; + * /Users/bion/projects/iordache/translator/pngenerator.g:97:1: proc_definitions : ^( def_start ( trans_defs )* ( select_functions )* ( nondeterm )? ) ; */ static void proc_definitions(ppngenerator ctx) @@ -1590,8 +1599,8 @@ ctx->ppngenerator_proc_definitionsTop = ppngenerator_proc_definitionsPush(ctx); { - // /Users/bion/projects/iordache/translator/pngenerator.g:94:2: ( ^( def_start ( trans_defs )* ( select_functions )* ( nondeterm )? ) ) - // /Users/bion/projects/iordache/translator/pngenerator.g:94:4: ^( def_start ( trans_defs )* ( select_functions )* ( nondeterm )? ) + // /Users/bion/projects/iordache/translator/pngenerator.g:103:2: ( ^( def_start ( trans_defs )* ( select_functions )* ( nondeterm )? ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:103:4: ^( def_start ( trans_defs )* ( select_functions )* ( nondeterm )? ) { FOLLOWPUSH(FOLLOW_def_start_in_proc_definitions102); def_start(ctx); @@ -1621,7 +1630,7 @@ return ; } - // /Users/bion/projects/iordache/translator/pngenerator.g:94:16: ( trans_defs )* + // /Users/bion/projects/iordache/translator/pngenerator.g:103:16: ( trans_defs )* for (;;) { @@ -1667,7 +1676,7 @@ loop5: ; /* Jump out to here if this rule does not match */ - // /Users/bion/projects/iordache/translator/pngenerator.g:94:28: ( select_functions )* + // /Users/bion/projects/iordache/translator/pngenerator.g:103:28: ( select_functions )* for (;;) { @@ -1713,7 +1722,7 @@ loop6: ; /* Jump out to here if this rule does not match */ - // /Users/bion/projects/iordache/translator/pngenerator.g:94:46: ( nondeterm )? + // /Users/bion/projects/iordache/translator/pngenerator.g:103:46: ( nondeterm )? { int alt7=2; { @@ -1786,7 +1795,7 @@ /** * $ANTLR start def_start - * /Users/bion/projects/iordache/translator/pngenerator.g:95:1: def_start : ID ; + * /Users/bion/projects/iordache/translator/pngenerator.g:104:1: def_start : ID ; */ static void def_start(ppngenerator ctx) @@ -1803,8 +1812,8 @@ ID1 = NULL; { - // /Users/bion/projects/iordache/translator/pngenerator.g:99:2: ( ID ) - // /Users/bion/projects/iordache/translator/pngenerator.g:99:4: ID + // /Users/bion/projects/iordache/translator/pngenerator.g:108:2: ( ID ) + // /Users/bion/projects/iordache/translator/pngenerator.g:108:4: ID { ID1 = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_def_start126); if (HASEXCEPTION()) @@ -1862,7 +1871,7 @@ /** * $ANTLR start trans_defs - * /Users/bion/projects/iordache/translator/pngenerator.g:120:1: trans_defs : ( extern_trans_def | trans_def ); + * /Users/bion/projects/iordache/translator/pngenerator.g:129:1: trans_defs : ( extern_trans_def | trans_def ); */ static void trans_defs(ppngenerator ctx) @@ -1873,7 +1882,7 @@ { { - // /Users/bion/projects/iordache/translator/pngenerator.g:121:2: ( extern_trans_def | trans_def ) + // /Users/bion/projects/iordache/translator/pngenerator.g:130:2: ( extern_trans_def | trans_def ) ANTLR3_UINT32 alt8; @@ -1911,7 +1920,7 @@ switch (alt8) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:121:4: extern_trans_def + // /Users/bion/projects/iordache/translator/pngenerator.g:130:4: extern_trans_def { FOLLOWPUSH(FOLLOW_extern_trans_def_in_trans_defs136); extern_trans_def(ctx); @@ -1929,7 +1938,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pngenerator.g:122:4: trans_def + // /Users/bion/projects/iordache/translator/pngenerator.g:131:4: trans_def { FOLLOWPUSH(FOLLOW_trans_def_in_trans_defs141); trans_def(ctx); @@ -1969,7 +1978,7 @@ /** * $ANTLR start extern_trans_def - * /Users/bion/projects/iordache/translator/pngenerator.g:123:1: extern_trans_def : ^( ( TO | FROM ) ( ID )+ ) ; + * /Users/bion/projects/iordache/translator/pngenerator.g:132:1: extern_trans_def : ^( ( TO | FROM ) ( ID )+ ) ; */ static void extern_trans_def(ppngenerator ctx) @@ -1992,11 +2001,11 @@ ID4 = NULL; { - // /Users/bion/projects/iordache/translator/pngenerator.g:129:2: ( ^( ( TO | FROM ) ( ID )+ ) ) - // /Users/bion/projects/iordache/translator/pngenerator.g:129:4: ^( ( TO | FROM ) ( ID )+ ) + // /Users/bion/projects/iordache/translator/pngenerator.g:138:2: ( ^( ( TO | FROM ) ( ID )+ ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:138:4: ^( ( TO | FROM ) ( ID )+ ) { - // /Users/bion/projects/iordache/translator/pngenerator.g:129:6: ( TO | FROM ) + // /Users/bion/projects/iordache/translator/pngenerator.g:138:6: ( TO | FROM ) { int alt9=2; @@ -2031,7 +2040,7 @@ switch (alt9) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:129:7: TO + // /Users/bion/projects/iordache/translator/pngenerator.g:138:7: TO { TO2 = (pANTLR3_BASE_TREE) MATCHT(TO, &FOLLOW_TO_in_extern_trans_def157); if (HASEXCEPTION()) @@ -2053,7 +2062,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pngenerator.g:132:7: FROM + // /Users/bion/projects/iordache/translator/pngenerator.g:141:7: FROM { FROM3 = (pANTLR3_BASE_TREE) MATCHT(FROM, &FOLLOW_FROM_in_extern_trans_def163); if (HASEXCEPTION()) @@ -2087,7 +2096,7 @@ { return ; } - // /Users/bion/projects/iordache/translator/pngenerator.g:135:6: ( ID )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:144:6: ( ID )+ { int cnt10=0; @@ -2107,7 +2116,7 @@ switch (alt10) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:135:7: ID + // /Users/bion/projects/iordache/translator/pngenerator.g:144:7: ID { ID4 = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_extern_trans_def169); if (HASEXCEPTION()) @@ -2186,7 +2195,7 @@ /** * $ANTLR start trans_def - * /Users/bion/projects/iordache/translator/pngenerator.g:139:1: trans_def : ( ^( ID CODE_BLOCK ) | ^(tran= ID (place= ID )+ ( CODE_BLOCK )? ) | ^(tran= ID ^(pInit= ID (place= ID )+ ( CODE_BLOCK )? ) ) ); + * /Users/bion/projects/iordache/translator/pngenerator.g:148:1: trans_def : ( ^( ID CODE_BLOCK ) | ^(tran= ID (place= ID )+ ( CODE_BLOCK )? ) | ^(tran= ID ^(pInit= ID (place= ID )+ ( CODE_BLOCK )? ) ) ); */ static void trans_def(ppngenerator ctx) @@ -2225,7 +2234,7 @@ { { - // /Users/bion/projects/iordache/translator/pngenerator.g:152:2: ( ^( ID CODE_BLOCK ) | ^(tran= ID (place= ID )+ ( CODE_BLOCK )? ) | ^(tran= ID ^(pInit= ID (place= ID )+ ( CODE_BLOCK )? ) ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:161:2: ( ^( ID CODE_BLOCK ) | ^(tran= ID (place= ID )+ ( CODE_BLOCK )? ) | ^(tran= ID ^(pInit= ID (place= ID )+ ( CODE_BLOCK )? ) ) ) ANTLR3_UINT32 alt15; @@ -2339,7 +2348,7 @@ switch (alt15) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:152:4: ^( ID CODE_BLOCK ) + // /Users/bion/projects/iordache/translator/pngenerator.g:161:4: ^( ID CODE_BLOCK ) { ID5 = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_trans_def189); if (HASEXCEPTION()) @@ -2393,7 +2402,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pngenerator.g:160:4: ^(tran= ID (place= ID )+ ( CODE_BLOCK )? ) + // /Users/bion/projects/iordache/translator/pngenerator.g:169:4: ^(tran= ID (place= ID )+ ( CODE_BLOCK )? ) { tran = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_trans_def205); if (HASEXCEPTION()) @@ -2421,7 +2430,7 @@ { return ; } - // /Users/bion/projects/iordache/translator/pngenerator.g:162:5: (place= ID )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:171:5: (place= ID )+ { int cnt11=0; @@ -2441,7 +2450,7 @@ switch (alt11) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:162:6: place= ID + // /Users/bion/projects/iordache/translator/pngenerator.g:171:6: place= ID { place = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_trans_def212); if (HASEXCEPTION()) @@ -2500,7 +2509,7 @@ } - // /Users/bion/projects/iordache/translator/pngenerator.g:173:5: ( CODE_BLOCK )? + // /Users/bion/projects/iordache/translator/pngenerator.g:182:5: ( CODE_BLOCK )? { int alt12=2; { @@ -2513,7 +2522,7 @@ switch (alt12) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:173:6: CODE_BLOCK + // /Users/bion/projects/iordache/translator/pngenerator.g:182:6: CODE_BLOCK { CODE_BLOCK7 = (pANTLR3_BASE_TREE) MATCHT(CODE_BLOCK, &FOLLOW_CODE_BLOCK_in_trans_def221); if (HASEXCEPTION()) @@ -2556,7 +2565,7 @@ } break; case 3: - // /Users/bion/projects/iordache/translator/pngenerator.g:179:4: ^(tran= ID ^(pInit= ID (place= ID )+ ( CODE_BLOCK )? ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:188:4: ^(tran= ID ^(pInit= ID (place= ID )+ ( CODE_BLOCK )? ) ) { tran = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_trans_def239); if (HASEXCEPTION()) @@ -2610,7 +2619,7 @@ { return ; } - // /Users/bion/projects/iordache/translator/pngenerator.g:183:5: (place= ID )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:192:5: (place= ID )+ { int cnt13=0; @@ -2630,7 +2639,7 @@ switch (alt13) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:183:6: place= ID + // /Users/bion/projects/iordache/translator/pngenerator.g:192:6: place= ID { place = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_trans_def253); if (HASEXCEPTION()) @@ -2689,7 +2698,7 @@ } - // /Users/bion/projects/iordache/translator/pngenerator.g:194:5: ( CODE_BLOCK )? + // /Users/bion/projects/iordache/translator/pngenerator.g:203:5: ( CODE_BLOCK )? { int alt14=2; { @@ -2702,7 +2711,7 @@ switch (alt14) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:194:6: CODE_BLOCK + // /Users/bion/projects/iordache/translator/pngenerator.g:203:6: CODE_BLOCK { CODE_BLOCK8 = (pANTLR3_BASE_TREE) MATCHT(CODE_BLOCK, &FOLLOW_CODE_BLOCK_in_trans_def262); if (HASEXCEPTION()) @@ -2777,7 +2786,7 @@ /** * $ANTLR start select_functions - * /Users/bion/projects/iordache/translator/pngenerator.g:199:1: select_functions : ^( SELECT_DEF ID CODE_BLOCK ) ; + * /Users/bion/projects/iordache/translator/pngenerator.g:208:1: select_functions : ^( SELECT_DEF ID CODE_BLOCK ) ; */ static void select_functions(ppngenerator ctx) @@ -2793,8 +2802,8 @@ CODE_BLOCK10 = NULL; { - // /Users/bion/projects/iordache/translator/pngenerator.g:200:2: ( ^( SELECT_DEF ID CODE_BLOCK ) ) - // /Users/bion/projects/iordache/translator/pngenerator.g:200:4: ^( SELECT_DEF ID CODE_BLOCK ) + // /Users/bion/projects/iordache/translator/pngenerator.g:209:2: ( ^( SELECT_DEF ID CODE_BLOCK ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:209:4: ^( SELECT_DEF ID CODE_BLOCK ) { MATCHT(SELECT_DEF, &FOLLOW_SELECT_DEF_in_select_functions279); if (HASEXCEPTION()) @@ -2876,7 +2885,7 @@ /** * $ANTLR start nondeterm - * /Users/bion/projects/iordache/translator/pngenerator.g:207:1: nondeterm : ^( 'nondeterministic places: ' ( ID )+ ) ; + * /Users/bion/projects/iordache/translator/pngenerator.g:216:1: nondeterm : ^( 'nondeterministic places: ' ( ID )+ ) ; */ static void nondeterm(ppngenerator ctx) @@ -2890,8 +2899,8 @@ ID11 = NULL; { - // /Users/bion/projects/iordache/translator/pngenerator.g:208:2: ( ^( 'nondeterministic places: ' ( ID )+ ) ) - // /Users/bion/projects/iordache/translator/pngenerator.g:208:4: ^( 'nondeterministic places: ' ( ID )+ ) + // /Users/bion/projects/iordache/translator/pngenerator.g:217:2: ( ^( 'nondeterministic places: ' ( ID )+ ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:217:4: ^( 'nondeterministic places: ' ( ID )+ ) { MATCHT(45, &FOLLOW_45_in_nondeterm296); if (HASEXCEPTION()) @@ -2912,7 +2921,7 @@ { return ; } - // /Users/bion/projects/iordache/translator/pngenerator.g:208:34: ( ID )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:217:34: ( ID )+ { int cnt16=0; @@ -2932,7 +2941,7 @@ switch (alt16) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:208:35: ID + // /Users/bion/projects/iordache/translator/pngenerator.g:217:35: ID { ID11 = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_nondeterm299); if (HASEXCEPTION()) @@ -3012,7 +3021,7 @@ /** * $ANTLR start proc_instantiations - * /Users/bion/projects/iordache/translator/pngenerator.g:214:1: proc_instantiations : ( proc_init | sync_def | proc_start ); + * /Users/bion/projects/iordache/translator/pngenerator.g:223:1: proc_instantiations : ( proc_init | sync_def | proc_start ); */ static void proc_instantiations(ppngenerator ctx) @@ -3023,7 +3032,7 @@ ctx->ppngenerator_proc_instantiationsTop = ppngenerator_proc_instantiationsPush(ctx); { { - // /Users/bion/projects/iordache/translator/pngenerator.g:220:2: ( proc_init | sync_def | proc_start ) + // /Users/bion/projects/iordache/translator/pngenerator.g:229:2: ( proc_init | sync_def | proc_start ) ANTLR3_UINT32 alt17; @@ -3068,7 +3077,7 @@ switch (alt17) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:220:4: proc_init + // /Users/bion/projects/iordache/translator/pngenerator.g:229:4: proc_init { FOLLOWPUSH(FOLLOW_proc_init_in_proc_instantiations318); proc_init(ctx); @@ -3088,7 +3097,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pngenerator.g:220:16: sync_def + // /Users/bion/projects/iordache/translator/pngenerator.g:229:16: sync_def { FOLLOWPUSH(FOLLOW_sync_def_in_proc_instantiations322); sync_def(ctx); @@ -3108,7 +3117,7 @@ } break; case 3: - // /Users/bion/projects/iordache/translator/pngenerator.g:220:27: proc_start + // /Users/bion/projects/iordache/translator/pngenerator.g:229:27: proc_start { FOLLOWPUSH(FOLLOW_proc_start_in_proc_instantiations326); proc_start(ctx); @@ -3152,7 +3161,7 @@ /** * $ANTLR start proc_init - * /Users/bion/projects/iordache/translator/pngenerator.g:221:1: proc_init : ^( ID ( numbered_ID[$proc_instantiations::places] )+ ) ; + * /Users/bion/projects/iordache/translator/pngenerator.g:230:1: proc_init : ^( ID ( numbered_ID[$proc_instantiations::places] )+ ) ; */ static void proc_init(ppngenerator ctx) @@ -3175,8 +3184,8 @@ numbered_ID13 = NULL; { - // /Users/bion/projects/iordache/translator/pngenerator.g:227:2: ( ^( ID ( numbered_ID[$proc_instantiations::places] )+ ) ) - // /Users/bion/projects/iordache/translator/pngenerator.g:227:4: ^( ID ( numbered_ID[$proc_instantiations::places] )+ ) + // /Users/bion/projects/iordache/translator/pngenerator.g:236:2: ( ^( ID ( numbered_ID[$proc_instantiations::places] )+ ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:236:4: ^( ID ( numbered_ID[$proc_instantiations::places] )+ ) { ID12 = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_proc_init341); if (HASEXCEPTION()) @@ -3211,7 +3220,7 @@ { return ; } - // /Users/bion/projects/iordache/translator/pngenerator.g:236:5: ( numbered_ID[$proc_instantiations::places] )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:245:5: ( numbered_ID[$proc_instantiations::places] )+ { int cnt18=0; @@ -3231,7 +3240,7 @@ switch (alt18) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:236:6: numbered_ID[$proc_instantiations::places] + // /Users/bion/projects/iordache/translator/pngenerator.g:245:6: numbered_ID[$proc_instantiations::places] { FOLLOWPUSH(FOLLOW_numbered_ID_in_proc_init346); numbered_ID13=numbered_ID(ctx, (SCOPE_TOP(proc_instantiations))->places); @@ -3331,7 +3340,7 @@ /** * $ANTLR start sync_def - * /Users/bion/projects/iordache/translator/pngenerator.g:254:1: sync_def : ^( SYNC_TOK ( group_elements )+ ) ; + * /Users/bion/projects/iordache/translator/pngenerator.g:263:1: sync_def : ^( SYNC_TOK ( group_elements )+ ) ; */ static void sync_def(ppngenerator ctx) @@ -3351,8 +3360,8 @@ group_elements14 = NULL; { - // /Users/bion/projects/iordache/translator/pngenerator.g:259:2: ( ^( SYNC_TOK ( group_elements )+ ) ) - // /Users/bion/projects/iordache/translator/pngenerator.g:259:4: ^( SYNC_TOK ( group_elements )+ ) + // /Users/bion/projects/iordache/translator/pngenerator.g:268:2: ( ^( SYNC_TOK ( group_elements )+ ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:268:4: ^( SYNC_TOK ( group_elements )+ ) { MATCHT(SYNC_TOK, &FOLLOW_SYNC_TOK_in_sync_def369); if (HASEXCEPTION()) @@ -3373,7 +3382,7 @@ { return ; } - // /Users/bion/projects/iordache/translator/pngenerator.g:259:15: ( group_elements )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:268:15: ( group_elements )+ { int cnt19=0; @@ -3393,7 +3402,7 @@ switch (alt19) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:259:16: group_elements + // /Users/bion/projects/iordache/translator/pngenerator.g:268:16: group_elements { FOLLOWPUSH(FOLLOW_group_elements_in_sync_def372); group_elements14=group_elements(ctx); @@ -3523,7 +3532,7 @@ /** * $ANTLR start proc_start - * /Users/bion/projects/iordache/translator/pngenerator.g:307:1: proc_start : ^( START ( ID )+ ) ; + * /Users/bion/projects/iordache/translator/pngenerator.g:316:1: proc_start : ^( START ( ID )+ ) ; */ static void proc_start(ppngenerator ctx) @@ -3537,8 +3546,8 @@ ID15 = NULL; { - // /Users/bion/projects/iordache/translator/pngenerator.g:308:2: ( ^( START ( ID )+ ) ) - // /Users/bion/projects/iordache/translator/pngenerator.g:308:4: ^( START ( ID )+ ) + // /Users/bion/projects/iordache/translator/pngenerator.g:317:2: ( ^( START ( ID )+ ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:317:4: ^( START ( ID )+ ) { MATCHT(START, &FOLLOW_START_in_proc_start389); if (HASEXCEPTION()) @@ -3559,7 +3568,7 @@ { return ; } - // /Users/bion/projects/iordache/translator/pngenerator.g:308:12: ( ID )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:317:12: ( ID )+ { int cnt20=0; @@ -3579,7 +3588,7 @@ switch (alt20) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:308:13: ID + // /Users/bion/projects/iordache/translator/pngenerator.g:317:13: ID { ID15 = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_proc_start392); if (HASEXCEPTION()) @@ -3661,7 +3670,7 @@ /** * $ANTLR start constraints - * /Users/bion/projects/iordache/translator/pngenerator.g:316:1: constraints : ^( constraint_block ( eq )* ( live_def )? ( uncontrol )? ( unobserve )? ) ; + * /Users/bion/projects/iordache/translator/pngenerator.g:325:1: constraints : ^( constraint_block ( eq )* ( live_def )? ( uncontrol )? ( unobserve )? ) ; */ static void constraints(ppngenerator ctx) @@ -3671,8 +3680,8 @@ ctx->ppngenerator_constraintsTop = ppngenerator_constraintsPush(ctx); { - // /Users/bion/projects/iordache/translator/pngenerator.g:321:2: ( ^( constraint_block ( eq )* ( live_def )? ( uncontrol )? ( unobserve )? ) ) - // /Users/bion/projects/iordache/translator/pngenerator.g:321:4: ^( constraint_block ( eq )* ( live_def )? ( uncontrol )? ( unobserve )? ) + // /Users/bion/projects/iordache/translator/pngenerator.g:330:2: ( ^( constraint_block ( eq )* ( live_def )? ( uncontrol )? ( unobserve )? ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:330:4: ^( constraint_block ( eq )* ( live_def )? ( uncontrol )? ( unobserve )? ) { FOLLOWPUSH(FOLLOW_constraint_block_in_constraints412); constraint_block(ctx); @@ -3702,7 +3711,7 @@ return ; } - // /Users/bion/projects/iordache/translator/pngenerator.g:321:23: ( eq )* + // /Users/bion/projects/iordache/translator/pngenerator.g:330:23: ( eq )* for (;;) { @@ -3748,7 +3757,7 @@ loop21: ; /* Jump out to here if this rule does not match */ - // /Users/bion/projects/iordache/translator/pngenerator.g:321:27: ( live_def )? + // /Users/bion/projects/iordache/translator/pngenerator.g:330:27: ( live_def )? { int alt22=2; { @@ -3784,7 +3793,7 @@ } } - // /Users/bion/projects/iordache/translator/pngenerator.g:321:37: ( uncontrol )? + // /Users/bion/projects/iordache/translator/pngenerator.g:330:37: ( uncontrol )? { int alt23=2; { @@ -3820,7 +3829,7 @@ } } - // /Users/bion/projects/iordache/translator/pngenerator.g:321:48: ( unobserve )? + // /Users/bion/projects/iordache/translator/pngenerator.g:330:48: ( unobserve )? { int alt24=2; { @@ -3893,7 +3902,7 @@ /** * $ANTLR start constraint_block - * /Users/bion/projects/iordache/translator/pngenerator.g:322:1: constraint_block : ID ; + * /Users/bion/projects/iordache/translator/pngenerator.g:331:1: constraint_block : ID ; */ static void constraint_block(ppngenerator ctx) @@ -3907,8 +3916,8 @@ ID16 = NULL; { - // /Users/bion/projects/iordache/translator/pngenerator.g:323:2: ( ID ) - // /Users/bion/projects/iordache/translator/pngenerator.g:323:4: ID + // /Users/bion/projects/iordache/translator/pngenerator.g:332:2: ( ID ) + // /Users/bion/projects/iordache/translator/pngenerator.g:332:4: ID { ID16 = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_constraint_block433); if (HASEXCEPTION()) @@ -3959,7 +3968,7 @@ /** * $ANTLR start eq - * /Users/bion/projects/iordache/translator/pngenerator.g:338:1: eq : ( relationalExpression | ^( EQS_OP eq eq ) ); + * /Users/bion/projects/iordache/translator/pngenerator.g:347:1: eq : ( relationalExpression | ^( EQS_OP eq eq ) ); */ static void eq(ppngenerator ctx) @@ -3970,7 +3979,7 @@ { { - // /Users/bion/projects/iordache/translator/pngenerator.g:339:2: ( relationalExpression | ^( EQS_OP eq eq ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:348:2: ( relationalExpression | ^( EQS_OP eq eq ) ) ANTLR3_UINT32 alt25; @@ -4008,7 +4017,7 @@ switch (alt25) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:339:4: relationalExpression + // /Users/bion/projects/iordache/translator/pngenerator.g:348:4: relationalExpression { FOLLOWPUSH(FOLLOW_relationalExpression_in_eq445); relationalExpression(ctx); @@ -4026,7 +4035,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pngenerator.g:340:4: ^( EQS_OP eq eq ) + // /Users/bion/projects/iordache/translator/pngenerator.g:349:4: ^( EQS_OP eq eq ) { MATCHT(EQS_OP, &FOLLOW_EQS_OP_in_eq451); if (HASEXCEPTION()) @@ -4107,7 +4116,7 @@ /** * $ANTLR start relationalExpression - * /Users/bion/projects/iordache/translator/pngenerator.g:342:1: relationalExpression : ( additiveExpression | ^( EQ_OP relationalExpression relationalExpression ) ); + * /Users/bion/projects/iordache/translator/pngenerator.g:351:1: relationalExpression : ( additiveExpression | ^( EQ_OP relationalExpression relationalExpression ) ); */ static void relationalExpression(ppngenerator ctx) @@ -4118,7 +4127,7 @@ { { - // /Users/bion/projects/iordache/translator/pngenerator.g:343:5: ( additiveExpression | ^( EQ_OP relationalExpression relationalExpression ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:352:5: ( additiveExpression | ^( EQ_OP relationalExpression relationalExpression ) ) ANTLR3_UINT32 alt26; @@ -4156,7 +4165,7 @@ switch (alt26) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:343:9: additiveExpression + // /Users/bion/projects/iordache/translator/pngenerator.g:352:9: additiveExpression { FOLLOWPUSH(FOLLOW_additiveExpression_in_relationalExpression471); additiveExpression(ctx); @@ -4174,7 +4183,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pngenerator.g:344:7: ^( EQ_OP relationalExpression relationalExpression ) + // /Users/bion/projects/iordache/translator/pngenerator.g:353:7: ^( EQ_OP relationalExpression relationalExpression ) { MATCHT(EQ_OP, &FOLLOW_EQ_OP_in_relationalExpression480); if (HASEXCEPTION()) @@ -4255,7 +4264,7 @@ /** * $ANTLR start additiveExpression - * /Users/bion/projects/iordache/translator/pngenerator.g:346:1: additiveExpression : ( primary | ^( ADD additiveExpression additiveExpression ) | ^( SUB additiveExpression additiveExpression ) ); + * /Users/bion/projects/iordache/translator/pngenerator.g:355:1: additiveExpression : ( primary | ^( ADD additiveExpression additiveExpression ) | ^( SUB additiveExpression additiveExpression ) ); */ static void additiveExpression(ppngenerator ctx) @@ -4266,7 +4275,7 @@ { { - // /Users/bion/projects/iordache/translator/pngenerator.g:347:5: ( primary | ^( ADD additiveExpression additiveExpression ) | ^( SUB additiveExpression additiveExpression ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:356:5: ( primary | ^( ADD additiveExpression additiveExpression ) | ^( SUB additiveExpression additiveExpression ) ) ANTLR3_UINT32 alt27; @@ -4368,7 +4377,7 @@ switch (alt27) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:347:9: primary + // /Users/bion/projects/iordache/translator/pngenerator.g:356:9: primary { FOLLOWPUSH(FOLLOW_primary_in_additiveExpression500); primary(ctx); @@ -4386,7 +4395,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pngenerator.g:348:7: ^( ADD additiveExpression additiveExpression ) + // /Users/bion/projects/iordache/translator/pngenerator.g:357:7: ^( ADD additiveExpression additiveExpression ) { MATCHT(ADD, &FOLLOW_ADD_in_additiveExpression509); if (HASEXCEPTION()) @@ -4445,7 +4454,7 @@ } break; case 3: - // /Users/bion/projects/iordache/translator/pngenerator.g:349:7: ^( SUB additiveExpression additiveExpression ) + // /Users/bion/projects/iordache/translator/pngenerator.g:358:7: ^( SUB additiveExpression additiveExpression ) { MATCHT(SUB, &FOLLOW_SUB_in_additiveExpression523); if (HASEXCEPTION()) @@ -4526,7 +4535,7 @@ /** * $ANTLR start primary - * /Users/bion/projects/iordache/translator/pngenerator.g:351:1: primary : ( ID | group_elements | NUM | ^( MULT NUM primary ) | ^( ADD additiveExpression additiveExpression ) | ^( SUB additiveExpression additiveExpression ) ); + * /Users/bion/projects/iordache/translator/pngenerator.g:360:1: primary : ( ID | group_elements | NUM | ^( MULT NUM primary ) | ^( ADD additiveExpression additiveExpression ) | ^( SUB additiveExpression additiveExpression ) ); */ static void primary(ppngenerator ctx) @@ -4537,7 +4546,7 @@ { { - // /Users/bion/projects/iordache/translator/pngenerator.g:352:5: ( ID | group_elements | NUM | ^( MULT NUM primary ) | ^( ADD additiveExpression additiveExpression ) | ^( SUB additiveExpression additiveExpression ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:361:5: ( ID | group_elements | NUM | ^( MULT NUM primary ) | ^( ADD additiveExpression additiveExpression ) | ^( SUB additiveExpression additiveExpression ) ) ANTLR3_UINT32 alt28; @@ -4595,7 +4604,7 @@ switch (alt28) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:352:9: ID + // /Users/bion/projects/iordache/translator/pngenerator.g:361:9: ID { MATCHT(ID, &FOLLOW_ID_in_primary542); if (HASEXCEPTION()) @@ -4610,7 +4619,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pngenerator.g:353:7: group_elements + // /Users/bion/projects/iordache/translator/pngenerator.g:362:7: group_elements { FOLLOWPUSH(FOLLOW_group_elements_in_primary550); group_elements(ctx); @@ -4628,7 +4637,7 @@ } break; case 3: - // /Users/bion/projects/iordache/translator/pngenerator.g:354:7: NUM + // /Users/bion/projects/iordache/translator/pngenerator.g:363:7: NUM { MATCHT(NUM, &FOLLOW_NUM_in_primary558); if (HASEXCEPTION()) @@ -4643,7 +4652,7 @@ } break; case 4: - // /Users/bion/projects/iordache/translator/pngenerator.g:355:7: ^( MULT NUM primary ) + // /Users/bion/projects/iordache/translator/pngenerator.g:364:7: ^( MULT NUM primary ) { MATCHT(MULT, &FOLLOW_MULT_in_primary567); if (HASEXCEPTION()) @@ -4699,7 +4708,7 @@ } break; case 5: - // /Users/bion/projects/iordache/translator/pngenerator.g:356:7: ^( ADD additiveExpression additiveExpression ) + // /Users/bion/projects/iordache/translator/pngenerator.g:365:7: ^( ADD additiveExpression additiveExpression ) { MATCHT(ADD, &FOLLOW_ADD_in_primary581); if (HASEXCEPTION()) @@ -4758,7 +4767,7 @@ } break; case 6: - // /Users/bion/projects/iordache/translator/pngenerator.g:357:7: ^( SUB additiveExpression additiveExpression ) + // /Users/bion/projects/iordache/translator/pngenerator.g:366:7: ^( SUB additiveExpression additiveExpression ) { MATCHT(SUB, &FOLLOW_SUB_in_primary595); if (HASEXCEPTION()) @@ -4839,7 +4848,7 @@ /** * $ANTLR start live_def - * /Users/bion/projects/iordache/translator/pngenerator.g:358:1: live_def : ( ^( LIVE ALL ( ID )* ) | ^( LIVE ( ID )+ ) ); + * /Users/bion/projects/iordache/translator/pngenerator.g:367:1: live_def : ( ^( LIVE ALL ( ID )* ) | ^( LIVE ( ID )+ ) ); */ static void live_def(ppngenerator ctx) @@ -4856,7 +4865,7 @@ { { - // /Users/bion/projects/iordache/translator/pngenerator.g:359:2: ( ^( LIVE ALL ( ID )* ) | ^( LIVE ( ID )+ ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:368:2: ( ^( LIVE ALL ( ID )* ) | ^( LIVE ( ID )+ ) ) ANTLR3_UINT32 alt31; @@ -4942,7 +4951,7 @@ switch (alt31) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:359:4: ^( LIVE ALL ( ID )* ) + // /Users/bion/projects/iordache/translator/pngenerator.g:368:4: ^( LIVE ALL ( ID )* ) { MATCHT(LIVE, &FOLLOW_LIVE_in_live_def610); if (HASEXCEPTION()) @@ -4987,7 +4996,7 @@ } - // /Use... [truncated message content] |
From: <the...@us...> - 2009-06-19 19:03:01
|
Revision: 78 http://pntool.svn.sourceforge.net/pntool/?rev=78&view=rev Author: thecodeweasel Date: 2009-06-19 19:02:56 +0000 (Fri, 19 Jun 2009) Log Message: ----------- Start and live support. There's an additional language feature I should document here that required a hack around the traditional updatepn() protocol. The translator supports live defs in the following forms: live: all; live: t1 t2 ... tn; live: all -t1 -t2 ... -tn; //undocumented While I could have built a list of all the transitions in the process, removed the eliminated ones (if necessary), and then made all the remaining transitions live, there is a signficant performance increase in speed and memory overhead in accessing "TransInfo* t" directly. (I cannot "unlive" a transition through an updatepn() call, so building and pruning a list is the only other option) Modified Paths: -------------- translator/generator.patch translator/pngenerator.c translator/pngenerator.g translator/pngenerator.h Modified: translator/generator.patch =================================================================== --- translator/generator.patch 2009-06-19 18:36:07 UTC (rev 77) +++ translator/generator.patch 2009-06-19 19:02:56 UTC (rev 78) @@ -36,3 +36,15 @@ } // Now we decrement the scope's upper limit bound. We do not actually pop the scope as +@@ -583,9 +583,9 @@ + // + // If the user supplied the scope entries with a free function,then call it first + // +- if (SCOPE_TOP(constraints)>free != NULL) ++ if (SCOPE_TOP(constraints)->free != NULL) + { +- SCOPE_TOP(constraints)>->free(SCOPE_TOP(constraints)); ++ SCOPE_TOP(constraints)->free(SCOPE_TOP(constraints)); + } + + // Now we decrement the scope's upper limit bound. We do not actually pop the scope as Modified: translator/pngenerator.c =================================================================== --- translator/pngenerator.c 2009-06-19 18:36:07 UTC (rev 77) +++ translator/pngenerator.c 2009-06-19 19:02:56 UTC (rev 78) @@ -2,7 +2,7 @@ * This C source file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pngenerator.g - * - On : 2009-06-19 00:41:12 + * - On : 2009-06-19 13:53:39 * - for the tree parser : pngeneratorTreeParser * * Editing it, at least manually, is not wise. * @@ -369,9 +369,94 @@ return newAttributes; } +/* ruleAttributeScopeFuncDecl(scope) + */ +/* ----------------------------------------------------------------------------- + * Function declarations for creating a pngenerator_constraints scope set + */ +static ppngenerator_constraints_SCOPE ppngenerator_constraintsPush(ppngenerator ctx); +static void ANTLR3_CDECL constraintsFree(ppngenerator_constraints_SCOPE scope); +/* ----------------------------------------------------------------------------- */ +/* ruleAttributeScopeFuncs(scope) + */ +/* attributeFuncs(scope) + */ +static void ANTLR3_CDECL constraintsFree(ppngenerator_constraints_SCOPE scope) +{ + ANTLR3_FREE(scope); +} +/** \brief Allocate initial memory for a pngenerator constraints scope variable stack entry and + * add it to the top of the stack. + * + * \remark + * By default the structure is freed with ANTLR_FREE(), but you can use the + * the \@init action to install a pointer to a custom free() routine by + * adding the code: + * \code + * ctx->ppngenerator_constraintsTop->free = myroutine; + * \endcode + * + * With lots of comments of course! The routine should be declared in + * \@members { } as: + * \code + * void ANTLR3_CDECL myfunc( ppngenerator_constraints_SCOPE ptr). + * \endcode + * + * It should perform any custom freeing stuff that you need (call ANTLR_FREE3, not free() + * NB: It should not free the pointer it is given, which is the scope stack entry itself + * and will be freed by the function that calls your custom free routine. + * + */ +static ppngenerator_constraints_SCOPE +ppngenerator_constraintsPush(ppngenerator ctx) +{ + /* Pointer used to create a new set of attributes + */ + ppngenerator_constraints_SCOPE newAttributes; + + /* Allocate the memory for a new structure if we need one. + */ + if (ctx->ppngenerator_constraintsStack->size(ctx->ppngenerator_constraintsStack) > ctx->ppngenerator_constraintsStack_limit) + { + // The current limit value was less than the number of scopes available on the stack so + // we can just reuse one. Our limit tracks the stack count, so the index of the entry we want + // is one less than that, or conveniently, the current value of limit. + // + newAttributes = ctx->ppngenerator_constraintsStack->get(ctx->ppngenerator_constraintsStack, ctx->ppngenerator_constraintsStack_limit); + } + else + { + // Need a new allocation + // + newAttributes = (ppngenerator_constraints_SCOPE) ANTLR3_MALLOC(sizeof(pngenerator_constraints_SCOPE)); + if (newAttributes != NULL) + { + /* Standard ANTLR3 library implementation + */ + ctx->ppngenerator_constraintsStack->push(ctx->ppngenerator_constraintsStack, newAttributes, (void (*)(void *))constraintsFree); + } + } + + // Blank out any previous free pointer, the user might or might install a new one. + // + newAttributes->free = NULL; + + // Indicate the position in the available stack that the current level is at + // + ctx->ppngenerator_constraintsStack_limit++; + + /* Return value is the pointer to the new entry, which may be used locally + * without de-referencing via the context. + */ + return newAttributes; +} + + + + /* ============================================================================= */ /* ============================================================================= @@ -486,8 +571,32 @@ ctx->ppngenerator_proc_instantiationsStack_limit--; SCOPE_TOP(proc_instantiations) = (ppngenerator_proc_instantiations_SCOPE)(ctx->ppngenerator_proc_instantiationsStack->get(ctx->ppngenerator_proc_instantiationsStack, ctx->ppngenerator_proc_instantiationsStack_limit - 1)); } +/* ruleAttributeScopeFuncMacro(scope) + */ +/** Function for popping the top value from a ppngenerator_constraintsStack + */ +void +ppngenerator_constraintsPop(ppngenerator ctx) +{ + // First see if the user defined a function they want to be called when a + // scope is popped/freed. + // + // If the user supplied the scope entries with a free function,then call it first + // + if (SCOPE_TOP(constraints)->free != NULL) + { + SCOPE_TOP(constraints)->free(SCOPE_TOP(constraints)); + } + // Now we decrement the scope's upper limit bound. We do not actually pop the scope as + // we want to reuse scope entries if we do continuous push and pops. Most scopes don't + // next too far so we don't want to keep freeing and allocating them + // + ctx->ppngenerator_constraintsStack_limit--; + SCOPE_TOP(constraints) = (ppngenerator_constraints_SCOPE)(ctx->ppngenerator_constraintsStack->get(ctx->ppngenerator_constraintsStack, ctx->ppngenerator_constraintsStack_limit - 1)); +} + // Forward declare the locally static matching functions we have generated. // static void pn (ppngenerator ctx, ASSOC_ARRAY* procData, ASSOC_ARRAY* threadData, char* fileName); @@ -501,8 +610,8 @@ static void proc_instantiations (ppngenerator ctx); static void proc_init (ppngenerator ctx); static void sync_def (ppngenerator ctx); +static void proc_start (ppngenerator ctx); static void constraints (ppngenerator ctx); -static void proc_start (ppngenerator ctx); static void constraint_block (ppngenerator ctx); static void eq (ppngenerator ctx); static void relationalExpression (ppngenerator ctx); @@ -599,8 +708,8 @@ ctx->proc_instantiations = proc_instantiations; ctx->proc_init = proc_init; ctx->sync_def = sync_def; + ctx->proc_start = proc_start; ctx->constraints = constraints; - ctx->proc_start = proc_start; ctx->constraint_block = constraint_block; ctx->eq = eq; ctx->relationalExpression = relationalExpression; @@ -633,6 +742,12 @@ ctx->ppngenerator_proc_instantiationsStack = antlr3StackNew(0); ctx->ppngenerator_proc_instantiationsStack_limit = 0; ctx->ppngenerator_proc_instantiationsTop = NULL; + /* ruleAttributeScope(scope) + */ + ctx->ppngenerator_constraintsPush = ppngenerator_constraintsPush; + ctx->ppngenerator_constraintsStack = antlr3StackNew(0); + ctx->ppngenerator_constraintsStack_limit = 0; + ctx->ppngenerator_constraintsTop = NULL; @@ -662,6 +777,9 @@ /* ruleAttributeScope(scope) */ ctx->ppngenerator_proc_instantiationsStack->free(ctx->ppngenerator_proc_instantiationsStack); + /* ruleAttributeScope(scope) + */ + ctx->ppngenerator_constraintsStack->free(ctx->ppngenerator_constraintsStack); @@ -830,180 +948,180 @@ /** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_sync_def372 */ static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def372_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_sync_def372 = { FOLLOW_group_elements_in_sync_def372_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints390 */ -static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints390_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints390 = { FOLLOW_constraint_block_in_constraints390_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints392 */ -static ANTLR3_BITWORD FOLLOW_eq_in_constraints392_bits[] = { ANTLR3_UINT64_LIT(0x000380034C040488) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints392 = { FOLLOW_eq_in_constraints392_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints395 */ -static ANTLR3_BITWORD FOLLOW_live_def_in_constraints395_bits[] = { ANTLR3_UINT64_LIT(0x0000000300000008) }; -static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints395 = { FOLLOW_live_def_in_constraints395_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints398 */ -static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints398_bits[] = { ANTLR3_UINT64_LIT(0x0000000200000008) }; -static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints398 = { FOLLOW_uncontrol_in_constraints398_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints401 */ -static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints401_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints401 = { FOLLOW_unobserve_in_constraints401_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start414 */ -static ANTLR3_BITWORD FOLLOW_START_in_proc_start414_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start414 = { FOLLOW_START_in_proc_start414_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start416 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_start416_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start416 = { FOLLOW_ID_in_proc_start416_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block427 */ -static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block427_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block427 = { FOLLOW_ID_in_constraint_block427_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq437 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq437_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq437 = { FOLLOW_relationalExpression_in_eq437_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq443 */ -static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq443_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq443 = { FOLLOW_EQS_OP_in_eq443_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq445 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq445_bits[] = { ANTLR3_UINT64_LIT(0x000380034C040488) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq445 = { FOLLOW_eq_in_eq445_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq447 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq447_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq447 = { FOLLOW_eq_in_eq447_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression463 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression463_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression463 = { FOLLOW_additiveExpression_in_relationalExpression463_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression472 */ -static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression472_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression472 = { FOLLOW_EQ_OP_in_relationalExpression472_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression474 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression474_bits[] = { ANTLR3_UINT64_LIT(0x0003800008040488) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression474 = { FOLLOW_relationalExpression_in_relationalExpression474_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression476 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression476_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression476 = { FOLLOW_relationalExpression_in_relationalExpression476_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression492 */ -static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression492_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression492 = { FOLLOW_primary_in_additiveExpression492_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_additiveExpression501 */ -static ANTLR3_BITWORD FOLLOW_ADD_in_additiveExpression501_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ADD_in_additiveExpression501 = { FOLLOW_ADD_in_additiveExpression501_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression503 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression503_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression503 = { FOLLOW_additiveExpression_in_additiveExpression503_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression505 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression505_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression505 = { FOLLOW_additiveExpression_in_additiveExpression505_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SUB_in_additiveExpression515 */ -static ANTLR3_BITWORD FOLLOW_SUB_in_additiveExpression515_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SUB_in_additiveExpression515 = { FOLLOW_SUB_in_additiveExpression515_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression517 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression517_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression517 = { FOLLOW_additiveExpression_in_additiveExpression517_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression519 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression519_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression519 = { FOLLOW_additiveExpression_in_additiveExpression519_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_primary534 */ -static ANTLR3_BITWORD FOLLOW_ID_in_primary534_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_primary534 = { FOLLOW_ID_in_primary534_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary542 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_primary542_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary542 = { FOLLOW_group_elements_in_primary542_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_primary550 */ -static ANTLR3_BITWORD FOLLOW_NUM_in_primary550_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_NUM_in_primary550 = { FOLLOW_NUM_in_primary550_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary559 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_primary559_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary559 = { FOLLOW_MULT_in_primary559_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_primary561 */ -static ANTLR3_BITWORD FOLLOW_NUM_in_primary561_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; -static ANTLR3_BITSET_LIST FOLLOW_NUM_in_primary561 = { FOLLOW_NUM_in_primary561_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary563 */ -static ANTLR3_BITWORD FOLLOW_primary_in_primary563_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary563 = { FOLLOW_primary_in_primary563_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_primary573 */ -static ANTLR3_BITWORD FOLLOW_ADD_in_primary573_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ADD_in_primary573 = { FOLLOW_ADD_in_primary573_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary575 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary575_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary575 = { FOLLOW_additiveExpression_in_primary575_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary577 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary577_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary577 = { FOLLOW_additiveExpression_in_primary577_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SUB_in_primary587 */ -static ANTLR3_BITWORD FOLLOW_SUB_in_primary587_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SUB_in_primary587 = { FOLLOW_SUB_in_primary587_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary589 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary589_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary589 = { FOLLOW_additiveExpression_in_primary589_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary591 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary591_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary591 = { FOLLOW_additiveExpression_in_primary591_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def602 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def602_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def602 = { FOLLOW_LIVE_in_live_def602_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def604 */ -static ANTLR3_BITWORD FOLLOW_ALL_in_live_def604_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def604 = { FOLLOW_ALL_in_live_def604_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def606 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def606_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def606 = { FOLLOW_ID_in_live_def606_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def614 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def614_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def614 = { FOLLOW_LIVE_in_live_def614_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def616 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def616_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def616 = { FOLLOW_ID_in_live_def616_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol628 */ -static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol628_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol628 = { FOLLOW_UNCONTROL_in_uncontrol628_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol630 */ -static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol630_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol630 = { FOLLOW_ID_in_uncontrol630_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve642 */ -static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve642_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve642 = { FOLLOW_UNOBSERVE_in_unobserve642_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve644 */ -static ANTLR3_BITWORD FOLLOW_ID_in_unobserve644_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve644 = { FOLLOW_ID_in_unobserve644_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands656 */ -static ANTLR3_BITWORD FOLLOW_print_in_other_commands656_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands656 = { FOLLOW_print_in_other_commands656_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print666 */ -static ANTLR3_BITWORD FOLLOW_PRINT_in_print666_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print666 = { FOLLOW_PRINT_in_print666_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print668 */ -static ANTLR3_BITWORD FOLLOW_ID_in_print668_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_print668 = { FOLLOW_ID_in_print668_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print670 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_print670_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print670 = { FOLLOW_group_elements_in_print670_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_GROUP_in_group_elements691 */ -static ANTLR3_BITWORD FOLLOW_GROUP_in_group_elements691_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_GROUP_in_group_elements691 = { FOLLOW_GROUP_in_group_elements691_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements694 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements694_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements694 = { FOLLOW_ID_in_group_elements694_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID713 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID713_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID713 = { FOLLOW_ID_in_numbered_ID713_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID721 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID721_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID721 = { FOLLOW_ID_in_numbered_ID721_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID723 */ -static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID723_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID723 = { FOLLOW_INT_in_numbered_ID723_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start389 */ +static ANTLR3_BITWORD FOLLOW_START_in_proc_start389_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start389 = { FOLLOW_START_in_proc_start389_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start392 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_start392_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start392 = { FOLLOW_ID_in_proc_start392_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints412 */ +static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints412_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints412 = { FOLLOW_constraint_block_in_constraints412_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints414 */ +static ANTLR3_BITWORD FOLLOW_eq_in_constraints414_bits[] = { ANTLR3_UINT64_LIT(0x000380034C040488) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints414 = { FOLLOW_eq_in_constraints414_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints417 */ +static ANTLR3_BITWORD FOLLOW_live_def_in_constraints417_bits[] = { ANTLR3_UINT64_LIT(0x0000000300000008) }; +static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints417 = { FOLLOW_live_def_in_constraints417_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints420 */ +static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints420_bits[] = { ANTLR3_UINT64_LIT(0x0000000200000008) }; +static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints420 = { FOLLOW_uncontrol_in_constraints420_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints423 */ +static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints423_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints423 = { FOLLOW_unobserve_in_constraints423_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block433 */ +static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block433_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block433 = { FOLLOW_ID_in_constraint_block433_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq445 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq445_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq445 = { FOLLOW_relationalExpression_in_eq445_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq451 */ +static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq451_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq451 = { FOLLOW_EQS_OP_in_eq451_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq453 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq453_bits[] = { ANTLR3_UINT64_LIT(0x000380034C040488) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq453 = { FOLLOW_eq_in_eq453_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq455 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq455_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq455 = { FOLLOW_eq_in_eq455_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression471 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression471_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression471 = { FOLLOW_additiveExpression_in_relationalExpression471_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression480 */ +static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression480_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression480 = { FOLLOW_EQ_OP_in_relationalExpression480_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression482 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression482_bits[] = { ANTLR3_UINT64_LIT(0x0003800008040488) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression482 = { FOLLOW_relationalExpression_in_relationalExpression482_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression484 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression484_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression484 = { FOLLOW_relationalExpression_in_relationalExpression484_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression500 */ +static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression500_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression500 = { FOLLOW_primary_in_additiveExpression500_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_additiveExpression509 */ +static ANTLR3_BITWORD FOLLOW_ADD_in_additiveExpression509_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ADD_in_additiveExpression509 = { FOLLOW_ADD_in_additiveExpression509_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression511 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression511_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression511 = { FOLLOW_additiveExpression_in_additiveExpression511_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression513 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression513_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression513 = { FOLLOW_additiveExpression_in_additiveExpression513_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SUB_in_additiveExpression523 */ +static ANTLR3_BITWORD FOLLOW_SUB_in_additiveExpression523_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SUB_in_additiveExpression523 = { FOLLOW_SUB_in_additiveExpression523_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression525 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression525_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression525 = { FOLLOW_additiveExpression_in_additiveExpression525_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression527 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression527_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression527 = { FOLLOW_additiveExpression_in_additiveExpression527_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_primary542 */ +static ANTLR3_BITWORD FOLLOW_ID_in_primary542_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_primary542 = { FOLLOW_ID_in_primary542_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary550 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_primary550_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary550 = { FOLLOW_group_elements_in_primary550_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_primary558 */ +static ANTLR3_BITWORD FOLLOW_NUM_in_primary558_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_NUM_in_primary558 = { FOLLOW_NUM_in_primary558_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary567 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_primary567_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary567 = { FOLLOW_MULT_in_primary567_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_primary569 */ +static ANTLR3_BITWORD FOLLOW_NUM_in_primary569_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; +static ANTLR3_BITSET_LIST FOLLOW_NUM_in_primary569 = { FOLLOW_NUM_in_primary569_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary571 */ +static ANTLR3_BITWORD FOLLOW_primary_in_primary571_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary571 = { FOLLOW_primary_in_primary571_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_primary581 */ +static ANTLR3_BITWORD FOLLOW_ADD_in_primary581_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ADD_in_primary581 = { FOLLOW_ADD_in_primary581_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary583 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary583_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary583 = { FOLLOW_additiveExpression_in_primary583_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary585 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary585_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary585 = { FOLLOW_additiveExpression_in_primary585_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SUB_in_primary595 */ +static ANTLR3_BITWORD FOLLOW_SUB_in_primary595_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SUB_in_primary595 = { FOLLOW_SUB_in_primary595_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary597 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary597_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary597 = { FOLLOW_additiveExpression_in_primary597_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary599 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary599_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary599 = { FOLLOW_additiveExpression_in_primary599_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def610 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def610_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def610 = { FOLLOW_LIVE_in_live_def610_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def612 */ +static ANTLR3_BITWORD FOLLOW_ALL_in_live_def612_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def612 = { FOLLOW_ALL_in_live_def612_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def617 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def617_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def617 = { FOLLOW_ID_in_live_def617_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def628 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def628_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def628 = { FOLLOW_LIVE_in_live_def628_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def631 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def631_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def631 = { FOLLOW_ID_in_live_def631_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol646 */ +static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol646_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol646 = { FOLLOW_UNCONTROL_in_uncontrol646_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol648 */ +static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol648_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol648 = { FOLLOW_ID_in_uncontrol648_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve660 */ +static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve660_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve660 = { FOLLOW_UNOBSERVE_in_unobserve660_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve662 */ +static ANTLR3_BITWORD FOLLOW_ID_in_unobserve662_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve662 = { FOLLOW_ID_in_unobserve662_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands674 */ +static ANTLR3_BITWORD FOLLOW_print_in_other_commands674_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands674 = { FOLLOW_print_in_other_commands674_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print684 */ +static ANTLR3_BITWORD FOLLOW_PRINT_in_print684_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print684 = { FOLLOW_PRINT_in_print684_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print686 */ +static ANTLR3_BITWORD FOLLOW_ID_in_print686_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_print686 = { FOLLOW_ID_in_print686_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print688 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_print688_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print688 = { FOLLOW_group_elements_in_print688_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_GROUP_in_group_elements709 */ +static ANTLR3_BITWORD FOLLOW_GROUP_in_group_elements709_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_GROUP_in_group_elements709 = { FOLLOW_GROUP_in_group_elements709_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements712 */ +static ANTLR3_BITWORD FOLLOW_ID_in_group_elements712_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements712 = { FOLLOW_ID_in_group_elements712_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID731 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID731_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID731 = { FOLLOW_ID_in_numbered_ID731_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID739 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID739_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID739 = { FOLLOW_ID_in_numbered_ID739_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID741 */ +static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID741_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID741 = { FOLLOW_INT_in_numbered_ID741_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_synpred2_pngenerator80 */ static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_synpred2_pngenerator80_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_synpred2_pngenerator80 = { FOLLOW_proc_instantiations_in_synpred2_pngenerator80_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred29_pngenerator492 */ -static ANTLR3_BITWORD FOLLOW_primary_in_synpred29_pngenerator492_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred29_pngenerator492 = { FOLLOW_primary_in_synpred29_pngenerator492_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_synpred30_pngenerator501 */ -static ANTLR3_BITWORD FOLLOW_ADD_in_synpred30_pngenerator501_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ADD_in_synpred30_pngenerator501 = { FOLLOW_ADD_in_synpred30_pngenerator501_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_synpred30_pngenerator503 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_synpred30_pngenerator503_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_synpred30_pngenerator503 = { FOLLOW_additiveExpression_in_synpred30_pngenerator503_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_synpred30_pngenerator505 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_synpred30_pngenerator505_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_synpred30_pngenerator505 = { FOLLOW_additiveExpression_in_synpred30_pngenerator505_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred29_pngenerator500 */ +static ANTLR3_BITWORD FOLLOW_primary_in_synpred29_pngenerator500_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred29_pngenerator500 = { FOLLOW_primary_in_synpred29_pngenerator500_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_synpred30_pngenerator509 */ +static ANTLR3_BITWORD FOLLOW_ADD_in_synpred30_pngenerator509_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ADD_in_synpred30_pngenerator509 = { FOLLOW_ADD_in_synpred30_pngenerator509_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_synpred30_pngenerator511 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_synpred30_pngenerator511_bits[] = { ANTLR3_UINT64_LIT(0x0003800000040488) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_synpred30_pngenerator511 = { FOLLOW_additiveExpression_in_synpred30_pngenerator511_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_synpred30_pngenerator513 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_synpred30_pngenerator513_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_synpred30_pngenerator513 = { FOLLOW_additiveExpression_in_synpred30_pngenerator513_bits, 1 }; @@ -1043,24 +1161,24 @@ static const ANTLR3_INT32 dfa2_T0[] = { + 3, 6, -1, -1, -1, 2, -1, -1, 5, -1, -1, -1, -1, -1, -1, -1, 2, -1, -1, + -1, -1, -1, -1, -1, 2, 2, -1, -1, 2, -1, 2, 2, -1, -1, -1, -1, -1, -1, + -1, -1, -1, -1, -1, -1, -1, 2, 2, 2 + };static const ANTLR3_INT32 dfa2_T1[] = + { 2, -1, -1, -1, 2, -1, -1, 5, -1, -1, -1, -1, -1, -1, -1, 2, -1, -1, -1, -1, -1, -1, -1, 2, 2, -1, -1, 2, -1, 2, 2, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 2, 2, 2 - };static const ANTLR3_INT32 dfa2_T1[] = - { - 1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 3, 3, -1, -1, -1, -1, -1, - -1, -1, -1, -1, -1, 2 };static const ANTLR3_INT32 dfa2_T2[] = { - -1 + 4 };static const ANTLR3_INT32 dfa2_T3[] = { - 3, 6, -1, -1, -1, 2, -1, -1, 5, -1, -1, -1, -1, -1, -1, -1, 2, -1, -1, - -1, -1, -1, -1, -1, 2, 2, -1, -1, 2, -1, 2, 2, -1, -1, -1, -1, -1, -1, - -1, -1, -1, -1, -1, -1, -1, 2, 2, 2 + -1 };static const ANTLR3_INT32 dfa2_T4[] = { - 4 + 1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 3, 3, -1, -1, -1, -1, -1, + -1, -1, -1, -1, -1, 2 }; /* Transition tables are a table of sub tables, with some tables @@ -1068,7 +1186,7 @@ */ static const ANTLR3_INT32 * const dfa2_transitions[] = { - dfa2_T1, dfa2_T4, dfa2_T_empty, dfa2_T_empty, dfa2_T0, dfa2_T3, dfa2_T2 + dfa2_T4, dfa2_T2, dfa2_T_empty, dfa2_T_empty, dfa2_T1, dfa2_T0, dfa2_T3 }; static ANTLR3_INT32 dfa2_sst(ppngenerator ctx, pANTLR3_BASE_RECOGNIZER recognizer, pANTLR3_INT_STREAM is, pANTLR3_CYCLIC_DFA dfa, ANTLR3_INT32 s) @@ -3404,8 +3522,146 @@ /* $ANTLR end sync_def */ /** + * $ANTLR start proc_start + * /Users/bion/projects/iordache/translator/pngenerator.g:307:1: proc_start : ^( START ( ID )+ ) ; + */ +static void +proc_start(ppngenerator ctx) +{ + pANTLR3_BASE_TREE ID15; + + /* Initialize rule variables + */ + + + ID15 = NULL; + + { + // /Users/bion/projects/iordache/translator/pngenerator.g:308:2: ( ^( START ( ID )+ ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:308:4: ^( START ( ID )+ ) + { + MATCHT(START, &FOLLOW_START_in_proc_start389); + if (HASEXCEPTION()) + { + goto ruleproc_startEx; + } + if (HASFAILED()) + { + return ; + } + + MATCHT(ANTLR3_TOKEN_DOWN, NULL); + if (HASEXCEPTION()) + { + goto ruleproc_startEx; + } + if (HASFAILED()) + { + return ; + } + // /Users/bion/projects/iordache/translator/pngenerator.g:308:12: ( ID )+ + { + int cnt20=0; + + for (;;) + { + int alt20=2; + { + /* dfaLoopbackState(k,edges,eotPredictsAlt,description,stateNumber,semPredState) + */ + int LA20_0 = LA(1); + if ( (LA20_0 == ID) ) + { + alt20=1; + } + + } + switch (alt20) + { + case 1: + // /Users/bion/projects/iordache/translator/pngenerator.g:308:13: ID + { + ID15 = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_proc_start392); + if (HASEXCEPTION()) + { + goto ruleproc_startEx; + } + if (HASFAILED()) + { + return ; + } + if ( BACKTRACKING==0 ) + { + + process* proc; + pANTLR3_LIST list; + list = (pANTLR3_LIST) threads->get(threads, (char*) (ID15->getText(ID15))->chars); + proc = (process*) list->get(list, kPROC); + proc->start = 1; + + } + + } + break; + + default: + + if ( cnt20 >= 1 ) + { + goto loop20; + } + if (BACKTRACKING>0) + { + FAILEDFLAG = ANTLR3_TRUE; + return ; + } + /* mismatchedSetEx() + */ + CONSTRUCTEX(); + EXCEPTION->type = ANTLR3_EARLY_EXIT_EXCEPTION; + EXCEPTION->name = (void *)ANTLR3_EARLY_EXIT_NAME; + + + goto ruleproc_startEx; + } + cnt20++; + } + loop20: ; /* Jump to here if this rule does not match */ + } + + MATCHT(ANTLR3_TOKEN_UP, NULL); + if (HASEXCEPTION()) + { + goto ruleproc_startEx; + } + if (HASFAILED()) + { + return ; + } + + } + + } + + + // This is where rules clean up and exit + // + goto ruleproc_startEx; /* Prevent compiler warnings */ + ruleproc_startEx: ; + + if (HASEXCEPTION()) + { + PREPORTERROR(); + PRECOVER(); + } + + return ; +} +/* $ANTLR end proc_start */ + +/** * $ANTLR start constraints - * /Users/bion/projects/iordache/translator/pngenerator.g:308:1: constraints : ^( constraint_block ( eq )* ( live_def )? ( uncontrol )? ( unobserve )? ) ; + * /Users/bion/projects/iordache/translator/pngenerator.g:316:1: constraints : ^( constraint_block ( eq )* ( live_def )? ( uncontrol )? ( unobserve )? ) ; */ static void constraints(ppngenerator ctx) @@ -3413,12 +3669,12 @@ /* Initialize rule variables */ - + ctx->ppngenerator_constraintsTop = ppngenerator_constraintsPush(ctx); { - // /Users/bion/projects/iordache/translator/pngenerator.g:309:2: ( ^( constraint_block ( eq )* ( live_def )? ( uncontrol )? ( unobserve )? ) ) - // /Users/bion/projects/iordache/translator/pngenerator.g:309:4: ^( constraint_block ( eq )* ( live_def )? ( uncontrol )? ( unobserve )? ) + // /Users/bion/projects/iordache/translator/pngenerator.g:321:2: ( ^( constraint_block ( eq )* ( live_def )? ( uncontrol )? ( unobserve )? ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:321:4: ^( constraint_block ( eq )* ( live_def )? ( uncontrol )? ( unobserve )? ) { - FOLLOWPUSH(FOLLOW_constraint_block_in_constraints390); + FOLLOWPUSH(FOLLOW_constraint_block_in_constraints412); constraint_block(ctx); FOLLOWPOP(); @@ -3428,6 +3684,8 @@ } if (HASFAILED()) { + ppngenerator_constraintsPop(ctx); + return ; } @@ -3439,30 +3697,32 @@ } if (HASFAILED()) { + ppngenerator_constraintsPop(ctx); + return ; } - // /Users/bion/projects/iordache/translator/pngenerator.g:309:23: ( eq )* + // /Users/bion/projects/iordache/translator/pngenerator.g:321:23: ( eq )* for (;;) { - int alt20=2; + int alt21=2; { /* dfaLoopbackState(k,edges,eotPredictsAlt,description,stateNumber,semPredState) */ - int LA20_0 = LA(1); - if ( (LA20_0 == GROUP || LA20_0 == ID || LA20_0 == MULT || ((LA20_0 >= EQS_OP) && (LA20_0 <= EQ_OP)) || ((LA20_0 >= ADD) && (LA20_0 <= NUM))) ) + int LA21_0 = LA(1); + if ( (LA21_0 == GROUP || LA21_0 == ID || LA21_0 == MULT || ((LA21_0 >= EQS_OP) && (LA21_0 <= EQ_OP)) || ((LA21_0 >= ADD) && (LA21_0 <= NUM))) ) { - alt20=1; + alt21=1; } } - switch (alt20) + switch (alt21) { case 1: // /Users/bion/projects/iordache/translator/pngenerator.g:0:0: eq { - FOLLOWPUSH(FOLLOW_eq_in_constraints392); + FOLLOWPUSH(FOLLOW_eq_in_constraints414); eq(ctx); FOLLOWPOP(); @@ -3472,6 +3732,8 @@ } if (HASFAILED()) { + ppngenerator_constraintsPop(ctx); + return ; } @@ -3479,29 +3741,29 @@ break; default: - goto loop20; /* break out of the loop */ + goto loop21; /* break out of the loop */ break; } } - loop20: ; /* Jump out to here if this rule does not match */ + loop21: ; /* Jump out to here if this rule does not match */ - // /Users/bion/projects/iordache/translator/pngenerator.g:309:27: ( live_def )? + // /Users/bion/projects/iordache/translator/pngenerator.g:321:27: ( live_def )? { - int alt21=2; + int alt22=2; { - int LA21_0 = LA(1); - if ( (LA21_0 == LIVE) ) + int LA22_0 = LA(1); + if ( (LA22_0 == LIVE) ) { - alt21=1; + alt22=1; } } - switch (alt21) + switch (alt22) { case 1: // /Users/bion/projects/iordache/translator/pngenerator.g:0:0: live_def { - FOLLOWPUSH(FOLLOW_live_def_in_constraints395); + FOLLOWPUSH(FOLLOW_live_def_in_constraints417); live_def(ctx); FOLLOWPOP(); @@ -3511,6 +3773,8 @@ } if (HASFAILED()) { + ppngenerator_constraintsPop(ctx); + return ; } @@ -3520,22 +3784,22 @@ } } - // /Users/bion/projects/iordache/translator/pngenerator.g:309:37: ( uncontrol )? + // /Users/bion/projects/iordache/translator/pngenerator.g:321:37: ( uncontrol )? { - int alt22=2; + int alt23=2; { - int LA22_0 = LA(1); - if ( (LA22_0 == UNCONTROL) ) + int LA23_0 = LA(1); + if ( (LA23_0 == UNCONTROL) ) { - alt22=1; + alt23=1; } } - switch (alt22) + switch (alt23) { case 1: // /Users/bion/projects/iordache/translator/pngenerator.g:0:0: uncontrol { - FOLLOWPUSH(FOLLOW_uncontrol_in_constraints398); + FOLLOWPUSH(FOLLOW_uncontrol_in_constraints420); uncontrol(ctx); FOLLOWPOP(); @@ -3545,6 +3809,8 @@ } if (HASFAILED()) { + ppngenerator_constraintsPop(ctx); + return ; } @@ -3554,22 +3820,22 @@ } } - // /Users/bion/projects/iordache/translator/pngenerator.g:309:48: ( unobserve )? + // /Users/bion/projects/iordache/translator/pngenerator.g:321:48: ( unobserve )? { - int alt23=2; + int alt24=2; { - int LA23_0 = LA(1); - if ( (LA23_0 == UNOBSERVE) ) + int LA24_0 = LA(1); + if ( (LA24_0 == UNOBSERVE) ) { - alt23=1; + alt24=1; } } - switch (alt23) + switch (alt24) { case 1: // /Users/bion/projects/iordache/translator/pngenerator.g:0:0: unobserve { - FOLLOWPUSH(FOLLOW_unobserve_in_constraints401); + FOLLOWPUSH(FOLLOW_unobserve_in_constraints423); unobserve(ctx); FOLLOWPOP(); @@ -3579,6 +3845,8 @@ } if (HASFAILED()) { + ppngenerator_constraintsPop(ctx); + return ; } @@ -3595,6 +3863,8 @@ ... [truncated message content] |
From: <the...@us...> - 2009-06-19 18:36:29
|
Revision: 77 http://pntool.svn.sourceforge.net/pntool/?rev=77&view=rev Author: thecodeweasel Date: 2009-06-19 18:36:07 +0000 (Fri, 19 Jun 2009) Log Message: ----------- Protection against live, uncontrollable, and unobservable declarations in a global context. Modified Paths: -------------- translator/pnscript.g translator/pnscriptLexer.c translator/pnscriptLexer.h translator/pnscriptParser.c translator/pnscriptParser.h Modified: translator/pnscript.g =================================================================== --- translator/pnscript.g 2009-06-19 05:42:32 UTC (rev 76) +++ translator/pnscript.g 2009-06-19 18:36:07 UTC (rev 77) @@ -289,7 +289,7 @@ } : proc=ID name=ID { if(0 == strcasecmp((char*) $name.text->chars, (char*) "global")) { - fprintf(stderr, "ERROR: Sorry, you cannot name a thread \"\%s\"\n", $name.text->chars); + fprintf(stderr, "ERROR: Sorry, you cannot name a thread \"\%s\".\n", $name.text->chars); FAIL_AT($name); } list = (pANTLR3_LIST) processes->get(processes, (char*) $proc.text->chars); @@ -445,7 +445,12 @@ } | number (MULT^ primary)?; live_def - : LIVE ( + : LIVE { + if($constraints::procName == NULL) { + fprintf(stderr, "ERROR: The \"live\" keyword is not valid in a global context.\n"); + FAIL_AT($LIVE); + } + } ( ALL (MINUS id1=ID { if(NULL == $constraints::places->get($constraints::places, (char*) $id1.text->chars)) { if(NULL == $constraints::trans->get($constraints::trans, (char*) $id1.text->chars)) { @@ -464,7 +469,12 @@ })+ -> ^(LIVE ID+) ) END; uncontrol - : UNCONTROL (ID { + : UNCONTROL { + if($constraints::procName == NULL) { + fprintf(stderr, "ERROR: The \"uncontrollable\" keyword is not valid in a global context.\n"); + FAIL_AT($UNCONTROL); + } + } (ID { if(NULL == $constraints::places->get($constraints::places, (char*) $ID.text->chars)) { if(NULL == $constraints::trans->get($constraints::trans, (char*) $ID.text->chars)) { fprintf(stderr, "ERROR: You did not declare a place or transition \%s in process \%s\n", $ID.text->chars, $constraints::procName); @@ -473,7 +483,12 @@ } })+ END -> ^(UNCONTROL ID+); unobserve - : UNOBSERVE (ID { + : UNOBSERVE { + if($constraints::procName == NULL) { + fprintf(stderr, "ERROR: The \"unobservable\" keyword is not valid in a global context.\n"); + FAIL_AT($UNOBSERVE); + } + } (ID { if(NULL == $constraints::places->get($constraints::places, (char*) $ID.text->chars)) { if(NULL == $constraints::trans->get($constraints::trans, (char*) $ID.text->chars)) { fprintf(stderr, "ERROR: You did not declare a place or transition \%s in process \%s\n", $ID.text->chars, $constraints::procName); Modified: translator/pnscriptLexer.c =================================================================== --- translator/pnscriptLexer.c 2009-06-19 05:42:32 UTC (rev 76) +++ translator/pnscriptLexer.c 2009-06-19 18:36:07 UTC (rev 77) @@ -2,7 +2,7 @@ * This C source file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pnscript.g - * - On : 2009-06-19 00:27:27 + * - On : 2009-06-19 13:34:29 * - for the lexer : pnscriptLexerLexer * * Editing it, at least manually, is not wise. * @@ -1275,7 +1275,7 @@ } // $ANTLR end T__46 -// Comes from: 498:2: ( 'extern' ) +// Comes from: 513:2: ( 'extern' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start EXTERN @@ -1295,8 +1295,8 @@ _type = EXTERN; - // /Users/bion/projects/iordache/translator/pnscript.g:498:2: ( 'extern' ) - // /Users/bion/projects/iordache/translator/pnscript.g:498:4: 'extern' + // /Users/bion/projects/iordache/translator/pnscript.g:513:2: ( 'extern' ) + // /Users/bion/projects/iordache/translator/pnscript.g:513:4: 'extern' { MATCHS(lit_4); if (HASEXCEPTION()) @@ -1318,7 +1318,7 @@ } // $ANTLR end EXTERN -// Comes from: 500:2: ( 'process' ) +// Comes from: 515:2: ( 'process' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start PROCESS @@ -1338,8 +1338,8 @@ _type = PROCESS; - // /Users/bion/projects/iordache/translator/pnscript.g:500:2: ( 'process' ) - // /Users/bion/projects/iordache/translator/pnscript.g:500:4: 'process' + // /Users/bion/projects/iordache/translator/pnscript.g:515:2: ( 'process' ) + // /Users/bion/projects/iordache/translator/pnscript.g:515:4: 'process' { MATCHS(lit_5); if (HASEXCEPTION()) @@ -1361,7 +1361,7 @@ } // $ANTLR end PROCESS -// Comes from: 502:2: ( 'build' ':' ) +// Comes from: 517:2: ( 'build' ':' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start BUILD @@ -1381,8 +1381,8 @@ _type = BUILD; - // /Users/bion/projects/iordache/translator/pnscript.g:502:2: ( 'build' ':' ) - // /Users/bion/projects/iordache/translator/pnscript.g:502:4: 'build' ':' + // /Users/bion/projects/iordache/translator/pnscript.g:517:2: ( 'build' ':' ) + // /Users/bion/projects/iordache/translator/pnscript.g:517:4: 'build' ':' { MATCHS(lit_6); if (HASEXCEPTION()) @@ -1410,7 +1410,7 @@ } // $ANTLR end BUILD -// Comes from: 504:2: ( 'include' ':' ) +// Comes from: 519:2: ( 'include' ':' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start INCLUDE @@ -1430,8 +1430,8 @@ _type = INCLUDE; - // /Users/bion/projects/iordache/translator/pnscript.g:504:2: ( 'include' ':' ) - // /Users/bion/projects/iordache/translator/pnscript.g:504:4: 'include' ':' + // /Users/bion/projects/iordache/translator/pnscript.g:519:2: ( 'include' ':' ) + // /Users/bion/projects/iordache/translator/pnscript.g:519:4: 'include' ':' { MATCHS(lit_7); if (HASEXCEPTION()) @@ -1459,7 +1459,7 @@ } // $ANTLR end INCLUDE -// Comes from: 507:2: ( '.PN:' ) +// Comes from: 522:2: ( '.PN:' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start PNDEF @@ -1479,8 +1479,8 @@ _type = PNDEF; - // /Users/bion/projects/iordache/translator/pnscript.g:507:2: ( '.PN:' ) - // /Users/bion/projects/iordache/translator/pnscript.g:507:4: '.PN:' + // /Users/bion/projects/iordache/translator/pnscript.g:522:2: ( '.PN:' ) + // /Users/bion/projects/iordache/translator/pnscript.g:522:4: '.PN:' { MATCHS(lit_8); if (HASEXCEPTION()) @@ -1502,7 +1502,7 @@ } // $ANTLR end PNDEF -// Comes from: 509:2: ( 'places' ':' ) +// Comes from: 524:2: ( 'places' ':' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start PLACES @@ -1522,8 +1522,8 @@ _type = PLACES; - // /Users/bion/projects/iordache/translator/pnscript.g:509:2: ( 'places' ':' ) - // /Users/bion/projects/iordache/translator/pnscript.g:509:4: 'places' ':' + // /Users/bion/projects/iordache/translator/pnscript.g:524:2: ( 'places' ':' ) + // /Users/bion/projects/iordache/translator/pnscript.g:524:4: 'places' ':' { MATCHS(lit_9); if (HASEXCEPTION()) @@ -1551,7 +1551,7 @@ } // $ANTLR end PLACES -// Comes from: 511:2: ( 'trans' ( 'itions' )? ':' ) +// Comes from: 526:2: ( 'trans' ( 'itions' )? ':' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start TRANS @@ -1571,8 +1571,8 @@ _type = TRANS; - // /Users/bion/projects/iordache/translator/pnscript.g:511:2: ( 'trans' ( 'itions' )? ':' ) - // /Users/bion/projects/iordache/translator/pnscript.g:511:4: 'trans' ( 'itions' )? ':' + // /Users/bion/projects/iordache/translator/pnscript.g:526:2: ( 'trans' ( 'itions' )? ':' ) + // /Users/bion/projects/iordache/translator/pnscript.g:526:4: 'trans' ( 'itions' )? ':' { MATCHS(lit_10); if (HASEXCEPTION()) @@ -1582,7 +1582,7 @@ - // /Users/bion/projects/iordache/translator/pnscript.g:511:12: ( 'itions' )? + // /Users/bion/projects/iordache/translator/pnscript.g:526:12: ( 'itions' )? { int alt1=2; { @@ -1595,7 +1595,7 @@ switch (alt1) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:511:12: 'itions' + // /Users/bion/projects/iordache/translator/pnscript.g:526:12: 'itions' { MATCHS(lit_11); if (HASEXCEPTION()) @@ -1629,7 +1629,7 @@ } // $ANTLR end TRANS -// Comes from: 513:2: ( '.code:' ) +// Comes from: 528:2: ( '.code:' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start CODE @@ -1649,8 +1649,8 @@ _type = CODE; - // /Users/bion/projects/iordache/translator/pnscript.g:513:2: ( '.code:' ) - // /Users/bion/projects/iordache/translator/pnscript.g:513:4: '.code:' + // /Users/bion/projects/iordache/translator/pnscript.g:528:2: ( '.code:' ) + // /Users/bion/projects/iordache/translator/pnscript.g:528:4: '.code:' { MATCHS(lit_12); if (HASEXCEPTION()) @@ -1672,7 +1672,7 @@ } // $ANTLR end CODE -// Comes from: 515:2: ( 'select function' ) +// Comes from: 530:2: ( 'select function' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start SELECT_DEF @@ -1692,8 +1692,8 @@ _type = SELECT_DEF; - // /Users/bion/projects/iordache/translator/pnscript.g:515:2: ( 'select function' ) - // /Users/bion/projects/iordache/translator/pnscript.g:515:4: 'select function' + // /Users/bion/projects/iordache/translator/pnscript.g:530:2: ( 'select function' ) + // /Users/bion/projects/iordache/translator/pnscript.g:530:4: 'select function' { MATCHS(lit_13); if (HASEXCEPTION()) @@ -1715,7 +1715,7 @@ } // $ANTLR end SELECT_DEF -// Comes from: 518:2: ( 'sync' ) +// Comes from: 533:2: ( 'sync' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start SYNC_TOK @@ -1735,8 +1735,8 @@ _type = SYNC_TOK; - // /Users/bion/projects/iordache/translator/pnscript.g:518:2: ( 'sync' ) - // /Users/bion/projects/iordache/translator/pnscript.g:518:4: 'sync' + // /Users/bion/projects/iordache/translator/pnscript.g:533:2: ( 'sync' ) + // /Users/bion/projects/iordache/translator/pnscript.g:533:4: 'sync' { MATCHS(lit_14); if (HASEXCEPTION()) @@ -1758,7 +1758,7 @@ } // $ANTLR end SYNC_TOK -// Comes from: 520:2: ( 'start' ) +// Comes from: 535:2: ( 'start' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start START @@ -1778,8 +1778,8 @@ _type = START; - // /Users/bion/projects/iordache/translator/pnscript.g:520:2: ( 'start' ) - // /Users/bion/projects/iordache/translator/pnscript.g:520:4: 'start' + // /Users/bion/projects/iordache/translator/pnscript.g:535:2: ( 'start' ) + // /Users/bion/projects/iordache/translator/pnscript.g:535:4: 'start' { MATCHS(lit_15); if (HASEXCEPTION()) @@ -1801,7 +1801,7 @@ } // $ANTLR end START -// Comes from: 523:2: ( '.constraints:' ) +// Comes from: 538:2: ( '.constraints:' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start CONSTRAINTS @@ -1821,8 +1821,8 @@ _type = CONSTRAINTS; - // /Users/bion/projects/iordache/translator/pnscript.g:523:2: ( '.constraints:' ) - // /Users/bion/projects/iordache/translator/pnscript.g:523:4: '.constraints:' + // /Users/bion/projects/iordache/translator/pnscript.g:538:2: ( '.constraints:' ) + // /Users/bion/projects/iordache/translator/pnscript.g:538:4: '.constraints:' { MATCHS(lit_16); if (HASEXCEPTION()) @@ -1844,7 +1844,7 @@ } // $ANTLR end CONSTRAINTS -// Comes from: 525:2: ( '||' | '&&' | 'or' | 'OR' | 'and' | 'AND' ) +// Comes from: 540:2: ( '||' | '&&' | 'or' | 'OR' | 'and' | 'AND' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start EQS_OP @@ -1865,7 +1865,7 @@ { - // /Users/bion/projects/iordache/translator/pnscript.g:525:2: ( '||' | '&&' | 'or' | 'OR' | 'and' | 'AND' ) + // /Users/bion/projects/iordache/translator/pnscript.g:540:2: ( '||' | '&&' | 'or' | 'OR' | 'and' | 'AND' ) ANTLR3_UINT32 alt2; @@ -1918,7 +1918,7 @@ switch (alt2) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:525:4: '||' + // /Users/bion/projects/iordache/translator/pnscript.g:540:4: '||' { MATCHS(lit_17); if (HASEXCEPTION()) @@ -1931,7 +1931,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pnscript.g:525:9: '&&' + // /Users/bion/projects/iordache/translator/pnscript.g:540:9: '&&' { MATCHS(lit_18); if (HASEXCEPTION()) @@ -1944,7 +1944,7 @@ } break; case 3: - // /Users/bion/projects/iordache/translator/pnscript.g:525:14: 'or' + // /Users/bion/projects/iordache/translator/pnscript.g:540:14: 'or' { MATCHS(lit_19); if (HASEXCEPTION()) @@ -1957,7 +1957,7 @@ } break; case 4: - // /Users/bion/projects/iordache/translator/pnscript.g:525:19: 'OR' + // /Users/bion/projects/iordache/translator/pnscript.g:540:19: 'OR' { MATCHS(lit_20); if (HASEXCEPTION()) @@ -1970,7 +1970,7 @@ } break; case 5: - // /Users/bion/projects/iordache/translator/pnscript.g:525:24: 'and' + // /Users/bion/projects/iordache/translator/pnscript.g:540:24: 'and' { MATCHS(lit_21); if (HASEXCEPTION()) @@ -1983,7 +1983,7 @@ } break; case 6: - // /Users/bion/projects/iordache/translator/pnscript.g:525:30: 'AND' + // /Users/bion/projects/iordache/translator/pnscript.g:540:30: 'AND' { MATCHS(lit_22); if (HASEXCEPTION()) @@ -2008,7 +2008,7 @@ } // $ANTLR end EQS_OP -// Comes from: 527:2: ( '<' | '<=' | '=' | '!=' | '>=' | '>' ) +// Comes from: 542:2: ( '<' | '<=' | '=' | '!=' | '>=' | '>' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start EQ_OP @@ -2029,7 +2029,7 @@ { - // /Users/bion/projects/iordache/translator/pnscript.g:527:2: ( '<' | '<=' | '=' | '!=' | '>=' | '>' ) + // /Users/bion/projects/iordache/translator/pnscript.g:542:2: ( '<' | '<=' | '=' | '!=' | '>=' | '>' ) ANTLR3_UINT32 alt3; @@ -2092,7 +2092,7 @@ switch (alt3) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:527:4: '<' + // /Users/bion/projects/iordache/translator/pnscript.g:542:4: '<' { MATCHC('<'); if (HASEXCEPTION()) @@ -2104,7 +2104,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pnscript.g:527:8: '<=' + // /Users/bion/projects/iordache/translator/pnscript.g:542:8: '<=' { MATCHS(lit_23); if (HASEXCEPTION()) @@ -2117,7 +2117,7 @@ } break; case 3: - // /Users/bion/projects/iordache/translator/pnscript.g:527:13: '=' + // /Users/bion/projects/iordache/translator/pnscript.g:542:13: '=' { MATCHC('='); if (HASEXCEPTION()) @@ -2129,7 +2129,7 @@ } break; case 4: - // /Users/bion/projects/iordache/translator/pnscript.g:527:17: '!=' + // /Users/bion/projects/iordache/translator/pnscript.g:542:17: '!=' { MATCHS(lit_24); if (HASEXCEPTION()) @@ -2142,7 +2142,7 @@ } break; case 5: - // /Users/bion/projects/iordache/translator/pnscript.g:527:22: '>=' + // /Users/bion/projects/iordache/translator/pnscript.g:542:22: '>=' { MATCHS(lit_25); if (HASEXCEPTION()) @@ -2155,7 +2155,7 @@ } break; case 6: - // /Users/bion/projects/iordache/translator/pnscript.g:527:27: '>' + // /Users/bion/projects/iordache/translator/pnscript.g:542:27: '>' { MATCHC('>'); if (HASEXCEPTION()) @@ -2179,7 +2179,7 @@ } // $ANTLR end EQ_OP -// Comes from: 529:2: ( '*' ) +// Comes from: 544:2: ( '*' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start MULT @@ -2199,8 +2199,8 @@ _type = MULT; - // /Users/bion/projects/iordache/translator/pnscript.g:529:2: ( '*' ) - // /Users/bion/projects/iordache/translator/pnscript.g:529:4: '*' + // /Users/bion/projects/iordache/translator/pnscript.g:544:2: ( '*' ) + // /Users/bion/projects/iordache/translator/pnscript.g:544:4: '*' { MATCHC('*'); if (HASEXCEPTION()) @@ -2221,7 +2221,7 @@ } // $ANTLR end MULT -// Comes from: 531:2: ( 'live:' ) +// Comes from: 546:2: ( 'live:' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start LIVE @@ -2241,8 +2241,8 @@ _type = LIVE; - // /Users/bion/projects/iordache/translator/pnscript.g:531:2: ( 'live:' ) - // /Users/bion/projects/iordache/translator/pnscript.g:531:4: 'live:' + // /Users/bion/projects/iordache/translator/pnscript.g:546:2: ( 'live:' ) + // /Users/bion/projects/iordache/translator/pnscript.g:546:4: 'live:' { MATCHS(lit_26); if (HASEXCEPTION()) @@ -2264,7 +2264,7 @@ } // $ANTLR end LIVE -// Comes from: 532:5: ( 'all' | 'All' | 'ALL' ) +// Comes from: 547:5: ( 'all' | 'All' | 'ALL' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start ALL @@ -2285,7 +2285,7 @@ { - // /Users/bion/projects/iordache/translator/pnscript.g:532:5: ( 'all' | 'All' | 'ALL' ) + // /Users/bion/projects/iordache/translator/pnscript.g:547:5: ( 'all' | 'All' | 'ALL' ) ANTLR3_UINT32 alt4; @@ -2341,7 +2341,7 @@ switch (alt4) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:532:7: 'all' + // /Users/bion/projects/iordache/translator/pnscript.g:547:7: 'all' { MATCHS(lit_27); if (HASEXCEPTION()) @@ -2354,7 +2354,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pnscript.g:532:13: 'All' + // /Users/bion/projects/iordache/translator/pnscript.g:547:13: 'All' { MATCHS(lit_28); if (HASEXCEPTION()) @@ -2367,7 +2367,7 @@ } break; case 3: - // /Users/bion/projects/iordache/translator/pnscript.g:532:19: 'ALL' + // /Users/bion/projects/iordache/translator/pnscript.g:547:19: 'ALL' { MATCHS(lit_29); if (HASEXCEPTION()) @@ -2392,7 +2392,7 @@ } // $ANTLR end ALL -// Comes from: 534:2: ( 'uncontrollable: ' ) +// Comes from: 549:2: ( 'uncontrollable: ' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start UNCONTROL @@ -2412,8 +2412,8 @@ _type = UNCONTROL; - // /Users/bion/projects/iordache/translator/pnscript.g:534:2: ( 'uncontrollable: ' ) - // /Users/bion/projects/iordache/translator/pnscript.g:534:4: 'uncontrollable: ' + // /Users/bion/projects/iordache/translator/pnscript.g:549:2: ( 'uncontrollable: ' ) + // /Users/bion/projects/iordache/translator/pnscript.g:549:4: 'uncontrollable: ' { MATCHS(lit_30); if (HASEXCEPTION()) @@ -2435,7 +2435,7 @@ } // $ANTLR end UNCONTROL -// Comes from: 536:2: ( 'unobservable: ' ) +// Comes from: 551:2: ( 'unobservable: ' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start UNOBSERVE @@ -2455,8 +2455,8 @@ _type = UNOBSERVE; - // /Users/bion/projects/iordache/translator/pnscript.g:536:2: ( 'unobservable: ' ) - // /Users/bion/projects/iordache/translator/pnscript.g:536:4: 'unobservable: ' + // /Users/bion/projects/iordache/translator/pnscript.g:551:2: ( 'unobservable: ' ) + // /Users/bion/projects/iordache/translator/pnscript.g:551:4: 'unobservable: ' { MATCHS(lit_31); if (HASEXCEPTION()) @@ -2478,7 +2478,7 @@ } // $ANTLR end UNOBSERVE -// Comes from: 539:2: ( 'print' ) +// Comes from: 554:2: ( 'print' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start PRINT @@ -2498,8 +2498,8 @@ _type = PRINT; - // /Users/bion/projects/iordache/translator/pnscript.g:539:2: ( 'print' ) - // /Users/bion/projects/iordache/translator/pnscript.g:539:4: 'print' + // /Users/bion/projects/iordache/translator/pnscript.g:554:2: ( 'print' ) + // /Users/bion/projects/iordache/translator/pnscript.g:554:4: 'print' { MATCHS(lit_32); if (HASEXCEPTION()) @@ -2521,7 +2521,7 @@ } // $ANTLR end PRINT -// Comes from: 544:2: ( '{' ( CODE_BLOCK | STRING | ~ ( '{' | '}' | '\\\"' | '\\'' ) )* '}' ) +// Comes from: 559:2: ( '{' ( CODE_BLOCK | STRING | ~ ( '{' | '}' | '\\\"' | '\\'' ) )* '}' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start CODE_BLOCK @@ -2541,8 +2541,8 @@ _type = CODE_BLOCK; - // /Users/bion/projects/iordache/translator/pnscript.g:544:2: ( '{' ( CODE_BLOCK | STRING | ~ ( '{' | '}' | '\\\"' | '\\'' ) )* '}' ) - // /Users/bion/projects/iordache/translator/pnscript.g:544:4: '{' ( CODE_BLOCK | STRING | ~ ( '{' | '}' | '\\\"' | '\\'' ) )* '}' + // /Users/bion/projects/iordache/translator/pnscript.g:559:2: ( '{' ( CODE_BLOCK | STRING | ~ ( '{' | '}' | '\\\"' | '\\'' ) )* '}' ) + // /Users/bion/projects/iordache/translator/pnscript.g:559:4: '{' ( CODE_BLOCK | STRING | ~ ( '{' | '}' | '\\\"' | '\\'' ) )* '}' { MATCHC('{'); if (HASEXCEPTION()) @@ -2551,7 +2551,7 @@ } - // /Users/bion/projects/iordache/translator/pnscript.g:544:8: ( CODE_BLOCK | STRING | ~ ( '{' | '}' | '\\\"' | '\\'' ) )* + // /Users/bion/projects/iordache/translator/pnscript.g:559:8: ( CODE_BLOCK | STRING | ~ ( '{' | '}' | '\\\"' | '\\'' ) )* for (;;) { @@ -2577,9 +2577,9 @@ switch (alt5) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:544:10: CODE_BLOCK + // /Users/bion/projects/iordache/translator/pnscript.g:559:10: CODE_BLOCK { - /* 544:10: CODE_BLOCK */ + /* 559:10: CODE_BLOCK */ mCODE_BLOCK(ctx ); if (HASEXCEPTION()) { @@ -2590,9 +2590,9 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pnscript.g:544:23: STRING + // /Users/bion/projects/iordache/translator/pnscript.g:559:23: STRING { - /* 544:23: STRING */ + /* 559:23: STRING */ mSTRING(ctx ); if (HASEXCEPTION()) { @@ -2603,7 +2603,7 @@ } break; case 3: - // /Users/bion/projects/iordache/translator/pnscript.g:544:32: ~ ( '{' | '}' | '\\\"' | '\\'' ) + // /Users/bion/projects/iordache/translator/pnscript.g:559:32: ~ ( '{' | '}' | '\\\"' | '\\'' ) { if ( ((LA(1) >= 0x0000) && (LA(1) <= '!')) || ((LA(1) >= '#') && (LA(1) <= '&')) || ((LA(1) >= '(') && (LA(1) <= 'z')) || LA(1) == '|' || ((LA(1) >= '~') && (LA(1) <= 0xFFFF)) ) { @@ -2649,7 +2649,7 @@ } // $ANTLR end CODE_BLOCK -// Comes from: 547:2: ( '\\'' ( CHAR_ESC | ~ ( '\\\\' | '\\'' ) )* '\\'' | '\\\"' ( CHAR_ESC | ~ ( '\\\\' | '\\\"' ) )* '\\\"' ) +// Comes from: 562:2: ( '\\'' ( CHAR_ESC | ~ ( '\\\\' | '\\'' ) )* '\\'' | '\\\"' ( CHAR_ESC | ~ ( '\\\\' | '\\\"' ) )* '\\\"' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start STRING @@ -2670,7 +2670,7 @@ { - // /Users/bion/projects/iordache/translator/pnscript.g:547:2: ( '\\'' ( CHAR_ESC | ~ ( '\\\\' | '\\'' ) )* '\\'' | '\\\"' ( CHAR_ESC | ~ ( '\\\\' | '\\\"' ) )* '\\\"' ) + // /Users/bion/projects/iordache/translator/pnscript.g:562:2: ( '\\'' ( CHAR_ESC | ~ ( '\\\\' | '\\'' ) )* '\\'' | '\\\"' ( CHAR_ESC | ~ ( '\\\\' | '\\\"' ) )* '\\\"' ) ANTLR3_UINT32 alt8; @@ -2703,7 +2703,7 @@ switch (alt8) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:547:4: '\\'' ( CHAR_ESC | ~ ( '\\\\' | '\\'' ) )* '\\'' + // /Users/bion/projects/iordache/translator/pnscript.g:562:4: '\\'' ( CHAR_ESC | ~ ( '\\\\' | '\\'' ) )* '\\'' { MATCHC('\''); if (HASEXCEPTION()) @@ -2712,7 +2712,7 @@ } - // /Users/bion/projects/iordache/translator/pnscript.g:547:9: ( CHAR_ESC | ~ ( '\\\\' | '\\'' ) )* + // /Users/bion/projects/iordache/translator/pnscript.g:562:9: ( CHAR_ESC | ~ ( '\\\\' | '\\'' ) )* for (;;) { @@ -2734,9 +2734,9 @@ switch (alt6) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:547:10: CHAR_ESC + // /Users/bion/projects/iordache/translator/pnscript.g:562:10: CHAR_ESC { - /* 547:10: CHAR_ESC */ + /* 562:10: CHAR_ESC */ mCHAR_ESC(ctx ); if (HASEXCEPTION()) { @@ -2747,7 +2747,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pnscript.g:547:19: ~ ( '\\\\' | '\\'' ) + // /Users/bion/projects/iordache/translator/pnscript.g:562:19: ~ ( '\\\\' | '\\'' ) { if ( ((LA(1) >= 0x0000) && (LA(1) <= '&')) || ((LA(1) >= '(') && (LA(1) <= '[')) || ((LA(1) >= ']') && (LA(1) <= 0xFFFF)) ) { @@ -2784,7 +2784,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pnscript.g:548:4: '\\\"' ( CHAR_ESC | ~ ( '\\\\' | '\\\"' ) )* '\\\"' + // /Users/bion/projects/iordache/translator/pnscript.g:563:4: '\\\"' ( CHAR_ESC | ~ ( '\\\\' | '\\\"' ) )* '\\\"' { MATCHC('\"'); if (HASEXCEPTION()) @@ -2793,7 +2793,7 @@ } - // /Users/bion/projects/iordache/translator/pnscript.g:548:9: ( CHAR_ESC | ~ ( '\\\\' | '\\\"' ) )* + // /Users/bion/projects/iordache/translator/pnscript.g:563:9: ( CHAR_ESC | ~ ( '\\\\' | '\\\"' ) )* for (;;) { @@ -2815,9 +2815,9 @@ switch (alt7) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:548:10: CHAR_ESC + // /Users/bion/projects/iordache/translator/pnscript.g:563:10: CHAR_ESC { - /* 548:10: CHAR_ESC */ + /* 563:10: CHAR_ESC */ mCHAR_ESC(ctx ); if (HASEXCEPTION()) { @@ -2828,7 +2828,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pnscript.g:548:19: ~ ( '\\\\' | '\\\"' ) + // /Users/bion/projects/iordache/translator/pnscript.g:563:19: ~ ( '\\\\' | '\\\"' ) { if ( ((LA(1) >= 0x0000) && (LA(1) <= '!')) || ((LA(1) >= '#') && (LA(1) <= '[')) || ((LA(1) >= ']') && (LA(1) <= 0xFFFF)) ) { @@ -2877,7 +2877,7 @@ } // $ANTLR end STRING -// Comes from: 550:2: ( '\\\\\\'' | '\\\\\\\"' | '\\\\' ~ ( '\\'' | '\\\"' ) ) +// Comes from: 565:2: ( '\\\\\\'' | '\\\\\\\"' | '\\\\' ~ ( '\\'' | '\\\"' ) ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start CHAR_ESC @@ -2898,7 +2898,7 @@ { - // /Users/bion/projects/iordache/translator/pnscript.g:550:2: ( '\\\\\\'' | '\\\\\\\"' | '\\\\' ~ ( '\\'' | '\\\"' ) ) + // /Users/bion/projects/iordache/translator/pnscript.g:565:2: ( '\\\\\\'' | '\\\\\\\"' | '\\\\' ~ ( '\\'' | '\\\"' ) ) ANTLR3_UINT32 alt9; @@ -2954,7 +2954,7 @@ switch (alt9) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:550:4: '\\\\\\'' + // /Users/bion/projects/iordache/translator/pnscript.g:565:4: '\\\\\\'' { MATCHS(lit_33); if (HASEXCEPTION()) @@ -2967,7 +2967,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pnscript.g:551:4: '\\\\\\\"' + // /Users/bion/projects/iordache/translator/pnscript.g:566:4: '\\\\\\\"' { MATCHS(lit_34); if (HASEXCEPTION()) @@ -2980,7 +2980,7 @@ } break; case 3: - // /Users/bion/projects/iordache/translator/pnscript.g:552:4: '\\\\' ~ ( '\\'' | '\\\"' ) + // /Users/bion/projects/iordache/translator/pnscript.g:567:4: '\\\\' ~ ( '\\'' | '\\\"' ) { MATCHC('\\'); if (HASEXCEPTION()) @@ -3018,7 +3018,7 @@ } // $ANTLR end CHAR_ESC -// Comes from: 555:2: ( '.' ) +// Comes from: 570:2: ( '.' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start DOT @@ -3038,8 +3038,8 @@ _type = DOT; - // /Users/bion/projects/iordache/translator/pnscript.g:555:2: ( '.' ) - // /Users/bion/projects/iordache/translator/pnscript.g:555:4: '.' + // /Users/bion/projects/iordache/translator/pnscript.g:570:2: ( '.' ) + // /Users/bion/projects/iordache/translator/pnscript.g:570:4: '.' { MATCHC('.'); if (HASEXCEPTION()) @@ -3060,7 +3060,7 @@ } // $ANTLR end DOT -// Comes from: 557:2: ( '+' ) +// Comes from: 572:2: ( '+' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start PLUS @@ -3080,8 +3080,8 @@ _type = PLUS; - // /Users/bion/projects/iordache/translator/pnscript.g:557:2: ( '+' ) - // /Users/bion/projects/iordache/translator/pnscript.g:557:4: '+' + // /Users/bion/projects/iordache/translator/pnscript.g:572:2: ( '+' ) + // /Users/bion/projects/iordache/translator/pnscript.g:572:4: '+' { MATCHC('+'); if (HASEXCEPTION()) @@ -3102,7 +3102,7 @@ } // $ANTLR end PLUS -// Comes from: 559:2: ( '-' ) +// Comes from: 574:2: ( '-' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start MINUS @@ -3122,8 +3122,8 @@ _type = MINUS; - // /Users/bion/projects/iordache/translator/pnscript.g:559:2: ( '-' ) - // /Users/bion/projects/iordache/translator/pnscript.g:559:4: '-' + // /Users/bion/projects/iordache/translator/pnscript.g:574:2: ( '-' ) + // /Users/bion/projects/iordache/translator/pnscript.g:574:4: '-' { MATCHC('-'); if (HASEXCEPTION()) @@ -3144,7 +3144,7 @@ } // $ANTLR end MINUS -// Comes from: 561:2: ( ( '0' .. '9' )+ ) +// Comes from: 576:2: ( ( '0' .. '9' )+ ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start INT @@ -3164,10 +3164,10 @@ _type = INT; - // /Users/bion/projects/iordache/translator/pnscript.g:561:2: ( ( '0' .. '9' )+ ) - // /Users/bion/projects/iordache/translator/pnscript.g:561:5: ( '0' .. '9' )+ + // /Users/bion/projects/iordache/translator/pnscript.g:576:2: ( ( '0' .. '9' )+ ) + // /Users/bion/projects/iordache/translator/pnscript.g:576:5: ( '0' .. '9' )+ { - // /Users/bion/projects/iordache/translator/pnscript.g:561:5: ( '0' .. '9' )+ + // /Users/bion/projects/iordache/translator/pnscript.g:576:5: ( '0' .. '9' )+ { int cnt10=0; @@ -3187,7 +3187,7 @@ switch (alt10) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:561:5: '0' .. '9' + // /Users/bion/projects/iordache/translator/pnscript.g:576:5: '0' .. '9' { MATCHRANGE('0', '9'); if (HASEXCEPTION()) @@ -3231,7 +3231,7 @@ } // $ANTLR end INT -// Comes from: 563:2: ( ( 'A' .. 'Z' | 'a' .. 'z' ) ( 'A' .. 'Z' | 'a' .. 'z' | '0' .. '9' | '_' )* ) +// Comes from: 578:2: ( ( 'A' .. 'Z' | 'a' .. 'z' ) ( 'A' .. 'Z' | 'a' .. 'z' | '0' .. '9' | '_' )* ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start ID @@ -3251,8 +3251,8 @@ _type = ID; - // /Users/bion/projects/iordache/translator/pnscript.g:563:2: ( ( 'A' .. 'Z' | 'a' .. 'z' ) ( 'A' .. 'Z' | 'a' .. 'z' | '0' .. '9' | '_' )* ) - // /Users/bion/projects/iordache/translator/pnscript.g:563:4: ( 'A' .. 'Z' | 'a' .. 'z' ) ( 'A' .. 'Z' | 'a' .. 'z' | '0' .. '9' | '_' )* + // /Users/bion/projects/iordache/translator/pnscript.g:578:2: ( ( 'A' .. 'Z' | 'a' .. 'z' ) ( 'A' .. 'Z' | 'a' .. 'z' | '0' .. '9' | '_' )* ) + // /Users/bion/projects/iordache/translator/pnscript.g:578:4: ( 'A' .. 'Z' | 'a' .. 'z' ) ( 'A' .. 'Z' | 'a' .. 'z' | '0' .. '9' | '_' )* { if ( ((LA(1) >= 'A') && (LA(1) <= 'Z')) || ((LA(1) >= 'a') && (LA(1) <= 'z')) ) { @@ -3269,7 +3269,7 @@ } - // /Users/bion/projects/iordache/translator/pnscript.g:563:24: ( 'A' .. 'Z' | 'a' .. 'z' | '0' .. '9' | '_' )* + // /Users/bion/projects/iordache/translator/pnscript.g:578:24: ( 'A' .. 'Z' | 'a' .. 'z' | '0' .. '9' | '_' )* for (;;) { @@ -3327,7 +3327,7 @@ } // $ANTLR end ID -// Comes from: 567:2: ( ( ';' )+ ) +// Comes from: 582:2: ( ( ';' )+ ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start END @@ -3347,10 +3347,10 @@ _type = END; - // /Users/bion/projects/iordache/translator/pnscript.g:567:2: ( ( ';' )+ ) - // /Users/bion/projects/iordache/translator/pnscript.g:567:4: ( ';' )+ + // /Users/bion/projects/iordache/translator/pnscript.g:582:2: ( ( ';' )+ ) + // /Users/bion/projects/iordache/translator/pnscript.g:582:4: ( ';' )+ { - // /Users/bion/projects/iordache/translator/pnscript.g:567:4: ( ';' )+ + // /Users/bion/projects/iordache/translator/pnscript.g:582:4: ( ';' )+ { int cnt12=0; @@ -3370,7 +3370,7 @@ switch (alt12) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:567:4: ';' + // /Users/bion/projects/iordache/translator/pnscript.g:582:4: ';' { MATCHC(';'); if (HASEXCEPTION()) @@ -3414,7 +3414,7 @@ } // $ANTLR end END -// Comes from: 571:2: ( ( ' ' | '\\t' | '\\r' | '\\n' )+ ) +// Comes from: 586:2: ( ( ' ' | '\\t' | '\\r' | '\\n' )+ ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start WS @@ -3434,10 +3434,10 @@ _type = WS; - // /Users/bion/projects/iordache/translator/pnscript.g:571:2: ( ( ' ' | '\\t' | '\\r' | '\\n' )+ ) - // /Users/bion/projects/iordache/translator/pnscript.g:571:5: ( ' ' | '\\t' | '\\r' | '\\n' )+ + // /Users/bion/projects/iordache/translator/pnscript.g:586:2: ( ( ' ' | '\\t' | '\\r' | '\\n' )+ ) + // /Users/bion/projects/iordache/translator/pnscript.g:586:5: ( ' ' | '\\t' | '\\r' | '\\n' )+ { - // /Users/bion/projects/iordache/translator/pnscript.g:571:5: ( ' ' | '\\t' | '\\r' | '\\n' )+ + // /Users/bion/projects/iordache/translator/pnscript.g:586:5: ( ' ' | '\\t' | '\\r' | '\\n' )+ { int cnt13=0; @@ -3512,7 +3512,7 @@ } // $ANTLR end WS -// Comes from: 574:2: ( '//' ( . )* '\\n' ) +// Comes from: 589:2: ( '//' ( . )* '\\n' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start COMMENT @@ -3532,8 +3532,8 @@ _type = COMMENT; - // /Users/bion/projects/iordache/translator/pnscript.g:574:2: ( '//' ( . )* '\\n' ) - // /Users/bion/projects/iordache/translator/pnscript.g:574:5: '//' ( . )* '\\n' + // /Users/bion/projects/iordache/translator/pnscript.g:589:2: ( '//' ( . )* '\\n' ) + // /Users/bion/projects/iordache/translator/pnscript.g:589:5: '//' ( . )* '\\n' { MATCHS(lit_35); if (HASEXCEPTION()) @@ -3543,7 +3543,7 @@ - // /Users/bion/projects/iordache/translator/pnscript.g:574:10: ( . )* + // /Users/bion/projects/iordache/translator/pnscript.g:589:10: ( . )* for (;;) { @@ -3565,7 +3565,7 @@ switch (alt14) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:574:10: . + // /Users/bion/projects/iordache/translator/pnscript.g:589:10: . { MATCHANY(); if (HASEXCEPTION()) @@ -3606,7 +3606,7 @@ } // $ANTLR end COMMENT -// Comes from: 577:2: ( '/*' ( . )* '*/' ) +// Comes from: 592:2: ( '/*' ( . )* '*/' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start BLOCK_COMMENT @@ -3626,8 +3626,8 @@ _type = BLOCK_COMMENT; - // /Users/bion/projects/iordache/translator/pnscript.g:577:2: ( '/*' ( . )* '*/' ) - // /Users/bion/projects/iordache/translator/pnscript.g:577:5: '/*' ( . )* '*/' + // /Users/bion/projects/iordache/translator/pnscript.g:592:2: ( '/*' ( . )* '*/' ) + // /Users/bion/projects/iordache/translator/pnscript.g:592:5: '/*' ( . )* '*/' { MATCHS(lit_36); if (HASEXCEPTION()) @@ -3637,7 +3637,7 @@ - // /Users/bion/projects/iordache/translator/pnscript.g:577:10: ( . )* + // /Users/bion/projects/iordache/translator/pnscript.g:592:10: ( . )* for (;;) { @@ -3672,7 +3672,7 @@ switch (alt15) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:577:10: . + // /Users/bion/projects/iordache/translator/pnscript.g:592:10: . { MATCHANY(); if (HASEXCEPTION()) Modified: translator/pnscriptLexer.h =================================================================== --- translator/pnscriptLexer.h 2009-06-19 05:42:32 UTC (rev 76) +++ translator/pnscriptLexer.h 2009-06-19 18:36:07 UTC (rev 77) @@ -2,7 +2,7 @@ * This C header file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pnscript.g - * - On : 2009-06-19 00:27:27 + * - On : 2009-06-19 13:34:29 * - for the lexer : pnscriptLexerLexer * * Editing it, at least manually, is not wise. * Modified: translator/pnscriptParser.c =================================================================== --- translator/pnscriptParser.c 2009-06-19 05:42:32 UTC (rev 76) +++ translator/pnscriptParser.c 2009-06-19 18:36:07 UTC (rev 77) @@ -2,7 +2,7 @@ * This C source file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pnscript.g - * - On : 2009-06-19 00:27:26 + * - On : 2009-06-19 13:34:29 * - for the parser : pnscriptParserParser * * Editing it, at least manually, is not wise. * @@ -1175,69 +1175,69 @@ /** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def919 */ static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def919_bits[] = { ANTLR3_UINT64_LIT(0x0000000080000400) }; static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def919 = { FOLLOW_LIVE_in_live_def919_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def925 */ -static ANTLR3_BITWORD FOLLOW_ALL_in_live_def925_bits[] = { ANTLR3_UINT64_LIT(0x0000000020000800) }; -static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def925 = { FOLLOW_ALL_in_live_def925_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_live_def928 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_live_def928_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000400) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_live_def928 = { FOLLOW_MINUS_in_live_def928_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def932 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def932_bits[] = { ANTLR3_UINT64_LIT(0x0000000020000800) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def932 = { FOLLOW_ID_in_live_def932_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def956 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def956_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000C00) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def956 = { FOLLOW_ID_in_live_def956_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_END_in_live_def975 */ -static ANTLR3_BITWORD FOLLOW_END_in_live_def975_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_END_in_live_def975 = { FOLLOW_END_in_live_def975_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol984 */ -static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol984_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000400) }; -static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol984 = { FOLLOW_UNCONTROL_in_uncontrol984_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol987 */ -static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol987_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000C00) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol987 = { FOLLOW_ID_in_uncontrol987_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_END_in_uncontrol993 */ -static ANTLR3_BITWORD FOLLOW_END_in_uncontrol993_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_END_in_uncontrol993 = { FOLLOW_END_in_uncontrol993_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve1011 */ -static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve1011_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000400) }; -static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve1011 = { FOLLOW_UNOBSERVE_in_unobserve1011_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve1014 */ -static ANTLR3_BITWORD FOLLOW_ID_in_unobserve1014_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000C00) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve1014 = { FOLLOW_ID_in_unobserve1014_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_END_in_unobserve1020 */ -static ANTLR3_BITWORD FOLLOW_END_in_unobserve1020_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_END_in_unobserve1020 = { FOLLOW_END_in_unobserve1020_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands1039 */ -static ANTLR3_BITWORD FOLLOW_print_in_other_commands1039_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands1039 = { FOLLOW_print_in_other_commands1039_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print1048 */ -static ANTLR3_BITWORD FOLLOW_PRINT_in_print1048_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000400) }; -static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print1048 = { FOLLOW_PRINT_in_print1048_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print1050 */ -static ANTLR3_BITWORD FOLLOW_ID_in_print1050_bits[] = { ANTLR3_UINT64_LIT(0x0000400000000000) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_print1050 = { FOLLOW_ID_in_print1050_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_46_in_print1052 */ -static ANTLR3_BITWORD FOLLOW_46_in_print1052_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000400) }; -static ANTLR3_BITSET_LIST FOLLOW_46_in_print1052 = { FOLLOW_46_in_print1052_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print1054 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_print1054_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print1054 = { FOLLOW_group_elements_in_print1054_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_number1073 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_number1073_bits[] = { ANTLR3_UINT64_LIT(0x0000000001000000) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_number1073 = { FOLLOW_MINUS_in_number1073_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number1077 */ -static ANTLR3_BITWORD FOLLOW_INT_in_number1077_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_number1077 = { FOLLOW_INT_in_number1077_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements1092 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements1092_bits[] = { ANTLR3_UINT64_LIT(0x0000000000100002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements1092 = { FOLLOW_ID_in_group_elements1092_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_DOT_in_group_elements1095 */ -static ANTLR3_BITWORD FOLLOW_DOT_in_group_elements1095_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000400) }; -static ANTLR3_BITSET_LIST FOLLOW_DOT_in_group_elements1095 = { FOLLOW_DOT_in_group_elements1095_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements1099 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements1099_bits[] = { ANTLR3_UINT64_LIT(0x0000000000100002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements1099 = { FOLLOW_ID_in_group_elements1099_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def927 */ +static ANTLR3_BITWORD FOLLOW_ALL_in_live_def927_bits[] = { ANTLR3_UINT64_LIT(0x0000000020000800) }; +static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def927 = { FOLLOW_ALL_in_live_def927_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_live_def930 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_live_def930_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000400) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_live_def930 = { FOLLOW_MINUS_in_live_def930_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def934 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def934_bits[] = { ANTLR3_UINT64_LIT(0x0000000020000800) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def934 = { FOLLOW_ID_in_live_def934_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def958 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def958_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000C00) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def958 = { FOLLOW_ID_in_live_def958_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_END_in_live_def977 */ +static ANTLR3_BITWORD FOLLOW_END_in_live_def977_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_END_in_live_def977 = { FOLLOW_END_in_live_def977_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol986 */ +static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol986_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000400) }; +static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol986 = { FOLLOW_UNCONTROL_in_uncontrol986_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol991 */ +static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol991_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000C00) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol991 = { FOLLOW_ID_in_uncontrol991_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_END_in_uncontrol997 */ +static ANTLR3_BITWORD FOLLOW_END_in_uncontrol997_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_END_in_uncontrol997 = { FOLLOW_END_in_uncontrol997_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve1015 */ +static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve1015_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000400) }; +static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve1015 = { FOLLOW_UNOBSERVE_in_unobserve1015_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve1020 */ +static ANTLR3_BITWORD FOLLOW_ID_in_unobserve1020_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000C00) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve1020 = { FOLLOW_ID_in_unobserve1020_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_END_in_unobserve1026 */ +static ANTLR3_BITWORD FOLLOW_END_in_unobserve1026_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_END_in_unobserve1026 = { FOLLOW_END_in_unobserve1026_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands1045 */ +static ANTLR3_BITWORD FOLLOW_print_in_other_commands1045_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands1045 = { FOLLOW_print_in_other_commands1045_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print1054 */ +static ANTLR3_BITWORD FOLLOW_PRINT_in_print1054_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000400) }; +static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print1054 = { FOLLOW_PRINT_in_print1054_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print1056 */ +static ANTLR3_BITWORD FOLLOW_ID_in_print1056_bits[] = { ANTLR3_UINT64_LIT(0x0000400000000000) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_print1056 = { FOLLOW_ID_in_print1056_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_46_in_print1058 */ +static ANTLR3_BITWORD FOLLOW_46_in_print1058_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000400) }; +static ANTLR3_BITSET_LIST FOLLOW_46_in_print1058 = { FOLLOW_46_in_print1058_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print1060 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_print1060_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print1060 = { FOLLOW_group_elements_in_print1060_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_number1079 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_number1079_bits[] = { ANTLR3_UINT64_LIT(0x0000000001000000) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_number1079 = { FOLLOW_MINUS_in_number1079_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number1083 */ +static ANTLR3_BITWORD FOLLOW_INT_in_number1083_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_number1083 = { FOLLOW_INT_in_number1083_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements1098 */ +static ANTLR3_BITWORD FOLLOW_ID_in_group_elements1098_bits[] = { ANTLR3_UINT64_LIT(0x0000000000100002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements1098 = { FOLLOW_ID_in_group_elements1098_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_DOT_in_group_elements1101 */ +static ANTLR3_BITWORD FOLLOW_DOT_in_group_elements1101_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000400) }; +static ANTLR3_BITSET_LIST FOLLOW_DOT_in_group_elements1101 = { FOLLOW_DOT_in_group_elements1101_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements1105 */ +static ANTLR3_BITWORD FOLLOW_ID_in_group_elements1105_bits[] = { ANTLR3_UINT64_LIT(0x0000000000100002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements1105 = { FOLLOW_ID_in_group_elements1105_bits, 1 }; @@ -1920,7 +1920,7 @@ /* AST REWRITE - * elements : ID, EXTERN + * elements : EXTERN, ID * token labels : * rule labels : retval * token list labels : @@ -2072,7 +2072,7 @@ /* AST REWRITE - * elements : CODE_BLOCK, BUILD + * elements : BUILD, CODE_BLOCK * token labels : * rule labels : retval * token list labels : @@ -3027,7 +3027,7 @@ /* AST REWRITE - * elements : TRANS, ID + * elements : ID, TRANS * token labels : * rule labels : retval * token list labels : @@ -4114,7 +4114,7 @@ /* AST REWRITE - * elements : CODE_BLOCK, CODE_BLOCK, ID, ID, ID, items, items + * elements : CODE_BLOCK, ID, CODE_BLOCK, ID, items, ID, items * token labels : * rule labels : retval * token list labels : items @@ -4584,7 +4584,7 @@ /* AST REWRITE - * elements : ID, text + * elements : text, ID * token labels : text * rule labels : retval * token list labels : @@ -4923,7 +4923,7 @@ { if(0 == strcasecmp((char*) (name->getText(name))->chars, (char*) "global")) { - fprintf(stderr, "ERROR: Sorry, you cannot name a thread \"%s\"\n", (name->getText(name))->chars); + fprintf(stderr, "ERROR: Sorry, you cannot name a thread \"%s\".\n", (name->getText(name))->chars); FAIL_AT(name); } list = (pANTLR3_LIST) processes->get(processes, (char*) (proc->getText(proc))->chars); @@ -5030,7 +5030,7 @@ /* AST REWRITE - * elements : name, ids + * elements : ids, name * token labels : name * rule labels : retval * token list labels : @@ -5245,7 +5245,7 @@ /* AST REWRITE - * elements : group_elements, SYNC_TOK + * elements : SYNC_TOK, group_elements * token labels : * rule labels : retval * token list labels : @@ -5886,7 +5886,7 @@ /* AST REWRITE - * elements : unobserve, eq, constraint_block, uncontrol, live_def + * elements : eq, constraint_block, live_def, unobserve, uncontrol * token labels : * rule labels : retval * token list labels : @@ -7026,8 +7026,16 @@ CREATE_stream_LIVE; stream_LIVE->add(stream_LIVE, LIVE97, NULL); + { - // /Users/bion/projects/iordache/translator/pnscript.g:448:9: ( ALL ( MINUS id1= ID )* -> ^( LIVE ALL ( ID )* ) | (id2= ID )+ -> ^( LIVE ( ID )+ ) ) + if( (SCOPE_TOP(constraints))->procName == NULL) { + fprintf(stderr, "ERROR: The \"live\" keyword is not valid in a global context.\n"); + FAIL_AT(LIVE97); + } + + } + + // /Users/bion/projects/iordache/translator/pnscript.g:453:5: ( ALL ( MINUS id1= ID )* -> ^( LIVE ALL ( ID )* ) | (id2= ID )+ -> ^( LIVE ( ID )+ ) ) { int alt40=2; @@ -7057,9 +7065,9 @@ switch (alt40) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:449:3: ALL ( MINUS id1= ID )* + // /Users/bion/projects/iordache/translator/pnscript.g:454:3: ALL ( MINUS id1= ID )* { - ALL98 = (pANTLR3_COMMON_TOKEN) MATCHT(ALL, &FOLLOW_ALL_in_live_def925); + ALL98 = (pANTLR3_COMMON_TOKEN) MATCHT(ALL, &FOLLOW_ALL_in_live_def927); if (HASEXCEPTION()) { goto rulelive_defEx; @@ -7068,7 +7076,7 @@ CREATE_stream_ALL; stream_ALL->add(stream_ALL, ALL98, NULL); - // /Users/bion/projects/iordache/translator/pnscript.g:449:7: ( MINUS id1= ID )* + // /Users/bion/projects/iordache/translator/pnscript.g:454:7: ( MINUS id1= ID )* for (;;) { @@ -7086,9 +7094,9 @@ switch (alt38) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:449:8: MINUS id1= ID + // /Users/bion/projects/iordache/translator/pnscript.g:454:8: MINUS id1= ID { - MINUS99 = (pANTLR3_COMMON_TOKEN) MATCHT(MINUS, &FOLLOW_MINUS_in_live_def928); + MINUS99 = (pANTLR3_COMMON_TOKEN) MATCHT(MINUS, &FOLLOW_MINUS_in_live_def930); if (HASEXCEPTION()) { goto rulelive_defEx; @@ -7096,7 +7104,7 @@ CREATE_stream_MINUS; stream_MINUS->add(stream_MINUS, MINUS99, NULL); - id1 = (pANTLR3_COMMON_TOKEN) MATCHT(ID, &FOLLOW_ID_in_live_def932); + id1 = (pANTLR3_COMMON_TOKEN) MATCHT(ID, &FOLLOW_ID_in_live_def934); if (HASEXCEPTION()) { goto rulelive_defEx; @@ -7128,7 +7136,7 @@ /* AST REWRITE - * elements : ALL, ID, LIVE + * elements : LIVE, ALL, ID * token labels : * rule labels : retval * token list labels : @@ -7141,15 +7149,15 @@ root_0 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR)); retval.tree = root_0; - // 456:8: -> ^( LIVE ALL ( ID )* ) + // 461:8: -> ^( LIVE ALL ( ID )* ) { - // /Users/bion/projects/iordache/translator/pnscript.g:456:11: ^( LIVE ALL ( ID )* ) + // /Users/bion/projects/iordache/translator/pnscript.g:461:11: ^( LIVE ALL ( ID )* ) { pANTLR3_BASE_TREE root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR)); root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->becomeRoot(ADAPTOR, stream_LIVE == NULL ? NULL : stream_LIVE->nextNode(stream_LIVE), root_1)); ADAPTOR->addChild(ADAPTOR, root_1, stream_ALL == NULL ? NULL : stream_ALL->nextNode(stream_ALL)); - // /Users/bion/projects/iordache/translator/pnscript.g:456:22: ( ID )* + // /Users/bion/projects/iordache/translator/pnscript.g:461:22: ( ID )* { while ( (stream_ID != NULL && stream_ID->hasNext(stream_ID)) ) { @@ -7173,9 +7181,9 @@ ... [truncated message content] |
From: <the...@us...> - 2009-06-19 05:42:55
|
Revision: 76 http://pntool.svn.sourceforge.net/pntool/?rev=76&view=rev Author: thecodeweasel Date: 2009-06-19 05:42:32 +0000 (Fri, 19 Jun 2009) Log Message: ----------- All this to get sync commands working... Modified Paths: -------------- translator/dataStructures.h translator/main.c translator/pncompactor.c translator/pncompactor.g translator/pncompactor.h translator/pncompactor.tokens translator/pngenerator.c translator/pngenerator.g translator/pngenerator.h translator/pngenerator.tokens translator/pnscript.g translator/pnscript.tokens translator/pnscriptLexer.c translator/pnscriptLexer.h translator/pnscriptParser.c translator/pnscriptParser.h Modified: translator/dataStructures.h =================================================================== --- translator/dataStructures.h 2009-06-18 21:28:52 UTC (rev 75) +++ translator/dataStructures.h 2009-06-19 05:42:32 UTC (rev 76) @@ -2,11 +2,12 @@ #define DATASTRUCTURES_H #include <antlr3.h> +#include "pns.h" /** Hash table with a vector * The speed of hash table lookups with the ability to iterate over the data */ -typedef struct ASSOC_ARRAY_struct +typedef struct ASSOC_ARRAY_struct { pANTLR3_HASH_TABLE table; //the list just enumerates the table keys @@ -28,4 +29,9 @@ char* (*iterKeys) (struct ASSOC_ARRAY_struct* array, int i); } ASSOC_ARRAY; +typedef struct pizza_struct { + pns* pn; + int tran; +} pizza; + #endif \ No newline at end of file Modified: translator/main.c =================================================================== --- translator/main.c 2009-06-18 21:28:52 UTC (rev 75) +++ translator/main.c 2009-06-19 05:42:32 UTC (rev 76) @@ -258,7 +258,7 @@ printf("Done.\n"); fflush(stdout); printf("Generating Petri Nets...\n"); - generator->pn(generator, processes, threads); + generator->pn(generator, processes, threads, (char*) fName); if (generator->pTreeParser->rec->state->errorCount > 0) { fprintf(stderr, "The parser returned %d error(s), code generation aborted.\n", generator->pTreeParser->rec->state->errorCount); } Modified: translator/pncompactor.c =================================================================== --- translator/pncompactor.c 2009-06-18 21:28:52 UTC (rev 75) +++ translator/pncompactor.c 2009-06-19 05:42:32 UTC (rev 76) @@ -2,7 +2,7 @@ * This C source file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pncompactor.g - * - On : 2009-06-18 14:59:09 + * - On : 2009-06-19 00:34:50 * - for the tree parser : pncompactorTreeParser * * Editing it, at least manually, is not wise. * @@ -278,7 +278,7 @@ /** \brief Table of all token names in symbolic order, mainly used for * error reporting. */ -pANTLR3_UINT8 pncompactorTokenNames[45+4] +pANTLR3_UINT8 pncompactorTokenNames[46+4] = { (pANTLR3_UINT8) "<invalid>", /* String to print to indicate an invalid token */ (pANTLR3_UINT8) "<EOR>", @@ -287,6 +287,7 @@ (pANTLR3_UINT8) "HEADER", (pANTLR3_UINT8) "TO", (pANTLR3_UINT8) "FROM", + (pANTLR3_UINT8) "GROUP", (pANTLR3_UINT8) "EXTERN", (pANTLR3_UINT8) "PROCESS", (pANTLR3_UINT8) "ID", @@ -386,13 +387,10 @@ static pncompactor_number_return number (ppncompactor ctx); static pncompactor_group_elements_return group_elements (ppncompactor ctx); static pncompactor_numbered_ID_return numbered_ID (ppncompactor ctx); -static ANTLR3_BOOLEAN synpred2_pncompactor (ppncompactor ctx); static ANTLR3_BOOLEAN synpred29_pncompactor (ppncompactor ctx); static ANTLR3_BOOLEAN synpred31_pncompactor (ppncompactor ctx); -static ANTLR3_BOOLEAN synpred32_pncompactor (ppncompactor ctx); static ANTLR3_BOOLEAN synpred33_pncompactor (ppncompactor ctx); static ANTLR3_BOOLEAN synpred34_pncompactor (ppncompactor ctx); -static ANTLR3_BOOLEAN synpred35_pncompactor (ppncompactor ctx); static void pncompactorFree(ppncompactor ctx); /* For use in tree output where we are accumulating rule labels via label += ruleRef * we need a function that knows how to free a return scope when the list is destroyed. @@ -489,13 +487,10 @@ ctx->number = number; ctx->group_elements = group_elements; ctx->numbered_ID = numbered_ID; - ctx->synpred2_pncompactor = synpred2_pncompactor; ctx->synpred29_pncompactor = synpred29_pncompactor; ctx->synpred31_pncompactor = synpred31_pncompactor; - ctx->synpred32_pncompactor = synpred32_pncompactor; ctx->synpred33_pncompactor = synpred33_pncompactor; ctx->synpred34_pncompactor = synpred34_pncompactor; - ctx->synpred35_pncompactor = synpred35_pncompactor; ctx->free = pncompactorFree; ctx->getGrammarFileName = getGrammarFileName; @@ -563,25 +558,25 @@ */ /** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_definitions_in_pn87 */ -static ANTLR3_BITWORD FOLLOW_proc_definitions_in_pn87_bits[] = { ANTLR3_UINT64_LIT(0x0000000000600200) }; +static ANTLR3_BITWORD FOLLOW_proc_definitions_in_pn87_bits[] = { ANTLR3_UINT64_LIT(0x0000000000C00400) }; static ANTLR3_BITSET_LIST FOLLOW_proc_definitions_in_pn87 = { FOLLOW_proc_definitions_in_pn87_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_pn90 */ -static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_pn90_bits[] = { ANTLR3_UINT64_LIT(0x0000000200600202) }; +static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_pn90_bits[] = { ANTLR3_UINT64_LIT(0x0000000400C00402) }; static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_pn90 = { FOLLOW_proc_instantiations_in_pn90_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_constraints_in_pn93 */ -static ANTLR3_BITWORD FOLLOW_constraints_in_pn93_bits[] = { ANTLR3_UINT64_LIT(0x0000000200000202) }; +static ANTLR3_BITWORD FOLLOW_constraints_in_pn93_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000402) }; static ANTLR3_BITSET_LIST FOLLOW_constraints_in_pn93 = { FOLLOW_constraints_in_pn93_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_other_commands_in_pn96 */ -static ANTLR3_BITWORD FOLLOW_other_commands_in_pn96_bits[] = { ANTLR3_UINT64_LIT(0x0000000200000002) }; +static ANTLR3_BITWORD FOLLOW_other_commands_in_pn96_bits[] = { ANTLR3_UINT64_LIT(0x0000000400000002) }; static ANTLR3_BITSET_LIST FOLLOW_other_commands_in_pn96 = { FOLLOW_other_commands_in_pn96_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_def_start_in_proc_definitions108 */ static ANTLR3_BITWORD FOLLOW_def_start_in_proc_definitions108_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; static ANTLR3_BITSET_LIST FOLLOW_def_start_in_proc_definitions108 = { FOLLOW_def_start_in_proc_definitions108_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_trans_defs_in_proc_definitions110 */ -static ANTLR3_BITWORD FOLLOW_trans_defs_in_proc_definitions110_bits[] = { ANTLR3_UINT64_LIT(0x0000100000100268) }; +static ANTLR3_BITWORD FOLLOW_trans_defs_in_proc_definitions110_bits[] = { ANTLR3_UINT64_LIT(0x0000200000200468) }; static ANTLR3_BITSET_LIST FOLLOW_trans_defs_in_proc_definitions110 = { FOLLOW_trans_defs_in_proc_definitions110_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_select_functions_in_proc_definitions113 */ -static ANTLR3_BITWORD FOLLOW_select_functions_in_proc_definitions113_bits[] = { ANTLR3_UINT64_LIT(0x0000100000100008) }; +static ANTLR3_BITWORD FOLLOW_select_functions_in_proc_definitions113_bits[] = { ANTLR3_UINT64_LIT(0x0000200000200008) }; static ANTLR3_BITSET_LIST FOLLOW_select_functions_in_proc_definitions113 = { FOLLOW_select_functions_in_proc_definitions113_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_nondeterm_in_proc_definitions116 */ static ANTLR3_BITWORD FOLLOW_nondeterm_in_proc_definitions116_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; @@ -599,7 +594,7 @@ static ANTLR3_BITWORD FOLLOW_set_in_extern_trans_def150_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; static ANTLR3_BITSET_LIST FOLLOW_set_in_extern_trans_def150 = { FOLLOW_set_in_extern_trans_def150_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_extern_trans_def158 */ -static ANTLR3_BITWORD FOLLOW_ID_in_extern_trans_def158_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITWORD FOLLOW_ID_in_extern_trans_def158_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; static ANTLR3_BITSET_LIST FOLLOW_ID_in_extern_trans_def158 = { FOLLOW_ID_in_extern_trans_def158_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def170 */ static ANTLR3_BITWORD FOLLOW_ID_in_trans_def170_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; @@ -611,7 +606,7 @@ static ANTLR3_BITWORD FOLLOW_ID_in_trans_def179_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def179 = { FOLLOW_ID_in_trans_def179_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def181 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def181_bits[] = { ANTLR3_UINT64_LIT(0x0000000000001208) }; +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def181_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002408) }; static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def181 = { FOLLOW_ID_in_trans_def181_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def184 */ static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def184_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; @@ -623,7 +618,7 @@ static ANTLR3_BITWORD FOLLOW_ID_in_trans_def195_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def195 = { FOLLOW_ID_in_trans_def195_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def197 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def197_bits[] = { ANTLR3_UINT64_LIT(0x0000000000001208) }; +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def197_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002408) }; static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def197 = { FOLLOW_ID_in_trans_def197_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def200 */ static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def200_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; @@ -632,16 +627,16 @@ static ANTLR3_BITWORD FOLLOW_SELECT_DEF_in_select_functions212_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; static ANTLR3_BITSET_LIST FOLLOW_SELECT_DEF_in_select_functions212 = { FOLLOW_SELECT_DEF_in_select_functions212_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_select_functions214 */ -static ANTLR3_BITWORD FOLLOW_ID_in_select_functions214_bits[] = { ANTLR3_UINT64_LIT(0x0000000000001000) }; +static ANTLR3_BITWORD FOLLOW_ID_in_select_functions214_bits[] = { ANTLR3_UINT64_LIT(0x0000000000002000) }; static ANTLR3_BITSET_LIST FOLLOW_ID_in_select_functions214 = { FOLLOW_ID_in_select_functions214_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_select_functions216 */ static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_select_functions216_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_select_functions216 = { FOLLOW_CODE_BLOCK_in_select_functions216_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_44_in_nondeterm227 */ -static ANTLR3_BITWORD FOLLOW_44_in_nondeterm227_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_44_in_nondeterm227 = { FOLLOW_44_in_nondeterm227_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_45_in_nondeterm227 */ +static ANTLR3_BITWORD FOLLOW_45_in_nondeterm227_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_45_in_nondeterm227 = { FOLLOW_45_in_nondeterm227_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_nondeterm229 */ -static ANTLR3_BITWORD FOLLOW_ID_in_nondeterm229_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITWORD FOLLOW_ID_in_nondeterm229_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; static ANTLR3_BITSET_LIST FOLLOW_ID_in_nondeterm229 = { FOLLOW_ID_in_nondeterm229_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_init_in_proc_instantiations241 */ static ANTLR3_BITWORD FOLLOW_proc_init_in_proc_instantiations241_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; @@ -656,31 +651,31 @@ static ANTLR3_BITWORD FOLLOW_ID_in_proc_init259_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init259 = { FOLLOW_ID_in_proc_init259_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_numbered_ID_in_proc_init261 */ -static ANTLR3_BITWORD FOLLOW_numbered_ID_in_proc_init261_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITWORD FOLLOW_numbered_ID_in_proc_init261_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; static ANTLR3_BITSET_LIST FOLLOW_numbered_ID_in_proc_init261 = { FOLLOW_numbered_ID_in_proc_init261_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_SYNC_TOK_in_sync_def273 */ static ANTLR3_BITWORD FOLLOW_SYNC_TOK_in_sync_def273_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; static ANTLR3_BITSET_LIST FOLLOW_SYNC_TOK_in_sync_def273 = { FOLLOW_SYNC_TOK_in_sync_def273_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_sync_def275 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def275_bits[] = { ANTLR3_UINT64_LIT(0x0000000000080208) }; +static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def275_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_sync_def275 = { FOLLOW_group_elements_in_sync_def275_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start287 */ static ANTLR3_BITWORD FOLLOW_START_in_proc_start287_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start287 = { FOLLOW_START_in_proc_start287_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start289 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_start289_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITWORD FOLLOW_ID_in_proc_start289_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start289 = { FOLLOW_ID_in_proc_start289_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints306 */ static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints306_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints306 = { FOLLOW_constraint_block_in_constraints306_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints311 */ -static ANTLR3_BITWORD FOLLOW_eq_in_constraints311_bits[] = { ANTLR3_UINT64_LIT(0x00000001BE8A0208) }; +static ANTLR3_BITWORD FOLLOW_eq_in_constraints311_bits[] = { ANTLR3_UINT64_LIT(0x000000037D040088) }; static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints311 = { FOLLOW_eq_in_constraints311_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints317 */ -static ANTLR3_BITWORD FOLLOW_live_def_in_constraints317_bits[] = { ANTLR3_UINT64_LIT(0x0000000180000008) }; +static ANTLR3_BITWORD FOLLOW_live_def_in_constraints317_bits[] = { ANTLR3_UINT64_LIT(0x0000000300000008) }; static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints317 = { FOLLOW_live_def_in_constraints317_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints320 */ -static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints320_bits[] = { ANTLR3_UINT64_LIT(0x0000000100000008) }; +static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints320_bits[] = { ANTLR3_UINT64_LIT(0x0000000200000008) }; static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints320 = { FOLLOW_uncontrol_in_constraints320_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints323 */ static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints323_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; @@ -695,7 +690,7 @@ static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq348_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq348 = { FOLLOW_EQS_OP_in_eq348_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq350 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq350_bits[] = { ANTLR3_UINT64_LIT(0x00000001BE8A0208) }; +static ANTLR3_BITWORD FOLLOW_eq_in_eq350_bits[] = { ANTLR3_UINT64_LIT(0x000000037D040088) }; static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq350 = { FOLLOW_eq_in_eq350_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq352 */ static ANTLR3_BITWORD FOLLOW_eq_in_eq352_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; @@ -707,7 +702,7 @@ static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression377_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression377 = { FOLLOW_EQ_OP_in_relationalExpression377_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression379 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression379_bits[] = { ANTLR3_UINT64_LIT(0x000000001C8A0208) }; +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression379_bits[] = { ANTLR3_UINT64_LIT(0x0000000039040088) }; static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression379 = { FOLLOW_relationalExpression_in_relationalExpression379_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression383 */ static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression383_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; @@ -719,7 +714,7 @@ static ANTLR3_BITWORD FOLLOW_PLUS_in_additiveExpression414_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; static ANTLR3_BITSET_LIST FOLLOW_PLUS_in_additiveExpression414 = { FOLLOW_PLUS_in_additiveExpression414_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression418 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression418_bits[] = { ANTLR3_UINT64_LIT(0x00000000188A0208) }; +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression418_bits[] = { ANTLR3_UINT64_LIT(0x0000000031040088) }; static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression418 = { FOLLOW_additiveExpression_in_additiveExpression418_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression435 */ static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression435_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; @@ -728,7 +723,7 @@ static ANTLR3_BITWORD FOLLOW_MINUS_in_additiveExpression485_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_additiveExpression485 = { FOLLOW_MINUS_in_additiveExpression485_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression489 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression489_bits[] = { ANTLR3_UINT64_LIT(0x00000000188A0208) }; +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression489_bits[] = { ANTLR3_UINT64_LIT(0x0000000031040088) }; static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression489 = { FOLLOW_additiveExpression_in_additiveExpression489_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression505 */ static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression505_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; @@ -739,105 +734,93 @@ /** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary570 */ static ANTLR3_BITWORD FOLLOW_eq_in_primary570_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary570 = { FOLLOW_eq_in_primary570_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_primary587 */ -static ANTLR3_BITWORD FOLLOW_ID_in_primary587_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_primary587 = { FOLLOW_ID_in_primary587_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary634 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_primary634_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary634 = { FOLLOW_group_elements_in_primary634_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary675 */ -static ANTLR3_BITWORD FOLLOW_number_in_primary675_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_primary675 = { FOLLOW_number_in_primary675_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary684 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_primary684_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary684 = { FOLLOW_MULT_in_primary684_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary686 */ -static ANTLR3_BITWORD FOLLOW_number_in_primary686_bits[] = { ANTLR3_UINT64_LIT(0x00000000108A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_primary686 = { FOLLOW_number_in_primary686_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary688 */ -static ANTLR3_BITWORD FOLLOW_primary_in_primary688_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary688 = { FOLLOW_primary_in_primary688_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary723 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_primary723_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary723 = { FOLLOW_MULT_in_primary723_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary725 */ -static ANTLR3_BITWORD FOLLOW_number_in_primary725_bits[] = { ANTLR3_UINT64_LIT(0x00000001BE8A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_primary725 = { FOLLOW_number_in_primary725_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary729 */ -static ANTLR3_BITWORD FOLLOW_eq_in_primary729_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary729 = { FOLLOW_eq_in_primary729_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def753 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def753_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def753 = { FOLLOW_LIVE_in_live_def753_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def755 */ -static ANTLR3_BITWORD FOLLOW_ALL_in_live_def755_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def755 = { FOLLOW_ALL_in_live_def755_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def757 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def757_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def757 = { FOLLOW_ID_in_live_def757_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def765 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def765_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def765 = { FOLLOW_LIVE_in_live_def765_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def767 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def767_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def767 = { FOLLOW_ID_in_live_def767_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol779 */ -static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol779_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol779 = { FOLLOW_UNCONTROL_in_uncontrol779_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol781 */ -static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol781_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol781 = { FOLLOW_ID_in_uncontrol781_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve793 */ -static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve793_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve793 = { FOLLOW_UNOBSERVE_in_unobserve793_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve795 */ -static ANTLR3_BITWORD FOLLOW_ID_in_unobserve795_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve795 = { FOLLOW_ID_in_unobserve795_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands807 */ -static ANTLR3_BITWORD FOLLOW_print_in_other_commands807_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands807 = { FOLLOW_print_in_other_commands807_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print817 */ -static ANTLR3_BITWORD FOLLOW_PRINT_in_print817_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print817 = { FOLLOW_PRINT_in_print817_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print819 */ -static ANTLR3_BITWORD FOLLOW_ID_in_print819_bits[] = { ANTLR3_UINT64_LIT(0x0000000000080208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_print819 = { FOLLOW_ID_in_print819_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print821 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_print821_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print821 = { FOLLOW_group_elements_in_print821_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number840 */ -static ANTLR3_BITWORD FOLLOW_INT_in_number840_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_number840 = { FOLLOW_INT_in_number840_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_number853 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_number853_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_number853 = { FOLLOW_MINUS_in_number853_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number855 */ -static ANTLR3_BITWORD FOLLOW_INT_in_number855_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_number855 = { FOLLOW_INT_in_number855_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements872 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements872_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements872 = { FOLLOW_ID_in_group_elements872_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_DOT_in_group_elements878 */ -static ANTLR3_BITWORD FOLLOW_DOT_in_group_elements878_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_DOT_in_group_elements878 = { FOLLOW_DOT_in_group_elements878_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_group_elements880 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_group_elements880_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000200) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_group_elements880 = { FOLLOW_group_elements_in_group_elements880_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements882 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements882_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements882 = { FOLLOW_ID_in_group_elements882_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID892 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID892_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID892 = { FOLLOW_ID_in_numbered_ID892_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID898 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID898_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID898 = { FOLLOW_ID_in_numbered_ID898_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID900 */ -static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID900_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID900 = { FOLLOW_INT_in_numbered_ID900_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_synpred2_pncompactor90 */ -static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_synpred2_pncompactor90_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_synpred2_pncompactor90 = { FOLLOW_proc_instantiations_in_synpred2_pncompactor90_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary585 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_primary585_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary585 = { FOLLOW_group_elements_in_primary585_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary626 */ +static ANTLR3_BITWORD FOLLOW_number_in_primary626_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_primary626 = { FOLLOW_number_in_primary626_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary635 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_primary635_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary635 = { FOLLOW_MULT_in_primary635_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary637 */ +static ANTLR3_BITWORD FOLLOW_number_in_primary637_bits[] = { ANTLR3_UINT64_LIT(0x0000000021040088) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_primary637 = { FOLLOW_number_in_primary637_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary639 */ +static ANTLR3_BITWORD FOLLOW_primary_in_primary639_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary639 = { FOLLOW_primary_in_primary639_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary674 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_primary674_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary674 = { FOLLOW_MULT_in_primary674_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary676 */ +static ANTLR3_BITWORD FOLLOW_number_in_primary676_bits[] = { ANTLR3_UINT64_LIT(0x000000037D040088) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_primary676 = { FOLLOW_number_in_primary676_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary680 */ +static ANTLR3_BITWORD FOLLOW_eq_in_primary680_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary680 = { FOLLOW_eq_in_primary680_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def704 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def704_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def704 = { FOLLOW_LIVE_in_live_def704_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def706 */ +static ANTLR3_BITWORD FOLLOW_ALL_in_live_def706_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def706 = { FOLLOW_ALL_in_live_def706_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def708 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def708_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def708 = { FOLLOW_ID_in_live_def708_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def716 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def716_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def716 = { FOLLOW_LIVE_in_live_def716_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def718 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def718_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def718 = { FOLLOW_ID_in_live_def718_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol730 */ +static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol730_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol730 = { FOLLOW_UNCONTROL_in_uncontrol730_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol732 */ +static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol732_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol732 = { FOLLOW_ID_in_uncontrol732_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve744 */ +static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve744_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve744 = { FOLLOW_UNOBSERVE_in_unobserve744_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve746 */ +static ANTLR3_BITWORD FOLLOW_ID_in_unobserve746_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve746 = { FOLLOW_ID_in_unobserve746_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands758 */ +static ANTLR3_BITWORD FOLLOW_print_in_other_commands758_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands758 = { FOLLOW_print_in_other_commands758_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print768 */ +static ANTLR3_BITWORD FOLLOW_PRINT_in_print768_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print768 = { FOLLOW_PRINT_in_print768_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print770 */ +static ANTLR3_BITWORD FOLLOW_ID_in_print770_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000088) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_print770 = { FOLLOW_ID_in_print770_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print772 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_print772_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print772 = { FOLLOW_group_elements_in_print772_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number791 */ +static ANTLR3_BITWORD FOLLOW_INT_in_number791_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_number791 = { FOLLOW_INT_in_number791_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_number804 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_number804_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_number804 = { FOLLOW_MINUS_in_number804_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number806 */ +static ANTLR3_BITWORD FOLLOW_INT_in_number806_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_number806 = { FOLLOW_INT_in_number806_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_GROUP_in_group_elements824 */ +static ANTLR3_BITWORD FOLLOW_GROUP_in_group_elements824_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_GROUP_in_group_elements824 = { FOLLOW_GROUP_in_group_elements824_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements826 */ +static ANTLR3_BITWORD FOLLOW_ID_in_group_elements826_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000408) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements826 = { FOLLOW_ID_in_group_elements826_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID837 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID837_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID837 = { FOLLOW_ID_in_numbered_ID837_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID843 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID843_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID843 = { FOLLOW_ID_in_numbered_ID843_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID845 */ +static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID845_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID845 = { FOLLOW_INT_in_numbered_ID845_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred29_pncompactor404 */ static ANTLR3_BITWORD FOLLOW_primary_in_synpred29_pncompactor404_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred29_pncompactor404 = { FOLLOW_primary_in_synpred29_pncompactor404_bits, 1 }; @@ -847,369 +830,22 @@ /** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_synpred31_pncompactor570 */ static ANTLR3_BITWORD FOLLOW_eq_in_synpred31_pncompactor570_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; static ANTLR3_BITSET_LIST FOLLOW_eq_in_synpred31_pncompactor570 = { FOLLOW_eq_in_synpred31_pncompactor570_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_synpred32_pncompactor587 */ -static ANTLR3_BITWORD FOLLOW_ID_in_synpred32_pncompactor587_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_synpred32_pncompactor587 = { FOLLOW_ID_in_synpred32_pncompactor587_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_synpred33_pncompactor634 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_synpred33_pncompactor634_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_synpred33_pncompactor634 = { FOLLOW_group_elements_in_synpred33_pncompactor634_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_synpred34_pncompactor675 */ -static ANTLR3_BITWORD FOLLOW_number_in_synpred34_pncompactor675_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_synpred34_pncompactor675 = { FOLLOW_number_in_synpred34_pncompactor675_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_synpred35_pncompactor684 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_synpred35_pncompactor684_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_synpred35_pncompactor684 = { FOLLOW_MULT_in_synpred35_pncompactor684_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_synpred35_pncompactor686 */ -static ANTLR3_BITWORD FOLLOW_number_in_synpred35_pncompactor686_bits[] = { ANTLR3_UINT64_LIT(0x00000000108A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_synpred35_pncompactor686 = { FOLLOW_number_in_synpred35_pncompactor686_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred35_pncompactor688 */ -static ANTLR3_BITWORD FOLLOW_primary_in_synpred35_pncompactor688_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred35_pncompactor688 = { FOLLOW_primary_in_synpred35_pncompactor688_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_synpred33_pncompactor626 */ +static ANTLR3_BITWORD FOLLOW_number_in_synpred33_pncompactor626_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_synpred33_pncompactor626 = { FOLLOW_number_in_synpred33_pncompactor626_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_synpred34_pncompactor635 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_synpred34_pncompactor635_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_synpred34_pncompactor635 = { FOLLOW_MULT_in_synpred34_pncompactor635_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_synpred34_pncompactor637 */ +static ANTLR3_BITWORD FOLLOW_number_in_synpred34_pncompactor637_bits[] = { ANTLR3_UINT64_LIT(0x0000000021040088) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_synpred34_pncompactor637 = { FOLLOW_number_in_synpred34_pncompactor637_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred34_pncompactor639 */ +static ANTLR3_BITWORD FOLLOW_primary_in_synpred34_pncompactor639_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred34_pncompactor639 = { FOLLOW_primary_in_synpred34_pncompactor639_bits, 1 }; - -/* ========================================================================= - * DFA tables for the parser - */ -/** Static dfa state tables for Cyclic dfa: - * ()+ loopback of 30:22: ( proc_instantiations )+ - */ -static const ANTLR3_INT32 dfa2_eot[7] = - { - -1, -1, -1, -1, -1, -1, -1 - }; -static const ANTLR3_INT32 dfa2_eof[7] = - { - 2, -1, -1, -1, -1, -1, -1 - }; -static const ANTLR3_INT32 dfa2_min[7] = - { - 9, 2, -1, -1, 3, 2, 0 - }; -static const ANTLR3_INT32 dfa2_max[7] = - { - 33, 2, -1, -1, 32, 32, 0 - }; -static const ANTLR3_INT32 dfa2_accept[7] = - { - -1, -1, 2, 1, -1, -1, -1 - }; -static const ANTLR3_INT32 dfa2_special[7] = - { - -1, -1, -1, -1, -1, -1, 0 - }; - -/** Used when there is no transition table entry for a particular state */ -#define dfa2_T_empty NULL - -static const ANTLR3_INT32 dfa2_T0[] = - { - 3, 6, -1, -1, -1, -1, -1, 5, -1, -1, -1, -1, -1, -1, -1, 2, -1, 2, -1, - -1, -1, 2, -1, 2, 2, 2, 2, 2, -1, 2, 2 - };static const ANTLR3_INT32 dfa2_T1[] = - { - 2, -1, -1, -1, -1, -1, 5, -1, -1, -1, -1, -1, -1, -1, 2, -1, 2, -1, -1, - -1, 2, -1, 2, 2, 2, 2, 2, -1, 2, 2 - };static const ANTLR3_INT32 dfa2_T2[] = - { - -1 - };static const ANTLR3_INT32 dfa2_T3[] = - { - 1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 3, 3, -1, -1, -1, -1, -1, - -1, -1, -1, -1, -1, 2 - };static const ANTLR3_INT32 dfa2_T4[] = - { - 4 - }; - -/* Transition tables are a table of sub tables, with some tables - * reused for efficiency. - */ -static const ANTLR3_INT32 * const dfa2_transitions[] = -{ - dfa2_T3, dfa2_T4, dfa2_T_empty, dfa2_T_empty, dfa2_T1, dfa2_T0, dfa2_T2 -}; - -static ANTLR3_INT32 dfa2_sst(ppncompactor ctx, pANTLR3_BASE_RECOGNIZER recognizer, pANTLR3_INT_STREAM is, pANTLR3_CYCLIC_DFA dfa, ANTLR3_INT32 s) -{ - ANTLR3_INT32 _s; - - _s = s; - switch (s) - { - case 0: - - { - ANTLR3_UINT32 LA2_6; - - ANTLR3_MARKER index2_6; - - - LA2_6 = LA(1); - - - index2_6 = INDEX(); - - REWINDLAST(); - - s = -1; - if ( (synpred2_pncompactor(ctx)) ) - { - s = 3; - } - - else if ( (ANTLR3_TRUE) ) - { - s = 2; - } - - - SEEK(index2_6); - - if ( s>=0 ) - { - return s; - } - } - break; - } - if (BACKTRACKING > 0) - { - FAILEDFLAG = ANTLR3_TRUE; - return -1; - } - CONSTRUCTEX(); - EXCEPTION->type = ANTLR3_NO_VIABLE_ALT_EXCEPTION; - EXCEPTION->message = (void *)"()+ loopback of 30:22: ( proc_instantiations )+"; - EXCEPTION->decisionNum = 2; - EXCEPTION->state = _s; - return -1; -} - -/* Declare tracking structure for Cyclic DFA 2 - */ -static -ANTLR3_CYCLIC_DFA cdfa2 - = { - 2, /* Decision number of this dfa */ - /* Which decision this represents: */ - (const pANTLR3_UCHAR)"()+ loopback of 30:22: ( proc_instantiations )+", - (CDFA_SPECIAL_FUNC) dfa2_sst, - antlr3dfaspecialTransition, /* DFA specialTransition is currently just a default function in the runtime */ - antlr3dfapredict, /* DFA simulator function is in the runtime */ - dfa2_eot, /* EOT table */ - dfa2_eof, /* EOF table */ - dfa2_min, /* Minimum tokens for each state */ - dfa2_max, /* Maximum tokens for each state */ - dfa2_accept, /* Accept table */ - dfa2_special, /* Special transition states */ - dfa2_transitions /* Table of transition tables */ - - }; -/* End of Cyclic DFA 2 - * --------------------- - *//** Static dfa state tables for Cyclic dfa: - * 146:1: primary[bool enableAlt] : ( ^( MINUS eq ) -> eq | ID -> {!enableAlt || i == 1}? ID -> ^( MULT[tok2, newVal2] NUM[tok, newVal] ID ) | group_elements -> {!enableAlt || i == 1}? group_elements -> ^( MULT[tok2, newVal2] NUM[tok, newVal] group_elements ) | number | ^( MULT number primary[false] ) -> {$number.value == 0}? -> ^( MULT number primary ) | ^( MULT number eq ) -> {i == 0}? -> eq ); - */ -static const ANTLR3_INT32 dfa27_eot[10] = - { - -1, -1, -1, -1, -1, -1, -1, -1, -1, -1 - }; -static const ANTLR3_INT32 dfa27_eof[10] = - { - -1, -1, -1, -1, -1, -1, -1, -1, -1, -1 - }; -static const ANTLR3_INT32 dfa27_min[10] = - { - 9, 0, 0, -1, -1, 0, -1, -1, -1, -1 - }; -static const ANTLR3_INT32 dfa27_max[10] = - { - 28, 0, 0, -1, -1, 0, -1, -1, -1, -1 - }; -static const ANTLR3_INT32 dfa27_accept[10] = - { - -1, -1, -1, 3, 4, -1, 1, 2, 5, 6 - }; -static const ANTLR3_INT32 dfa27_special[10] = - { - -1, 0, 1, -1, -1, 2, -1, -1, -1, -1 - }; - -/** Used when there is no transition table entry for a particular state */ -#define dfa27_T_empty NULL - -static const ANTLR3_INT32 dfa27_T0[] = - { - 2, -1, -1, -1, -1, -1, -1, -1, 5, -1, 3, -1, -1, -1, 4, -1, -1, -1, -1, - 1 - };static const ANTLR3_INT32 dfa27_T1[] = - { - -1 - }; - -/* Transition tables are a table of sub tables, with some tables - * reused for efficiency. - */ -static const ANTLR3_INT32 * const dfa27_transitions[] = -{ - dfa27_T0, dfa27_T1, dfa27_T1, dfa27_T_empty, dfa27_T_empty, dfa27_T1, - dfa27_T_empty, dfa27_T_empty, dfa27_T_empty, dfa27_T_empty -}; - -static ANTLR3_INT32 dfa27_sst(ppncompactor ctx, pANTLR3_BASE_RECOGNIZER recognizer, pANTLR3_INT_STREAM is, pANTLR3_CYCLIC_DFA dfa, ANTLR3_INT32 s) -{ - ANTLR3_INT32 _s; - - _s = s; - switch (s) - { - case 0: - - { - ANTLR3_UINT32 LA27_1; - - ANTLR3_MARKER index27_1; - - - LA27_1 = LA(1); - - - index27_1 = INDEX(); - - REWINDLAST(); - - s = -1; - if ( (synpred31_pncompactor(ctx)) ) - { - s = 6; - } - - else if ( (synpred34_pncompactor(ctx)) ) - { - s = 4; - } - - - SEEK(index27_1); - - if ( s>=0 ) - { - return s; - } - } - break; - case 1: - - { - ANTLR3_UINT32 LA27_2; - - ANTLR3_MARKER index27_2; - - - LA27_2 = LA(1); - - - index27_2 = INDEX(); - - REWINDLAST(); - - s = -1; - if ( (synpred32_pncompactor(ctx)) ) - { - s = 7; - } - - else if ( (synpred33_pncompactor(ctx)) ) - { - s = 3; - } - - - SEEK(index27_2); - - if ( s>=0 ) - { - return s; - } - } - break; - case 2: - - { - ANTLR3_UINT32 LA27_5; - - ANTLR3_MARKER index27_5; - - - LA27_5 = LA(1); - - - index27_5 = INDEX(); - - REWINDLAST(); - - s = -1; - if ( (synpred35_pncompactor(ctx)) ) - { - s = 8; - } - - else if ( (ANTLR3_TRUE) ) - { - s = 9; - } - - - SEEK(index27_5); - - if ( s>=0 ) - { - return s; - } - } - break; - } - if (BACKTRACKING > 0) - { - FAILEDFLAG = ANTLR3_TRUE; - return -1; - } - CONSTRUCTEX(); - EXCEPTION->type = ANTLR3_NO_VIABLE_ALT_EXCEPTION; - EXCEPTION->message = (void *)"146:1: primary[bool enableAlt] : ( ^( MINUS eq ) -> eq | ID -> {!enableAlt || i == 1}? ID -> ^( MULT[tok2, newVal2] NUM[tok, newVal] ID ) | group_elements -> {!enableAlt || i == 1}? group_elements -> ^( MULT[tok2, newVal2] NUM[tok, newVal] group_elements ) | number | ^( MULT number primary[false] ) -> {$number.value == 0}? -> ^( MULT number primary ) | ^( MULT number eq ) -> {i == 0}? -> eq );"; - EXCEPTION->decisionNum = 27; - EXCEPTION->state = _s; - return -1; -} - -/* Declare tracking structure for Cyclic DFA 27 - */ -static -ANTLR3_CYCLIC_DFA cdfa27 - = { - 27, /* Decision number of this dfa */ - /* Which decision this represents: */ - (const pANTLR3_UCHAR)"146:1: primary[bool enableAlt] : ( ^( MINUS eq ) -> eq | ID -> {!enableAlt || i == 1}? ID -> ^( MULT[tok2, newVal2] NUM[tok, newVal] ID ) | group_elements -> {!enableAlt || i == 1}? group_elements -> ^( MULT[tok2, newVal2] NUM[tok, newVal] group_elements ) | number | ^( MULT number primary[false] ) -> {$number.value == 0}? -> ^( MULT number primary ) | ^( MULT number eq ) -> {i == 0}? -> eq );", - (CDFA_SPECIAL_FUNC) dfa27_sst, - antlr3dfaspecialTransition, /* DFA specialTransition is currently just a default function in the runtime */ - antlr3dfapredict, /* DFA simulator function is in the runtime */ - dfa27_eot, /* EOT table */ - dfa27_eof, /* EOF table */ - dfa27_min, /* Minimum tokens for each state */ - dfa27_max, /* Maximum tokens for each state */ - dfa27_accept, /* Accept table */ - dfa27_special, /* Special transition states */ - dfa27_transitions /* Table of transition tables */ - - }; -/* End of Cyclic DFA 27 - * --------------------- - */ -/* ========================================================================= - * End of DFA tables for the parser - */ + /* ============================================== * Parsing rules */ @@ -1319,7 +955,7 @@ } } - else if ( (LA1_3 == UP || ((LA1_3 >= TO) && (LA1_3 <= FROM)) || LA1_3 == SELECT_DEF || LA1_3 == 44) ) + else if ( (LA1_3 == UP || ((LA1_3 >= TO) && (LA1_3 <= FROM)) || LA1_3 == SELECT_DEF || LA1_3 == 45) ) { alt1=1; } @@ -1388,15 +1024,38 @@ for (;;) { int alt2=2; - alt2 = cdfa2.predict(ctx, RECOGNIZER, ISTREAM, &cdfa2); - if (HASEXCEPTION()) { - goto rulepnEx; + /* dfaLoopbackState(k,edges,eotPredictsAlt,description,stateNumber,semPredState) + */ + int LA2_0 = LA(1); + if ( (LA2_0 == ID) ) + { + { + /* dfaLoopbackState(k,edges,eotPredictsAlt,description,stateNumber,semPredState) + */ + int LA2_1 = LA(2); + if ( (LA2_1 == DOWN) ) + { + { + /* dfaLoopbackState(k,edges,eotPredictsAlt,description,stateNumber,semPredState) + */ + int LA2_4 = LA(3); + if ( (LA2_4 == ID) ) + { + alt2=1; + } + + } + } + + } + } + else if ( (((LA2_0 >= SYNC_TOK) && (LA2_0 <= START))) ) + { + alt2=1; + } + } - if (HASFAILED()) - { - return retval; - } switch (alt2) { case 1: @@ -1762,7 +1421,7 @@ int alt7=2; { int LA7_0 = LA(1); - if ( (LA7_0 == 44) ) + if ( (LA7_0 == 45) ) { alt7=1; } @@ -2999,7 +2658,7 @@ pANTLR3_BASE_TREE root_1;_save_last_1 = _last; _first_last_1 = NULL; root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR));_last = (pANTLR3_BASE_TREE)LT(1); - string_literal26 = (pANTLR3_BASE_TREE) MATCHT(44, &FOLLOW_44_in_nondeterm227); + string_literal26 = (pANTLR3_BASE_TREE) MATCHT(45, &FOLLOW_45_in_nondeterm227); if (HASEXCEPTION()) { goto rulenondetermEx; @@ -3559,7 +3218,7 @@ /* dfaLoopbackState(k,edges,eotPredictsAlt,description,stateNumber,semPredState) */ int LA18_0 = LA(1); - if ( (LA18_0 == ID || LA18_0 == DOT) ) + if ( (LA18_0 == GROUP) ) { alt18=1; } @@ -3917,7 +3576,7 @@ /* dfaLoopbackState(k,edges,eotPredictsAlt,description,stateNumber,semPredState) */ int LA20_0 = LA(1); - if ( (LA20_0 == ID || LA20_0 == MULT || LA20_0 == DOT || LA20_0 == INT || ((LA20_0 >= EQS_OP) && (LA20_0 <= MINUS))) ) + if ( (LA20_0 == GROUP || LA20_0 == MULT || LA20_0 == INT || ((LA20_0 >= EQS_OP) && (LA20_0 <= MINUS))) ) { alt20=1; } @@ -4283,7 +3942,7 @@ { int LA24_0 = LA(1); - if ( (LA24_0 == ID || LA24_0 == MULT || LA24_0 == DOT || LA24_0 == INT || ((LA24_0 >= EQ_OP) && (LA24_0 <= MINUS))) ) + if ( (LA24_0 == GROUP || LA24_0 == MULT || LA24_0 == INT || ((LA24_0 >= EQ_OP) && (LA24_0 <= MINUS))) ) { alt24=1; } @@ -4494,7 +4153,7 @@ { int LA25_0 = LA(1); - if ( (LA25_0 == ID || LA25_0 == MULT || LA25_0 == DOT || LA25_0 == INT || ((LA25_0 >= PLUS) && (LA25_0 <= MINUS))) ) + if ( (LA25_0 == GROUP || LA25_0 == MULT || LA25_0 == INT || ((LA25_0 >= PLUS) && (LA25_0 <= MINUS))) ) { alt25=1; } @@ -4758,9 +4417,8 @@ } } break; - case ID: + case GROUP: case MULT: - case DOT: case INT: { alt26=1; @@ -4904,20 +4562,20 @@ /* AST REWRITE - * elements : add1, add2, add2, add1 + * elements : add2, add1, add1, add2 * token labels : - * rule labels : add2, add1, retval + * rule labels : add1, add2, retval * token list labels : * rule list labels : */ if ( BACKTRACKING==0 ) { - pANTLR3_REWRITE_RULE_SUBTREE_STREAM stream_add2; pANTLR3_REWRITE_RULE_SUBTREE_STREAM stream_add1; + pANTLR3_REWRITE_RULE_SUBTREE_STREAM stream_add2; pANTLR3_REWRITE_RULE_SUBTREE_STREAM stream_retval; - stream_add2=antlr3RewriteRuleSubtreeStreamNewAEE(ADAPTOR, RECOGNIZER, (pANTLR3_UINT8)"token add2", add2.tree != NULL ? add2.tree : NULL); stream_add1=antlr3RewriteRuleSubtreeStreamNewAEE(ADAPTOR, RECOGNIZER, (pANTLR3_UINT8)"token add1", add1.tree != NULL ? add1.tree : NULL); + stream_add2=antlr3RewriteRuleSubtreeStreamNewAEE(ADAPTOR, RECOGNIZER, (pANTLR3_UINT8)"token add2", add2.tree != NULL ? add2.tree : NULL); stream_retval=antlr3RewriteRuleSubtreeStreamNewAEE(ADAPTOR, RECOGNIZER, (pANTLR3_UINT8)"token retval", retval.tree != NULL ? retval.tree : NULL); root_0 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR)); @@ -4965,8 +4623,8 @@ } retval.tree = root_0; // set result root - if (stream_add2 != NULL) stream_add2->free(stream_add2); if (stream_add1 != NULL) stream_add1->free(stream_add1); + if (stream_add2 != NULL) stream_add2->free(stream_add2); if (stream_retval != NULL) stream_retval->free(stream_retval); @@ -5062,7 +4720,7 @@ /* AST REWRITE - * elements : add2, add1, add1, add2 + * elements : add2, add2, add1, add1 * token labels : * rule labels : add1, add2, retval * token list labels : @@ -5160,7 +481... [truncated message content] |
From: <the...@us...> - 2009-06-18 21:29:14
|
Revision: 75 http://pntool.svn.sourceforge.net/pntool/?rev=75&view=rev Author: thecodeweasel Date: 2009-06-18 21:28:52 +0000 (Thu, 18 Jun 2009) Log Message: ----------- Copying processes into threads for further setup. Minor optimization. Loading initialization vectors into petri nets Modified Paths: -------------- translator/generator.patch translator/pncompactor.c translator/pncompactor.g translator/pncompactor.h translator/pngenerator.c translator/pngenerator.g translator/pngenerator.h translator/pnscript.g translator/pnscriptLexer.c translator/pnscriptLexer.h translator/pnscriptParser.c translator/pnscriptParser.h Modified: translator/generator.patch =================================================================== --- translator/generator.patch 2009-06-18 20:18:15 UTC (rev 74) +++ translator/generator.patch 2009-06-18 21:28:52 UTC (rev 75) @@ -24,3 +24,15 @@ } // Now we decrement the scope's upper limit bound. We do not actually pop the scope as +@@ -473,9 +473,9 @@ + // + // If the user supplied the scope entries with a free function,then call it first + // +- if (SCOPE_TOP(proc_instantiations)>free != NULL) ++ if (SCOPE_TOP(proc_instantiations)->free != NULL) + { +- SCOPE_TOP(proc_instantiations)>->free(SCOPE_TOP(proc_instantiations)); ++ SCOPE_TOP(proc_instantiations)->free(SCOPE_TOP(proc_instantiations)); + } + + // Now we decrement the scope's upper limit bound. We do not actually pop the scope as Modified: translator/pncompactor.c =================================================================== --- translator/pncompactor.c 2009-06-18 20:18:15 UTC (rev 74) +++ translator/pncompactor.c 2009-06-18 21:28:52 UTC (rev 75) @@ -2,7 +2,7 @@ * This C source file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pncompactor.g - * - On : 2009-06-18 12:48:28 + * - On : 2009-06-18 14:59:09 * - for the tree parser : pncompactorTreeParser * * Editing it, at least manually, is not wise. * @@ -655,219 +655,216 @@ /** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init259 */ static ANTLR3_BITWORD FOLLOW_ID_in_proc_init259_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init259 = { FOLLOW_ID_in_proc_init259_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init261 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_init261_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000200) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init261 = { FOLLOW_ID_in_proc_init261_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_numbered_ID_in_proc_init263 */ -static ANTLR3_BITWORD FOLLOW_numbered_ID_in_proc_init263_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_numbered_ID_in_proc_init263 = { FOLLOW_numbered_ID_in_proc_init263_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SYNC_TOK_in_sync_def275 */ -static ANTLR3_BITWORD FOLLOW_SYNC_TOK_in_sync_def275_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SYNC_TOK_in_sync_def275 = { FOLLOW_SYNC_TOK_in_sync_def275_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_sync_def277 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def277_bits[] = { ANTLR3_UINT64_LIT(0x0000000000080208) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_sync_def277 = { FOLLOW_group_elements_in_sync_def277_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start289 */ -static ANTLR3_BITWORD FOLLOW_START_in_proc_start289_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start289 = { FOLLOW_START_in_proc_start289_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start291 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_start291_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start291 = { FOLLOW_ID_in_proc_start291_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints308 */ -static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints308_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints308 = { FOLLOW_constraint_block_in_constraints308_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints313 */ -static ANTLR3_BITWORD FOLLOW_eq_in_constraints313_bits[] = { ANTLR3_UINT64_LIT(0x00000001BE8A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints313 = { FOLLOW_eq_in_constraints313_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints319 */ -static ANTLR3_BITWORD FOLLOW_live_def_in_constraints319_bits[] = { ANTLR3_UINT64_LIT(0x0000000180000008) }; -static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints319 = { FOLLOW_live_def_in_constraints319_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints322 */ -static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints322_bits[] = { ANTLR3_UINT64_LIT(0x0000000100000008) }; -static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints322 = { FOLLOW_uncontrol_in_constraints322_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints325 */ -static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints325_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints325 = { FOLLOW_unobserve_in_constraints325_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block335 */ -static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block335_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block335 = { FOLLOW_ID_in_constraint_block335_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq344 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq344_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq344 = { FOLLOW_relationalExpression_in_eq344_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq350 */ -static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq350_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq350 = { FOLLOW_EQS_OP_in_eq350_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_numbered_ID_in_proc_init261 */ +static ANTLR3_BITWORD FOLLOW_numbered_ID_in_proc_init261_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_numbered_ID_in_proc_init261 = { FOLLOW_numbered_ID_in_proc_init261_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SYNC_TOK_in_sync_def273 */ +static ANTLR3_BITWORD FOLLOW_SYNC_TOK_in_sync_def273_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SYNC_TOK_in_sync_def273 = { FOLLOW_SYNC_TOK_in_sync_def273_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_sync_def275 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def275_bits[] = { ANTLR3_UINT64_LIT(0x0000000000080208) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_sync_def275 = { FOLLOW_group_elements_in_sync_def275_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start287 */ +static ANTLR3_BITWORD FOLLOW_START_in_proc_start287_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start287 = { FOLLOW_START_in_proc_start287_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start289 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_start289_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start289 = { FOLLOW_ID_in_proc_start289_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints306 */ +static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints306_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints306 = { FOLLOW_constraint_block_in_constraints306_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints311 */ +static ANTLR3_BITWORD FOLLOW_eq_in_constraints311_bits[] = { ANTLR3_UINT64_LIT(0x00000001BE8A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints311 = { FOLLOW_eq_in_constraints311_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints317 */ +static ANTLR3_BITWORD FOLLOW_live_def_in_constraints317_bits[] = { ANTLR3_UINT64_LIT(0x0000000180000008) }; +static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints317 = { FOLLOW_live_def_in_constraints317_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints320 */ +static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints320_bits[] = { ANTLR3_UINT64_LIT(0x0000000100000008) }; +static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints320 = { FOLLOW_uncontrol_in_constraints320_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints323 */ +static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints323_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints323 = { FOLLOW_unobserve_in_constraints323_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block333 */ +static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block333_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block333 = { FOLLOW_ID_in_constraint_block333_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq342 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq342_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq342 = { FOLLOW_relationalExpression_in_eq342_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq348 */ +static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq348_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq348 = { FOLLOW_EQS_OP_in_eq348_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq350 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq350_bits[] = { ANTLR3_UINT64_LIT(0x00000001BE8A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq350 = { FOLLOW_eq_in_eq350_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq352 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq352_bits[] = { ANTLR3_UINT64_LIT(0x00000001BE8A0208) }; +static ANTLR3_BITWORD FOLLOW_eq_in_eq352_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq352 = { FOLLOW_eq_in_eq352_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq354 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq354_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq354 = { FOLLOW_eq_in_eq354_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression370 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression370_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression370 = { FOLLOW_additiveExpression_in_relationalExpression370_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression379 */ -static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression379_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression379 = { FOLLOW_EQ_OP_in_relationalExpression379_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression381 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression381_bits[] = { ANTLR3_UINT64_LIT(0x000000001C8A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression381 = { FOLLOW_relationalExpression_in_relationalExpression381_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression385 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression385_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression385 = { FOLLOW_relationalExpression_in_relationalExpression385_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression406 */ -static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression406_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression406 = { FOLLOW_primary_in_additiveExpression406_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_PLUS_in_additiveExpression416 */ -static ANTLR3_BITWORD FOLLOW_PLUS_in_additiveExpression416_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_PLUS_in_additiveExpression416 = { FOLLOW_PLUS_in_additiveExpression416_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression420 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression420_bits[] = { ANTLR3_UINT64_LIT(0x00000000188A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression420 = { FOLLOW_additiveExpression_in_additiveExpression420_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression437 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression437_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression437 = { FOLLOW_additiveExpression_in_additiveExpression437_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_additiveExpression487 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_additiveExpression487_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_additiveExpression487 = { FOLLOW_MINUS_in_additiveExpression487_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression491 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression491_bits[] = { ANTLR3_UINT64_LIT(0x00000000188A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression491 = { FOLLOW_additiveExpression_in_additiveExpression491_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression507 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression507_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression507 = { FOLLOW_additiveExpression_in_additiveExpression507_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_primary568 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_primary568_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_primary568 = { FOLLOW_MINUS_in_primary568_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary572 */ -static ANTLR3_BITWORD FOLLOW_eq_in_primary572_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary572 = { FOLLOW_eq_in_primary572_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_primary589 */ -static ANTLR3_BITWORD FOLLOW_ID_in_primary589_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_primary589 = { FOLLOW_ID_in_primary589_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary636 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_primary636_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary636 = { FOLLOW_group_elements_in_primary636_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary677 */ -static ANTLR3_BITWORD FOLLOW_number_in_primary677_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_primary677 = { FOLLOW_number_in_primary677_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary686 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_primary686_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary686 = { FOLLOW_MULT_in_primary686_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary688 */ -static ANTLR3_BITWORD FOLLOW_number_in_primary688_bits[] = { ANTLR3_UINT64_LIT(0x00000000108A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_primary688 = { FOLLOW_number_in_primary688_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary690 */ -static ANTLR3_BITWORD FOLLOW_primary_in_primary690_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary690 = { FOLLOW_primary_in_primary690_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary725 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_primary725_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary725 = { FOLLOW_MULT_in_primary725_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary727 */ -static ANTLR3_BITWORD FOLLOW_number_in_primary727_bits[] = { ANTLR3_UINT64_LIT(0x00000001BE8A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_primary727 = { FOLLOW_number_in_primary727_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary731 */ -static ANTLR3_BITWORD FOLLOW_eq_in_primary731_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary731 = { FOLLOW_eq_in_primary731_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def755 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def755_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def755 = { FOLLOW_LIVE_in_live_def755_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def757 */ -static ANTLR3_BITWORD FOLLOW_ALL_in_live_def757_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def757 = { FOLLOW_ALL_in_live_def757_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def759 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def759_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def759 = { FOLLOW_ID_in_live_def759_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def767 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def767_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def767 = { FOLLOW_LIVE_in_live_def767_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def769 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def769_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def769 = { FOLLOW_ID_in_live_def769_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol781 */ -static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol781_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol781 = { FOLLOW_UNCONTROL_in_uncontrol781_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol783 */ -static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol783_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol783 = { FOLLOW_ID_in_uncontrol783_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve795 */ -static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve795_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve795 = { FOLLOW_UNOBSERVE_in_unobserve795_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve797 */ -static ANTLR3_BITWORD FOLLOW_ID_in_unobserve797_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve797 = { FOLLOW_ID_in_unobserve797_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands809 */ -static ANTLR3_BITWORD FOLLOW_print_in_other_commands809_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands809 = { FOLLOW_print_in_other_commands809_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print819 */ -static ANTLR3_BITWORD FOLLOW_PRINT_in_print819_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print819 = { FOLLOW_PRINT_in_print819_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print821 */ -static ANTLR3_BITWORD FOLLOW_ID_in_print821_bits[] = { ANTLR3_UINT64_LIT(0x0000000000080208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_print821 = { FOLLOW_ID_in_print821_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print823 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_print823_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print823 = { FOLLOW_group_elements_in_print823_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number842 */ -static ANTLR3_BITWORD FOLLOW_INT_in_number842_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_number842 = { FOLLOW_INT_in_number842_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_number855 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_number855_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_number855 = { FOLLOW_MINUS_in_number855_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number857 */ -static ANTLR3_BITWORD FOLLOW_INT_in_number857_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_number857 = { FOLLOW_INT_in_number857_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements874 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements874_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements874 = { FOLLOW_ID_in_group_elements874_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_DOT_in_group_elements880 */ -static ANTLR3_BITWORD FOLLOW_DOT_in_group_elements880_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_DOT_in_group_elements880 = { FOLLOW_DOT_in_group_elements880_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_group_elements882 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_group_elements882_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000200) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_group_elements882 = { FOLLOW_group_elements_in_group_elements882_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements884 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements884_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements884 = { FOLLOW_ID_in_group_elements884_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID894 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID894_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID894 = { FOLLOW_ID_in_numbered_ID894_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID900 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID900_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID900 = { FOLLOW_ID_in_numbered_ID900_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID902 */ -static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID902_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID902 = { FOLLOW_INT_in_numbered_ID902_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression368 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression368_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression368 = { FOLLOW_additiveExpression_in_relationalExpression368_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression377 */ +static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression377_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression377 = { FOLLOW_EQ_OP_in_relationalExpression377_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression379 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression379_bits[] = { ANTLR3_UINT64_LIT(0x000000001C8A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression379 = { FOLLOW_relationalExpression_in_relationalExpression379_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression383 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression383_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression383 = { FOLLOW_relationalExpression_in_relationalExpression383_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression404 */ +static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression404_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression404 = { FOLLOW_primary_in_additiveExpression404_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_PLUS_in_additiveExpression414 */ +static ANTLR3_BITWORD FOLLOW_PLUS_in_additiveExpression414_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_PLUS_in_additiveExpression414 = { FOLLOW_PLUS_in_additiveExpression414_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression418 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression418_bits[] = { ANTLR3_UINT64_LIT(0x00000000188A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression418 = { FOLLOW_additiveExpression_in_additiveExpression418_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression435 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression435_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression435 = { FOLLOW_additiveExpression_in_additiveExpression435_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_additiveExpression485 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_additiveExpression485_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_additiveExpression485 = { FOLLOW_MINUS_in_additiveExpression485_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression489 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression489_bits[] = { ANTLR3_UINT64_LIT(0x00000000188A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression489 = { FOLLOW_additiveExpression_in_additiveExpression489_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression505 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression505_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression505 = { FOLLOW_additiveExpression_in_additiveExpression505_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_primary566 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_primary566_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_primary566 = { FOLLOW_MINUS_in_primary566_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary570 */ +static ANTLR3_BITWORD FOLLOW_eq_in_primary570_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary570 = { FOLLOW_eq_in_primary570_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_primary587 */ +static ANTLR3_BITWORD FOLLOW_ID_in_primary587_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_primary587 = { FOLLOW_ID_in_primary587_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary634 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_primary634_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary634 = { FOLLOW_group_elements_in_primary634_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary675 */ +static ANTLR3_BITWORD FOLLOW_number_in_primary675_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_primary675 = { FOLLOW_number_in_primary675_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary684 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_primary684_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary684 = { FOLLOW_MULT_in_primary684_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary686 */ +static ANTLR3_BITWORD FOLLOW_number_in_primary686_bits[] = { ANTLR3_UINT64_LIT(0x00000000108A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_primary686 = { FOLLOW_number_in_primary686_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary688 */ +static ANTLR3_BITWORD FOLLOW_primary_in_primary688_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary688 = { FOLLOW_primary_in_primary688_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary723 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_primary723_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary723 = { FOLLOW_MULT_in_primary723_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary725 */ +static ANTLR3_BITWORD FOLLOW_number_in_primary725_bits[] = { ANTLR3_UINT64_LIT(0x00000001BE8A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_primary725 = { FOLLOW_number_in_primary725_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary729 */ +static ANTLR3_BITWORD FOLLOW_eq_in_primary729_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary729 = { FOLLOW_eq_in_primary729_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def753 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def753_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def753 = { FOLLOW_LIVE_in_live_def753_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def755 */ +static ANTLR3_BITWORD FOLLOW_ALL_in_live_def755_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def755 = { FOLLOW_ALL_in_live_def755_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def757 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def757_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def757 = { FOLLOW_ID_in_live_def757_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def765 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def765_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def765 = { FOLLOW_LIVE_in_live_def765_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def767 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def767_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def767 = { FOLLOW_ID_in_live_def767_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol779 */ +static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol779_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol779 = { FOLLOW_UNCONTROL_in_uncontrol779_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol781 */ +static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol781_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol781 = { FOLLOW_ID_in_uncontrol781_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve793 */ +static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve793_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve793 = { FOLLOW_UNOBSERVE_in_unobserve793_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve795 */ +static ANTLR3_BITWORD FOLLOW_ID_in_unobserve795_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve795 = { FOLLOW_ID_in_unobserve795_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands807 */ +static ANTLR3_BITWORD FOLLOW_print_in_other_commands807_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands807 = { FOLLOW_print_in_other_commands807_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print817 */ +static ANTLR3_BITWORD FOLLOW_PRINT_in_print817_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print817 = { FOLLOW_PRINT_in_print817_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print819 */ +static ANTLR3_BITWORD FOLLOW_ID_in_print819_bits[] = { ANTLR3_UINT64_LIT(0x0000000000080208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_print819 = { FOLLOW_ID_in_print819_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print821 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_print821_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print821 = { FOLLOW_group_elements_in_print821_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number840 */ +static ANTLR3_BITWORD FOLLOW_INT_in_number840_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_number840 = { FOLLOW_INT_in_number840_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_number853 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_number853_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_number853 = { FOLLOW_MINUS_in_number853_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number855 */ +static ANTLR3_BITWORD FOLLOW_INT_in_number855_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_number855 = { FOLLOW_INT_in_number855_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements872 */ +static ANTLR3_BITWORD FOLLOW_ID_in_group_elements872_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements872 = { FOLLOW_ID_in_group_elements872_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_DOT_in_group_elements878 */ +static ANTLR3_BITWORD FOLLOW_DOT_in_group_elements878_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_DOT_in_group_elements878 = { FOLLOW_DOT_in_group_elements878_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_group_elements880 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_group_elements880_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000200) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_group_elements880 = { FOLLOW_group_elements_in_group_elements880_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements882 */ +static ANTLR3_BITWORD FOLLOW_ID_in_group_elements882_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements882 = { FOLLOW_ID_in_group_elements882_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID892 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID892_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID892 = { FOLLOW_ID_in_numbered_ID892_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID898 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID898_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID898 = { FOLLOW_ID_in_numbered_ID898_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID900 */ +static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID900_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID900 = { FOLLOW_INT_in_numbered_ID900_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_synpred2_pncompactor90 */ static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_synpred2_pncompactor90_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_synpred2_pncompactor90 = { FOLLOW_proc_instantiations_in_synpred2_pncompactor90_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred29_pncompactor406 */ -static ANTLR3_BITWORD FOLLOW_primary_in_synpred29_pncompactor406_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred29_pncompactor406 = { FOLLOW_primary_in_synpred29_pncompactor406_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_synpred31_pncompactor568 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_synpred31_pncompactor568_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_synpred31_pncompactor568 = { FOLLOW_MINUS_in_synpred31_pncompactor568_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_synpred31_pncompactor572 */ -static ANTLR3_BITWORD FOLLOW_eq_in_synpred31_pncompactor572_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_synpred31_pncompactor572 = { FOLLOW_eq_in_synpred31_pncompactor572_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_synpred32_pncompactor589 */ -static ANTLR3_BITWORD FOLLOW_ID_in_synpred32_pncompactor589_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_synpred32_pncompactor589 = { FOLLOW_ID_in_synpred32_pncompactor589_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_synpred33_pncompactor636 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_synpred33_pncompactor636_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_synpred33_pncompactor636 = { FOLLOW_group_elements_in_synpred33_pncompactor636_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_synpred34_pncompactor677 */ -static ANTLR3_BITWORD FOLLOW_number_in_synpred34_pncompactor677_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_synpred34_pncompactor677 = { FOLLOW_number_in_synpred34_pncompactor677_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_synpred35_pncompactor686 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_synpred35_pncompactor686_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_synpred35_pncompactor686 = { FOLLOW_MULT_in_synpred35_pncompactor686_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_synpred35_pncompactor688 */ -static ANTLR3_BITWORD FOLLOW_number_in_synpred35_pncompactor688_bits[] = { ANTLR3_UINT64_LIT(0x00000000108A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_synpred35_pncompactor688 = { FOLLOW_number_in_synpred35_pncompactor688_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred35_pncompactor690 */ -static ANTLR3_BITWORD FOLLOW_primary_in_synpred35_pncompactor690_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred35_pncompactor690 = { FOLLOW_primary_in_synpred35_pncompactor690_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred29_pncompactor404 */ +static ANTLR3_BITWORD FOLLOW_primary_in_synpred29_pncompactor404_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred29_pncompactor404 = { FOLLOW_primary_in_synpred29_pncompactor404_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_synpred31_pncompactor566 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_synpred31_pncompactor566_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_synpred31_pncompactor566 = { FOLLOW_MINUS_in_synpred31_pncompactor566_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_synpred31_pncompactor570 */ +static ANTLR3_BITWORD FOLLOW_eq_in_synpred31_pncompactor570_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_synpred31_pncompactor570 = { FOLLOW_eq_in_synpred31_pncompactor570_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_synpred32_pncompactor587 */ +static ANTLR3_BITWORD FOLLOW_ID_in_synpred32_pncompactor587_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_synpred32_pncompactor587 = { FOLLOW_ID_in_synpred32_pncompactor587_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_synpred33_pncompactor634 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_synpred33_pncompactor634_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_synpred33_pncompactor634 = { FOLLOW_group_elements_in_synpred33_pncompactor634_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_synpred34_pncompactor675 */ +static ANTLR3_BITWORD FOLLOW_number_in_synpred34_pncompactor675_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_synpred34_pncompactor675 = { FOLLOW_number_in_synpred34_pncompactor675_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_synpred35_pncompactor684 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_synpred35_pncompactor684_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_synpred35_pncompactor684 = { FOLLOW_MULT_in_synpred35_pncompactor684_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_synpred35_pncompactor686 */ +static ANTLR3_BITWORD FOLLOW_number_in_synpred35_pncompactor686_bits[] = { ANTLR3_UINT64_LIT(0x00000000108A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_synpred35_pncompactor686 = { FOLLOW_number_in_synpred35_pncompactor686_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred35_pncompactor688 */ +static ANTLR3_BITWORD FOLLOW_primary_in_synpred35_pncompactor688_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred35_pncompactor688 = { FOLLOW_primary_in_synpred35_pncompactor688_bits, 1 }; @@ -877,29 +874,29 @@ /** Static dfa state tables for Cyclic dfa: * ()+ loopback of 30:22: ( proc_instantiations )+ */ -static const ANTLR3_INT32 dfa2_eot[8] = +static const ANTLR3_INT32 dfa2_eot[7] = { - -1, -1, -1, -1, -1, -1, -1, -1 + -1, -1, -1, -1, -1, -1, -1 }; -static const ANTLR3_INT32 dfa2_eof[8] = +static const ANTLR3_INT32 dfa2_eof[7] = { - 2, -1, -1, -1, -1, -1, -1, -1 + 2, -1, -1, -1, -1, -1, -1 }; -static const ANTLR3_INT32 dfa2_min[8] = +static const ANTLR3_INT32 dfa2_min[7] = { - 9, 2, -1, -1, 3, 3, 2, 0 + 9, 2, -1, -1, 3, 2, 0 }; -static const ANTLR3_INT32 dfa2_max[8] = +static const ANTLR3_INT32 dfa2_max[7] = { - 33, 2, -1, -1, 32, 32, 32, 0 + 33, 2, -1, -1, 32, 32, 0 }; -static const ANTLR3_INT32 dfa2_accept[8] = +static const ANTLR3_INT32 dfa2_accept[7] = { - -1, -1, 2, 1, -1, -1, -1, -1 + -1, -1, 2, 1, -1, -1, -1 }; -static const ANTLR3_INT32 dfa2_special[8] = +static const ANTLR3_INT32 dfa2_special[7] = { - -1, -1, -1, -1, -1, -1, -1, 0 + -1, -1, -1, -1, -1, -1, 0 }; /** Used when there is no transition table entry for a particular state */ @@ -907,26 +904,22 @@ static const ANTLR3_INT32 dfa2_T0[] = { - 3, 7, -1, -1, -1, -1, -1, 6, -1, -1, -1, -1, -1, -1, -1, 2, -1, 2, -1, + 3, 6, -1, -1, -1, -1, -1, 5, -1, -1, -1, -1, -1, -1, -1, 2, -1, 2, -1, -1, -1, 2, -1, 2, 2, 2, 2, 2, -1, 2, 2 };static const ANTLR3_INT32 dfa2_T1[] = { - -1 + 2, -1, -1, -1, -1, -1, 5, -1, -1, -1, -1, -1, -1, -1, 2, -1, 2, -1, -1, + -1, 2, -1, 2, 2, 2, 2, 2, -1, 2, 2 };static const ANTLR3_INT32 dfa2_T2[] = { - 4 + -1 };static const ANTLR3_INT32 dfa2_T3[] = { - 2, -1, -1, -1, -1, -1, 6, -1, -1, -1, -1, -1, -1, -1, 2, -1, 2, -1, -1, - -1, 2, -1, 2, 2, 2, 2, 2, -1, 2, 2 - };static const ANTLR3_INT32 dfa2_T4[] = - { 1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 3, 3, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 2 - };static const ANTLR3_INT32 dfa2_T5[] = + };static const ANTLR3_INT32 dfa2_T4[] = { - 2, -1, -1, -1, -1, -1, 5, -1, -1, -1, -1, -1, -1, -1, 2, -1, 2, -1, -1, - -1, 2, -1, 2, 2, 2, 2, 2, -1, 2, 2 + 4 }; /* Transition tables are a table of sub tables, with some tables @@ -934,8 +927,7 @@ */ static const ANTLR3_INT32 * const dfa2_transitions[] = { - dfa2_T4, dfa2_T2, dfa2_T_empty, dfa2_T_empty, dfa2_T5, dfa2_T3, dfa2_T0, - dfa2_T1 + dfa2_T3, dfa2_T4, dfa2_T_empty, dfa2_T_empty, dfa2_T1, dfa2_T0, dfa2_T2 }; static ANTLR3_INT32 dfa2_sst(ppncompactor ctx, pANTLR3_BASE_RECOGNIZER recognizer, pANTLR3_INT_STREAM is, pANTLR3_CYCLIC_DFA dfa, ANTLR3_INT32 s) @@ -948,15 +940,15 @@ case 0: { - ANTLR3_UINT32 LA2_7; + ANTLR3_UINT32 LA2_6; - ANTLR3_MARKER index2_7; + ANTLR3_MARKER index2_6; - LA2_7 = LA(1); + LA2_6 = LA(1); - index2_7 = INDEX(); + index2_6 = INDEX(); REWINDLAST(); @@ -972,7 +964,7 @@ } - SEEK(index2_7); + SEEK(index2_6); if ( s>=0 ) { @@ -1313,7 +1305,16 @@ int LA1_4 = LA(4); if ( (LA1_4 == DOWN) ) { - alt1=1; + { + /* dfaLoopbackState(k,edges,eotPredictsAlt,description,stateNumber,semPredState) + */ + int LA1_6 = LA(5); + if ( (LA1_6 == ID || LA1_6 == CODE_BLOCK) ) + { + alt1=1; + } + + } } } @@ -3308,7 +3309,7 @@ /** * $ANTLR start proc_init - * /Users/bion/projects/iordache/translator/pncompactor.g:52:1: proc_init : ^( ID ID ( numbered_ID )+ ) ; + * /Users/bion/projects/iordache/translator/pncompactor.g:52:1: proc_init : ^( ID ( numbered_ID )+ ) ; */ static pncompactor_proc_init_return proc_init(ppncompactor ctx) @@ -3322,13 +3323,11 @@ pANTLR3_BASE_TREE _first_0; pANTLR3_BASE_TREE ID31; - pANTLR3_BASE_TREE ID32; - pncompactor_numbered_ID_return numbered_ID33; - #undef RETURN_TYPE_numbered_ID33 - #define RETURN_TYPE_numbered_ID33 pncompactor_numbered_ID_return + pncompactor_numbered_ID_return numbered_ID32; + #undef RETURN_TYPE_numbered_ID32 + #define RETURN_TYPE_numbered_ID32 pncompactor_numbered_ID_return pANTLR3_BASE_TREE ID31_tree; - pANTLR3_BASE_TREE ID32_tree; /* Initialize rule variables */ @@ -3341,19 +3340,17 @@ _first_0 = NULL; ID31 = NULL; - ID32 = NULL; - numbered_ID33.tree = NULL; + numbered_ID32.tree = NULL; retval.start = LT(1); retval.stop = retval.start; ID31_tree = NULL; - ID32_tree = NULL; retval.tree = NULL; { - // /Users/bion/projects/iordache/translator/pncompactor.g:53:2: ( ^( ID ID ( numbered_ID )+ ) ) - // /Users/bion/projects/iordache/translator/pncompactor.g:53:4: ^( ID ID ( numbered_ID )+ ) + // /Users/bion/projects/iordache/translator/pncompactor.g:53:2: ( ^( ID ( numbered_ID )+ ) ) + // /Users/bion/projects/iordache/translator/pncompactor.g:53:4: ^( ID ( numbered_ID )+ ) { root_0 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR)); @@ -3381,21 +3378,8 @@ MATCHT(ANTLR3_TOKEN_DOWN, NULL); - _last = (pANTLR3_BASE_TREE)LT(1); - ID32 = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_proc_init261); - if (HASEXCEPTION()) + // /Users/bion/projects/iordache/translator/pncompactor.g:53:9: ( numbered_ID )+ { - goto ruleproc_initEx; - } - if (HASFAILED()) - { - return retval; - } - if ( BACKTRACKING ==0 ) { - ID32_tree = (pANTLR3_BASE_TREE)ADAPTOR->dupNode(ADAPTOR, ID32);ADAPTOR->addChild(ADAPTOR, root_1, ID32_tree); - } - // /Users/bion/projects/iordache/translator/pncompactor.g:53:12: ( numbered_ID )+ - { int cnt17=0; for (;;) @@ -3417,8 +3401,8 @@ // /Users/bion/projects/iordache/translator/pncompactor.g:0:0: numbered_ID { _last = (pANTLR3_BASE_TREE)LT(1); - FOLLOWPUSH(FOLLOW_numbered_ID_in_proc_init263); - numbered_ID33=numbered_ID(ctx); + FOLLOWPUSH(FOLLOW_numbered_ID_in_proc_init261); + numbered_ID32=numbered_ID(ctx); FOLLOWPOP(); if (HASEXCEPTION()) @@ -3430,7 +3414,7 @@ return retval; } if ( BACKTRACKING == 0 ) - { ADAPTOR->addChild(ADAPTOR, root_1, numbered_ID33.tree);} + { ADAPTOR->addChild(ADAPTOR, root_1, numbered_ID32.tree);} if ( BACKTRACKING ==0 ) { } @@ -3508,12 +3492,12 @@ pANTLR3_BASE_TREE _first_0; - pANTLR3_BASE_TREE SYNC_TOK34; - pncompactor_group_elements_return group_elements35; - #undef RETURN_TYPE_group_elements35 - #define RETURN_TYPE_group_elements35 pncompactor_group_elements_return + pANTLR3_BASE_TREE SYNC_TOK33; + pncompactor_group_elements_return group_elements34; + #undef RETURN_TYPE_group_elements34 + #define RETURN_TYPE_group_elements34 pncompactor_group_elements_return - pANTLR3_BASE_TREE SYNC_TOK34_tree; + pANTLR3_BASE_TREE SYNC_TOK33_tree; /* Initialize rule variables */ @@ -3525,12 +3509,12 @@ _first_0 = NULL; - SYNC_TOK34 = NULL; - group_elements35.tree = NULL; + SYNC_TOK33 = NULL; + group_elements34.tree = NULL; retval.start = LT(1); retval.stop = retval.start; - SYNC_TOK34_tree = NULL; + SYNC_TOK33_tree = NULL; retval.tree = NULL; @@ -3547,7 +3531,7 @@ pANTLR3_BASE_TREE root_1;_save_last_1 = _last; _first_last_1 = NULL; root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR));_last = (pANTLR3_BASE_TREE)LT(1); - SYNC_TOK34 = (pANTLR3_BASE_TREE) MATCHT(SYNC_TOK, &FOLLOW_SYNC_TOK_in_sync_def275); + SYNC_TOK33 = (pANTLR3_BASE_TREE) MATCHT(SYNC_TOK, &FOLLOW_SYNC_TOK_in_sync_def273); if (HASEXCEPTION()) { goto rulesync_defEx; @@ -3557,9 +3541,9 @@ return retval; } if ( BACKTRACKING == 0 ) { - SYNC_TOK34_tree = (pANTLR3_BASE_TREE)ADAPTOR->dupNode(ADAPTOR, SYNC_TOK34); + SYNC_TOK33_tree = (pANTLR3_BASE_TREE)ADAPTOR->dupNode(ADAPTOR, SYNC_TOK33); - root_1 = (pANTLR3_BASE_TREE)ADAPTOR->becomeRoot(ADAPTOR, SYNC_TOK34_tree, root_1); + root_1 = (pANTLR3_BASE_TREE)ADAPTOR->becomeRoot(ADAPTOR, SYNC_TOK33_tree, root_1); } @@ -3587,8 +3571,8 @@ // /Users/bion/projects/iordache/translator/pncompactor.g:0:0: group_elements { _last = (pANTLR3_BASE_TREE)LT(1); - FOLLOWPUSH(FOLLOW_group_elements_in_sync_def277); - group_elements35=group_elements(ctx); + FOLLOWPUSH(FOLLOW_group_elements_in_sync_def275); + group_elements34=group_elements(ctx); FOLLOWPOP(); if (HASEXCEPTION()) @@ -3600,7 +3584,7 @@ return retval; } if ( BACKTRACKING == 0 ) - { ADAPTOR->addChild(ADAPTOR, root_1, group_elements35.tree);} + { ADAPTOR->addChild(ADAPTOR, root_1, group_elements34.tree);} if ( BACKTRACKING ==0 ) { } @@ -3678,11 +3662,11 @@ pANTLR3_BASE_TREE _first_0; - pANTLR3_BASE_TREE START36; - pANTLR3_BASE_TREE ID37; + pANTLR3_BASE_TREE START35; + pANTLR3_BASE_TREE ID36; - pANTLR3_BASE_TREE START36_tree; - pANTLR3_BASE_TREE ID37_tree; + pANTLR3_BASE_TREE START35_tree; + pANTLR3_BASE_TREE ID36_tree; /* Initialize rule variables */ @@ -3694,12 +3678,12 @@ _first_0 = NULL; - START36 = NULL; - ID37 = NULL; + START35 = NULL; + ID36 = NULL; retval.start = LT(1); retval.stop = retval.start; - START36_tree = NULL; - ID37_tree = NULL; + START35_tree = NULL; + ID36_tree = NULL; retval.tree = NULL; @@ -3716,7 +3700,7 @@ pANTLR3_BASE_TREE root_1;_save_last_1 = _last; _first_last_1 = NULL; root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR));_last = (pANTLR3_BASE_TREE)LT(1); - START36 = (pANTLR3_BASE_TREE) MATCHT(START, &FOLLOW_START_in_proc_start289); + START35 = (pANTLR3_BASE_TREE) MATCHT(START, &FOLLOW_START_in_proc_start287); if (HASEXCEPTION()) { goto ruleproc_startEx; @@ -3726,9 +3710,9 @@ return retval; } if ( BACKTRACKING == 0 ) { - START36_tree = (pANTLR3_BASE_TREE)ADAPTOR->dupNode(ADAPTOR, START36); + START35_tree = (pANTLR3_BASE_TREE)ADAPTOR->dupNode(ADAPTOR, START35); - root_1 = (pANTLR3_BASE_TREE)ADAPTOR->becomeRoot(ADAPTOR, START36_tree, root_1); + root_1 = (pANTLR3_BASE_TREE)ADAPTOR->becomeRoot(ADAPTOR, START35_tree, root_1); } @@ -3756,7 +3740,7 @@ // /Users/bion/projects/iordache/translator/pncompactor.g:0:0: ID { _last = (pANTLR3_BASE_TREE)LT(1); - ID37 = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_proc_start291); + ID36 = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_proc_start289); if (HASEXCEPTION()) { goto ruleproc_startEx; @@ -3766,7 +3750,7 @@ return retval; } if ( BACKTRACKING ==0 ) { - ID37_tree = (pANTLR3_BASE_TREE)ADAPTOR->dupNode(ADAPTOR, ID37);ADAPTOR->addChild(ADAPTOR, root_1, ID37_tree); + ID36_tree = (pANTLR3_BASE_TREE)ADAPTOR->dupNode(ADAPTOR, ID36);ADAPTOR->addChild(ADAPTOR, root_1, ID36_tree); } ... [truncated message content] |
From: <Ste...@us...> - 2009-06-18 20:18:19
|
Revision: 74 http://pntool.svn.sourceforge.net/pntool/?rev=74&view=rev Author: StephenCamp Date: 2009-06-18 20:18:15 +0000 (Thu, 18 Jun 2009) Log Message: ----------- StructuredIO.c: Added some necessary comments, changed DisplayStructure's handling of empty matrices. pn2acpn: Testing still in progress. DO NOT USE yet. test-pn2acpn.c/mak/txt: The test files for pn2acpn. spnbox: Added the definitions for pn2acpn. test-nltrans.txt/mak/c: The test files for nltrans. clean.bsh: Deleted. This was a shell script for me to use during development. Modified Paths: -------------- spnbox/spnbox.h spnbox/tests/StructuredIO.c Added Paths: ----------- spnbox/pn2acpn.c spnbox/tests/test-nltrans.mak spnbox/tests/test-nltrans.txt spnbox/tests/test-pn2acpn.c spnbox/tests/test-pn2acpn.mak spnbox/tests/test-pn2acpn.txt Removed Paths: ------------- spnbox/tests/clean.bsh Property Changed: ---------------- spnbox/tests/ Added: spnbox/pn2acpn.c =================================================================== --- spnbox/pn2acpn.c (rev 0) +++ spnbox/pn2acpn.c 2009-06-18 20:18:15 UTC (rev 74) @@ -0,0 +1,614 @@ +#include "MemoryManager.h" +#include "spnbox.h" +#include "matrixmath.h" + +/*Subroutine declarations. See subroutine implementation for descriptions.*/ +void AddPlaces(pn2acpn_r* result, matrix* Dm, int Transition, int* Qflag, int QLength, int* ipl, int ipCount, int* dpl, int dpCount); + +int GetQPlace(matrix* U, int Pair, int* Qflag, int* mask, pn2acpn_r* result); + +matrix GetU(int* cardbt, pn2acpn_r* result, int Transition, int OriginalPlaces); + +int InitParts(MemoryManager* mem, pn2acpn_r* result, int** cardbt, int** cardbtx, int** Qflag, matrix* Dm, matrix* Dp, matrix* MX, matrix* L0); + +int CheckParams(MemoryManager* mem, matrix* Dm, matrix* Dp, int** Mask, matrix* MX, matrix* L0, matrix* L, int **ipl, int *ipCount, int **dpl, int *dpCount); + +int CheckParams(MemoryManager* mem, matrix* Dm, matrix* Dp, int** Mask, matrix* MX, matrix* L0, matrix* L, int **ipl, int *ipCount, int **dpl, int *dpCount); + +void FinalizeResult(pn2acpn_r* result, matrix* L, matrix* Dm, int* ipl, int ipCount); + +/*The function itself. pn2acpn transforms a Petri net to an asymmetric choice +Petri net*/ +pn2acpn_r pn2acpn(matrix* Dm, matrix* Dp, int* Mask, matrix* MX, matrix* L0, matrix* L, int *ipl, int ipCount, int* dpl, int dpCount) +{ + int Transition, Transitions, Places, i, j, x; + int *cardbt, *cardbtx, *Qflag; + MemoryManager mem; + matrix U; + pn2acpn_r result; + + /*Initialize the value to be returned to an error value.*/ + memset(&result, 0, sizeof(pn2acpn_r)); + + /*Initialize the memory manager.*/ + mem = CreateMemoryManager(10, 5, 0, 0); + + if (! CheckParams(&mem, Dm, Dp, &Mask, MX, L0, L, &ipl, &ipCount, &dpl, &dpCount)) + { + return result; + } + Places = NumberOfRows(*Dm); + Transitions = NumberOfColumns(*Dm); + + /*Initialize parts of the return value and the flag matrices cardbt and + cardbtx. This function returns the index of the first transition which should + be processed.*/ + Transition = InitParts(&mem, &result, &cardbt, &cardbtx, &Qflag, Dm, Dp, MX, L0); + + /*Loop until there are no more transitions to be processed. This will be when + Transition has been set to -1 by either of the functions responsible for + finding the next transition to be processed.*/ + while (Transition >= 0) + { + + cardbtx[Transition] = 0; + /*Get U, a 2xn matrix each column of which contains a pair of place + indices for which a particular relationship holds.*/ + U = GetU(cardbt, &result, Transition, NumberOfRows(*Dm)); + + /*Iterate through each of the place pairs. From each pair we will develop + the index of a single place, for which we will set the Q-flag and with + which we will make an alteration to the cardbtx flag array.*/ + /*The Q-flag array defaults to all cleared.*/ + memset(Qflag, 0, sizeof(int) * Places); + for (i = 0; i < NumberOfColumns(U); i++) + { + /*Get the index of some particular place algorithmically.*/ + if ((x = GetQPlace(&U, i, Qflag, Mask, &result)) >= 0) + { + /*Set the corresponding q flag.*/ + Qflag[x] = 1; + /*We OR cardbtx with cardbt AND the place from Dm*/ + for (j = 0; j < NumberOfColumns(*Dm); j++) + { + cardbtx[j] = cardbtx[j] || (cardbt[j] && GetMatrixEl(Dm, x, j)); + } + } + } + /*Free the memory allocated for the U vector now that we don't need it + anymore.*/ + DeallocateMatrix(&U); + /*Fill in the new places and transitions we reserved memory for above.*/ + AddPlaces(&result, Dm, Transition, Qflag, Places, ipl, ipCount, dpl, dpCount); + /*Clear the current element of cardbtx in case it was reset some how.*/ + cardbtx[Transition] = 0; + /*Find the next transition to be processed. This will be the first one with + a set cardbtx flag. The next transition number defaults to -1 to indicate + that there are no more transitions to be processed.*/ + Transition = -1; + for (i = 0; i < Transitions; i++) + { + if (cardbtx[i]) + { + Transition = i; + break; + } + } + } + /*Finalize the result structure; fill in the last few values.*/ + FinalizeResult(&result, L, Dm, ipl, ipCount); + FreeMemory(&mem); + return result; +} + + +/************************************************** + Subroutines +**************************************************/ +/* +FinalizeResult takes the result structure and fills in values that are not +computed during the main processing loop: the incidence matrix Df, the new +marking constraint matrix Lf, and the new independent place list iplf. +*/ +void FinalizeResult(pn2acpn_r* result, matrix* L, matrix* Dm, int* ipl, int ipCount) +{ + int places, lrows, oldplaces, i, place; + /*Fill the incidence matrix.*/ + result->Df = SubtractMatrix(&result->Dpf, &result->Dmf, (matrix*) 2); + + if (L) + { + lrows = NumberOfRows(*L); + oldplaces = NumberOfColumns(*L); + } + else + { + lrows = 0; + oldplaces = NumberOfRows(*Dm); + } + places = NumberOfRows(result->Df); + + /*The new L matrix should be the same as the old with columns of zeros added + for all the new places.*/ + AllocateMatrixType(2, &result->LF, lrows, places); + CopyBlock(lrows, oldplaces, L, 0, 0, &result->LF, 0, 0); + + /*The new independent place list should contain all the places that were + added and each of the old places.*/ + result->iplfCount = ipCount + (places - oldplaces); + result->iplf = tcalloc(result->iplfCount, sizeof(int)); + for (i = 0; i < ipCount; i++) + { + result->iplf[i] = ipl[i]; + } + place = oldplaces; + for (; i < result->iplfCount; i++) + { + result->iplf[i] = place++; + } +} + +/* +AddPlaces is responsible for filling in the values in the transitions and +places that are added during each iteration of the main processing loop. It +fills in values in the Petri net matrices, in the initial marking constraint +matrix L0f, and in the independent-to-dependent marking transformation matrix +MXf. It requires the result vector, the original output matrix, the transition +currently being processed by the main processing loop, the vector of Q flags, +the length of the vector of Q flags, and the lists of dependent and independent +places. +*/ +void AddPlaces(pn2acpn_r* result, matrix* Dm, int Transition, int* Qflag, int Qlength, int* ipl, int ipCount, int* dpl, int dpCount) +{ + int Rows, Cols, i, j, x, ToAdd = 0; + matrix Dmf, Dpf, MX, L0; + /*We will be adding a place and transition for each set Qflag. Count them.*/ + for (i = 0; i < Qlength; i++) + { + if (Qflag[i]) ToAdd++; + } + + /*We will be adding new columns to MX and L0. Reseve space and copy + existing columns.*/ + if (NumberOfRows(result->MXF)) + { + AllocateMatrixType(2, &MX, NumberOfRows(result->MXF), NumberOfColumns(result->MXF) + ToAdd); + CopyBlock(NumberOfRows(result->MXF), NumberOfColumns(result->MXF), &result->MXF, 0, 0, &MX, 0, 0); + } + else + { + /*Zero MX.*/ + AllocateMatrix(&MX, 0, 0); + } + if (NumberOfRows(result->L0F)) + { + AllocateMatrixType(2, &L0, NumberOfRows(result->L0F), NumberOfColumns(result->L0F) + ToAdd); + CopyBlock(NumberOfRows(result->L0F), NumberOfColumns(result->L0F), &result->L0F, 0, 0, &L0, 0, 0); + } + else + { + AllocateMatrix(&L0, 0, 0); + } + + /*We add rows and columns to the Petri net matrices. Store them temporarily + in the local Dmf and Dpf matrices. Allocate space and copy the existing + matrices into the new space.*/ + Rows = NumberOfRows(result->Dmf); + Cols = NumberOfColumns(result->Dmf); + AllocateMatrixType(2, &Dmf, Rows + ToAdd, Cols + ToAdd); + AllocateMatrixType(2, &Dpf, Rows + ToAdd, Cols + ToAdd); + CopyBlock(Rows, Cols, &result->Dmf, 0, 0, &Dmf, 0, 0); + CopyBlock(Rows, Cols, &result->Dpf, 0, 0, &Dpf, 0, 0); + /*Iterate through the places which have been Q-flagged. At each one add a new + place and transition. Use j to keep track of which place or transition is + being added.*/ + j = 0; + for (i = 0; i < Qlength; i++) + { + if (! Qflag[i]) continue; + /*Zero the output arc at the place and transition of interest*/ + SetMatrixEl(&Dmf, i, Transition, 0); + /*The place gets an output arc added at the new transition*/ + SetMatrixEl(&Dmf, i, Cols + j, 1); + /*The new place gets an input arc added at the new transition*/ + SetMatrixEl(&Dpf, Rows + j, Cols + j, 1); + /*The new place gets an output arc added to the current transition, with + the same weight as the original output arc at the place and transition of + interest.*/ + SetMatrixEl(&Dmf, Rows + j, Transition, GetMatrixEl(Dm, i, Transition)); + /*Modify MX and L0 if they exist.*/ + if (NumberOfRows(MX) || NumberOfRows(L0)) + { + /*Find out if the current place is independent..*/ + for (x = 0; x < ipCount; x++) + { + if (ipl[x] == i) + { + break; + } + } + /*If it is, we want to copy to the new columns of MX and L0 the values + in their respective existing columns corresponding to the independent + place just found. (if they exist)*/ + if (x < ipCount) + { + if (NumberOfRows(MX)) + { + CopyBlock(NumberOfRows(MX), 1, &MX, 0, x, &MX, 0, NumberOfColumns(MX) - ToAdd + j); + } + if (NumberOfRows(L0)) + { + CopyBlock(NumberOfRows(L0), 1, &L0, 0, x, &L0, 0, NumberOfColumns(L0) - ToAdd + j); + } + } + /*If not, we fill the new column of MX with a -1 in the row corresponding + to the dependent place indexed to by i. The new column of L0 remains zeroed.*/ + else + { + /*Get the index of the place.*/ + for (x = 0; x < dpCount; x++) + { + if (dpl[x] == i) break; + } + if (x < dpCount) + { + SetMatrixEl(&MX, x, NumberOfColumns(MX) - ToAdd + j, -1); + } + } + } + /*Increment the added-place counter.*/ + j++; + } + /*Now deallocate the old matrices and replace them with the new.*/ + DeallocateMatrix(&result->Dmf); + result->Dmf = Dmf; + DeallocateMatrix(&result->Dpf); + result->Dpf = Dpf; + if (NumberOfRows(MX)) + { + DeallocateMatrix(&result->MXF); + result->MXF = MX; + } + if (NumberOfRows(L0)) + { + DeallocateMatrix(&result->L0F); + result->L0F = L0; + } +} + +/*GetQPlace examines the pair of place indices in the U matrix that is +currently being processed and selects and returns on of the indicies, to be used +to set a Q-flag and perform operations on the cardbtx flag vector. +It requires the U matrix, the pair number ot process, the vector of Q-flags, +the mask provided to pn2acpn, and the result structure for read access to Dmf +and Dpf.*/ +int GetQPlace(matrix* U, int Pair, int* Qflag, int* mask, pn2acpn_r* result) +{ + int U1, U2, i, arcCount1, arcCount2; + U1 = GetMatrixEl(U, 0, Pair); + U2 = GetMatrixEl(U, 1, Pair); + + /*If neither U1 nor U2 indexes a place that has a high mask bit, there is no + valid Q index. Return -1.*/ + if (! (mask[U1] || mask[U2])) + { + return -1; + } + /*If only one of U1 or U2 index a place with a high mask bit, that place is + the Q index.*/ + if (mask[U1] && (! mask[U2])) + { + return U1; + } + if ((! mask[U1]) && mask[U2]) + { + return U2; + } + /*Otherwise, we do some other tests to eliminate one of the numbers.*/ + /*If the qflags for both of the U indices are still 0...*/ + if (! (Qflag[U1] && Qflag[U2])) + { + //If we are examining any but the last pair of place indexes: + if (Pair < NumberOfColumns(*U)) + { + /*If the first index in the next pair is the same as the first index in this pair, return that index.*/ + if (U1 == GetMatrixEl(U, 0, Pair + 1)) + { + return U1; + } + else + { + /*Otherwise, if there exist any pairs after the current one such that one of their indicies is the same as the second index of the current pair, return the second index of the current pair.*/ + for (i = Pair; i < NumberOfColumns(*U); i++) + { + if (GetMatrixEl(U, 0, i) == U2 || GetMatrixEl(U, 1, i) == U2) + { + return U2; + } + } + } + } + /*If we get here, then we count the number of nonzero output arcs in the places specified by U1 and U2. We return the index of the place with the most nonzero output arcs.*/ + arcCount1 = 0; + arcCount2 = 0; + for (i = 0; i < NumberOfColumns(result->Dmf); i++) + { + if (GetMatrixEl(&result->Dmf, U1, i)) arcCount1++; + if (GetMatrixEl(&result->Dpf, U2, i)) arcCount1++; + } + if (arcCount1 >= arcCount2) + { + return U1; + } + else + { + return U2; + } + } + //If we get here, no valid place number was found. Return -1. + return -1; +} + +/*GetU creates and returns a 2 x n matrix, each column of which is a pair of +place indices such that the places exhibit some special relationship. The U +matrix is specific to the transition currently being investigated. Its +calculation requires the cardbt flag vector, the result structure for access +to the Petri net matrices, the index of the transition currently being processed, +and a count of the number of places in the original Petri net.*/ +matrix GetU(int* cardbt, pn2acpn_r* result, int Transition, int OriginalPlaces) +{ + int *Row0, *Row1; + int NextCol, ColCapacity, i, j, k, flag0, flag1, Transitions, dmi, dmj; + Transitions = NumberOfColumns(result->Dmf); + matrix U; + + /*U will be a 2xn matrix, where each column contains a pair of place + indices. The pairs are determined algorithmically by examining all places in + the current transition that are nonzero.*/ + + /*It is hard to predict the number of pairs that will be found. Store pairs + in an array that will be reallocated periodically if necessary. Allocated + in blocks the size of the number of places.*/ + Row0 = tcalloc(OriginalPlaces, sizeof(int)); + Row1 = tcalloc(OriginalPlaces, sizeof(int)); + NextCol = 0; + ColCapacity = OriginalPlaces; + + /*Iterate through all the places in the transition of interest.*/ + for (i = 0; i < OriginalPlaces - 1; i++) + { + //If the output arc here is nonzero... + if (GetMatrixEl(&result->Dmf, i, Transition)) + { + /*Iterate through all the remaining places*/ + for (j = i; j < OriginalPlaces; j++) + { + //If the output arc is nonzero... + if (GetMatrixEl(&result->Dmf, j, Transition)) + { + /*The original Matlab algorithm set a flag according to this + algorithm: (some variable names changed to make it apparent in terms + of variables already used): + prj = Dmf(i,:) ~= 0; % p_j\bullet + prk = Dmf(j,:) ~= 0; % p_k\bullet + flag = sum((~prj) & (prj | prk)) & sum((~prk) & (prj | prk)); + The same operation can be reduced to a pair of examinations, one + to get the results of the operation logical of + sum((~prj) & (prj | prk)) and the next to get the results of the + operation logical of sum((~prk) & (prj | prk))*/ + flag0 = 0; + flag1 = 0; + for (k = 0; k < Transitions; k++) + { + dmi = GetMatrixEl(&result->Dmf, i, k); + dmj = GetMatrixEl(&result->Dmf, j, k); + if ((! dmi) && dmj) + { + flag0 = 1; + } + if ((! dmj) && dmi) + { + flag1 = 1; + } + } + /*If both flags are set, we add the current pair of places to the + U-matrix.*/ + if (flag0 && flag1) + { + /*If there is space left in the temporary holding places, use it. If + not, reallocate with more space.*/ + if (NextCol == ColCapacity) + { + Row0 = realloc(Row0, (ColCapacity += OriginalPlaces) * sizeof(int)); + Row1 = realloc(Row1, (ColCapacity += OriginalPlaces) * sizeof(int)); + } + Row0[NextCol] = i; + Row1[NextCol++] = j; + } + } + } + } + } + /*Copy the contents of Row0 and Row1 into the U-matrix.*/ + AllocateMatrixType(2, &U, 2, NextCol); + for (i = 0; i < NextCol; i++) + { + SetMatrixEl(&U, 0, i, Row0[i]); + SetMatrixEl(&U, 1, i, Row1[i]); + } + free(Row0); + free(Row1); + return U; +} + +/* +InitParts initializes intermediate variables cardbt and cardbtx, flag arrays, +Qflag, a flag array, and the Petri net matrices in the result structure. +*/ +int InitParts(MemoryManager* mem, pn2acpn_r* result, int** cardbt, int** cardbtx, int** Qflag, matrix* Dm, matrix* Dp, matrix* MX, matrix* L0) +{ + int Places, Transitions, i, j, res = -1; + Places = NumberOfRows(*Dm); + Transitions = NumberOfColumns(*Dp); + + /*The result Petri net matrices should default to the same as the passed + matrices. The result MX and L0 should also default to the same as the passed + MX and L0, if they were given.*/ + AllocateMatrixType(2, &result->Dmf, Places, Transitions); + CopyMatrix(Dm, &result->Dmf); + AllocateMatrixType(2, &result->Dpf, Places, Transitions); + CopyMatrix(Dp, &result->Dpf); + if (MX) + { + AllocateMatrixType(2, &result->MXF, NumberOfRows(*MX), NumberOfColumns(*MX)); + CopyMatrix(MX, &result->MXF); + } + if (L0) + { + AllocateMatrixType(2, &result->L0F, NumberOfRows(*L0), NumberOfColumns(*L0)); + CopyMatrix(L0, &result->L0F); + } + + /*The Q-flag array has an element for each place.*/ + *Qflag = mcalloc(mem, Places, sizeof(int)); + + /*cardbt and cardbts are flag arrays with elements for each transition. They + default to containing a count of the number of nonzero output arcs associated + with the appropriate transition.*/ + *cardbt = mcalloc(mem, Transitions, sizeof(int)); + *cardbtx = mcalloc(mem, Transitions, sizeof(int)); + /*The return value should be the index of the first transition which will be + processed. This is the index of the first transition such that the associated + value of cardbt is greater than one.*/ + for (i = 0; i < Transitions; i++) + { + for (j = 0; j < Places; j++) + { + if (GetMatrixEl(Dm, j, i)) + { + (*cardbt)[i]++; + (*cardbtx)[i]++; + } + if (res < 0 && (*cardbt)[i] > 1) + { + res = i; + } + } + } + + return res; +} + +/* +CheckParams examines the parameters to make sure that required parameters are +present and dimensions and array counts are consistent. It also fills in default +values where appropriate. +*/ +int CheckParams(MemoryManager* mem, matrix* Dm, matrix* Dp, int** Mask, matrix* MX, matrix* L0, matrix* L, int **ipl, int *ipCount, int **dpl, int *dpCount) +{ + int Places, Transitions, i, j; + + /*Dm - output matrix. Required. Same size as Dp. + Dp - input matrix. Required. Same size as Dm. */ + if (! (Dm && Dp)) + { + merror(0, "PN2ACPN: One of the required parameters Dm or Dp was null"); + return 0; + } + Places = NumberOfRows(*Dm); + Transitions = NumberOfColumns(*Dm); + if (NumberOfRows(*Dp) != Places || NumberOfColumns(*Dm) != Transitions) + { + merror(0, "PN2ACPN: The sizes of the input and output matrices Dp and Dm do not agree"); + return 0; + } + + /*Mask = array of int flags. Not required. Defaults to array of 1s, one for + each place (row of D).*/ + if (! *Mask) + { + (*Mask) = mcalloc(mem, Places, sizeof(int)); + for (i = 0; i < Places; i++) + { + (*Mask)[i] = 1; + } + } + + /*L0 - matrix, initial marking constraint. Not required. If present must have + the same number of columns as there are places.*/ + if (L0) + { + if (NumberOfColumns(*L0) != Places) + { + FreeMemory(mem); + merror(0, "PN2ACPN: The size of L0 and the Petri net matrices do not agree"); + return 0; + } + } + + /*L - matrix, marking constraint. Not required. If present must have the same + number of columns as there are places.*/ + if (L) + { + if (NumberOfColumns(*L) != Places) + { + FreeMemory(mem); + merror(0, "PN2ACPN: The size of L and the Petri net matrices do not agree"); + return 0; + } + } + + /*ipl, dpl: unpredictable-length int arrays, holding indices of independent + and dependent places. Not required. If either array pointer is null the count + should be set to zero and vice-versa. + Total number of ipl and dpl must be same as number of places if given. ipl + defaults to indexes of all places, dpl defaults to empty set.*/ + if (! *ipl) + { + *ipCount = 0; + } + else if (! ipCount) + { + *ipl = 0; + } + if (! *dpl) + { + *dpCount = 0; + } + else if (! (*dpCount)) + { + *dpl = 0; + } + + if (! (*ipCount)) + { + *ipl = mcalloc(mem, Places, sizeof(int)); + for (i = 0; i < Places; i++) + { + (*ipl)[i] = i; + } + *ipCount = Places; + } + + if (*ipCount + *dpCount != Places) + { + FreeMemory(mem); + merror(0, "PN2ACPN: The independent and dependent place list lengths do not agree with the number of places"); + return 0; + } + + /*MX - matrix, same meaning as in msplit: is the transformation matrix from + the independent marking to the dependent marking. Not required. If present, + must have the same number of rows as there are dependent places and the same + number of columns as there are independent places (if those counts are given)*/ + if (MX && ipCount && dpCount) + { + if (NumberOfRows(*MX) != *dpCount || NumberOfColumns(*MX) != *ipCount) + { + FreeMemory(mem); + merror(0, "PN2ACPN: The size of the transformation matrix MX and the dependent and independent place counts do not agree"); + return 0; + } + } + return 1; +} Modified: spnbox/spnbox.h =================================================================== --- spnbox/spnbox.h 2009-06-18 19:27:22 UTC (rev 73) +++ spnbox/spnbox.h 2009-06-18 20:18:15 UTC (rev 74) @@ -71,6 +71,18 @@ int dtrCount; } nltrans_r; +typedef struct pn2acpn_r +{ + matrix Df; + matrix Dmf; + matrix Dpf; + matrix MXF; + matrix L0F; + matrix LF; + int *iplf; + int iplfCount; +} pn2acpn_r; + /*Constants returned in by functions to indicate the nature of the result.*/ #define HOW_ERROR "error" #define HOW_OK "OK" @@ -319,4 +331,37 @@ Written by Marian V. Iordache, mar...@le.... Converted to C by Marian V. Iordache and Stephen Camp, ste...@le... */ + +pn2acpn_r pn2acpn(matrix* Dm, matrix* Dp, int* Mask, matrix* MX, matrix* L0, matrix* L, int *ipl, int ipCount, int* dpl, int dpCount); +/* +PN2ACPN - Transforms a Petri net to an asymmetric choice Petri net + +[Df, Dmf, Dpf] = pn2acpn(D) + +[Df, Dmf, Dpf] = pn2acpn(Dm, Dp) + +[Df, Dmf, Dpf] = pn2acpn(Dm, Dp, mask) + +[Df, Dmf, Dpf, MF, L0F, LF, iplf] = pn2acpn(Dm, Dp, mask, M, L0, L, ipl, dpl) + +mask is an optional argument: mask(i) = 1 if the place i is +in the set M of the technical report. (M in the tech. report has +a different meaning than M in the TLE program.) + +The last four parameters are optional. See TLE code for meaning. +Their updated values are given as output. + +If called before the first iteration, take LF = MF, as the computation +of LF does not consider this case! + +See MSPLIT. + + +Written by Marian V. Iordache, mar...@le... +M. Iordache -- Sep. 4, 2000 +revised on Oct. 24, 2001 + +Converted to C by Marian V. Iordache and Stephen Camp, ste...@le... +Stephen Camp -- Jun. 18, 2009 +*/ #endif Property changes on: spnbox/tests ___________________________________________________________________ Added: svn:ignore + *.bsh *.exe *.stackdump Modified: spnbox/tests/StructuredIO.c =================================================================== --- spnbox/tests/StructuredIO.c 2009-06-18 19:27:22 UTC (rev 73) +++ spnbox/tests/StructuredIO.c 2009-06-18 20:18:15 UTC (rev 74) @@ -75,24 +75,29 @@ the end of the parse.*/ ParamsAssigned = mcalloc(&memory, ParamCount, sizeof(int)); } - + while (1) { + /*Read a token. If we have reached end of file return 0.*/ if (fscanf(file, "%s", Token) == EOF) { FreeMemory(&memory); return 0; } + /*If it is the problem-end keyword return 1.*/ else if (! strcmp(Token, "done")) { FreeMemory(&memory); return 1; } + /*If it is the file-end keyword return 0.*/ else if (! strcmp(Token, "quit")) { FreeMemory(&memory); return 0; } + /*If it is a request to echo a line to the screen, read the line, move past + any leading whitespace, and print to the screen.*/ else if (! strcmp(Token, "echo")) { fgets(Line, 128, file); @@ -100,20 +105,29 @@ while (isspace(*LineStart) && *LineStart != '\0') LineStart++; printf("%s", LineStart); } + /*If it is a line comment read the remainder of the line and do nothing.*/ else if (! strcmp(Token, "rem")) { fgets(Line, 128, file); } + /*Otherwise try to parse it as a user-defined token.*/ else { + /*Get the ID (index in the parameter array) of the parameter to which + the token corresponds. FindParameter will return -1 if it cannot find + a parameter with the given name.*/ if ((PID = FindParameter(Token, Param, ParamCount)) >= 0) { + /*If the parameter has already been assigned it is a fatal error. Fail.*/ if (ParamsAssigned[PID]) { FreeMemory(&memory); merror(0, "PARSE: Parameter defined twice. Failing."); return 0; } + /*If the parameter is a matrix, read using the readmatrix function. + ReadMatrix will return an empty matrix in case of failure. Such an error + is fatal.*/ if (! strcmp(Param[PID].Type, "matrix")) { *((matrix*)Data[Param[PID].Start]) = ReadMatrix(file); @@ -125,32 +139,44 @@ } ManageMatrix(Memory, (matrix*)Data[Param[PID].Start]); } + /*If it is an int array read that. There are two members of the + variable-length parameter list for each array; the first is the pointer + to the array pointer and the second is a pointer to an int to hold the + array length.*/ else if (! (strcmp(Param[PID].Type, "arrayi") && strcmp(Param[PID].Type, "indexarray"))) { *((int**) Data[Param[PID].Start]) = ReadIntArray(file, &Length); *((int*) Data[Param[PID].Start + 1]) = Length; ManageMemory(Memory, *((void**) Data[Param[PID].Start])); } + /*Array of doubles..*/ else if (! strcmp(Param[PID].Type, "arrayd")) { *((double**) Data[Param[PID].Start]) = ReadDblArray(file, &Length); *((int*) Data[Param[PID].Start + 1]) = Length; ManageMemory(Memory, *((void**) Data[Param[PID].Start])); } + /*A single integer.*/ else if (! strcmp(Param[PID].Type, "int")) { fscanf(file, "%d", ((int*) Data[Param[PID].Start])); } + /*A single double.*/ else if (! strcmp(Param[PID].Type, "double")) { fscanf(file, "%lf", ((double*) Data[Param[PID].Start])); } + /*A string. Read the remainder of the line. Note that this assumes that + the corresponding pointer in the variable-length parameter list is + a pre-allocated pointer to a char array of at least length 128.*/ else if (! strcmp(Param[PID].Type, "string")) { fgets(((char*) Data[Param[PID].Start]), 128, file); } else { + /*If we get here it means that somehow the Type string of the + parameter array was mis-set. Fail due to internal error.*/ FreeMemory(&memory); merror(0, "PARSE: Internal Error"); return 0; @@ -159,6 +185,8 @@ } else { + /*If we get here, it means that FindParam could not find a parameter + with the name given. Warn about the unrecognized token and continue.*/ printf("Warning: Unrecognized Token '%s'\n", Token); } } @@ -182,18 +210,22 @@ memory = CreateMemoryManager(10, 10, 0, 0); + /*Parse the data description and get a parameter type array.*/ if (! (ParamCount = ParseDescription(&memory, DataDescription, &Params, &DataLength))) { merror(0, "DISPLAYDATA: Bad Data Description"); return; } - + /*Iterate through the parameters. Since the variable-length parameter list + is given in the same order as the parameters, we can just read it one + parameter at a time.*/ for (i = 0; i < ParamCount; i++) { if (! strcmp(Params[i].Type, "matrix")) - { + { Matrix = va_arg(args, matrix*); - if (Mask ? Mask[i] : 1) + /*If the matrix is zero-sized don't show it.*/ + if (Mask ? Mask[i] : 1 && NumberOfRows(*Matrix) && NumberOfColumns(*Matrix)) { ShowMatrix(Matrix, Params[i].Name); } @@ -202,6 +234,8 @@ { IntP = va_arg(args, int*); Length = va_arg(args, int); + /*Print the name of the array and then all its elements after it on one + line.*/ if (Mask ? Mask[i] : 1) { printf("%s:\t", Params[i].Name); @@ -214,8 +248,20 @@ } else if (! strcmp(Params[i].Type, "indexarray")) { + /*An indexarray is stored like a normal integer array except for a third + element in the variable parameter list. It is displayed differently as + well. The indexarray represents a variable-length array of column + indices. When it is displayed, rather than showing the indices, the + columns corresponding the indices are marked in stdout with an X. Columns + without a corresponding index entry are left blank. Columns are separated + by tabs; the display is intended to be compatible with matrix display, + which also separates columns with tabs*/ IntP = va_arg(args, int*); Length = va_arg(args, int); + /*The third parameter is another integer representing the total number + of columns in the matrix. This is used so that the list name can be + printed not immediately after the last index mark but instead to the right + of the last column of the matrix.*/ MarkWidth = va_arg(args, int); if (Mask ? Mask[i] : 1) { @@ -236,7 +282,9 @@ } else if (! strcmp(Params[i].Type, "arrayd")) { - DblP = va_arg(args, double*); + /*The first parameter is the array pointer and the second is the array + length.*/ + DblP = va_arg(args, double*); Length = va_arg(args, int); if (Mask ? Mask[i] : 1) { @@ -274,6 +322,7 @@ } else { + /*If we get here it means that the parameter type name was invalid.*/ merror(0, "DISPLAYDATA: Data Description Error"); va_end(args); return; @@ -286,10 +335,13 @@ { int* ret; int i; + /*Return a null pointer in case of failure to read the array length.*/ if (! fscanf(file, "%d", length)) { return 0; } + /*Allocate array space, read the array elements, and return. If an error + occurs free the allocated space and return a null pointer.*/ ret = tcalloc(*length, sizeof(int)); for (i = 0; i < *length; i++) { @@ -306,10 +358,13 @@ { double* ret; int i; + /*Return a null pointer in case of failure to read the array length.*/ if (! fscanf(file, "%d", length)) { return 0; } + /*Allocate array space, read the array elements, and return. If an error + occurs free the allocated space and return a null pointer.*/ ret = tcalloc(*length, sizeof(double)); for (i = 0; i < *length; i++) { @@ -327,13 +382,15 @@ int* data; int rows, cols, i; matrix Ret; - + /*Zero the matrix initially. An empty matrix will be the rror return value.*/ AllocateMatrix(&Ret, 0, 0); + /*Read matrix size.*/ if (fscanf(file, "%d %d", &rows, &cols) != 2) { return Ret; } + /*Allocate space for and read a 1D array containing all the elements by row.*/ data = tcalloc(rows * cols, sizeof(int)); for (i = 0; i < rows * cols; i++) { @@ -343,6 +400,7 @@ return Ret; } } + /*Use vector2matrix to convert the 1D array into a matrix.*/ Ret = vector2matrix(data, rows, cols); free(data); return Ret; @@ -352,6 +410,7 @@ { int i; char* start; + /*Search the parameter list for a parameter with the given name.*/ for (i = 0; i < ParamCount; i++) { if (! strcmp(Name, Param[i].Name)) @@ -359,9 +418,15 @@ return i; } } + /*If no such parameter is found, return a -1.*/ return -1; } +/*ParseDescription parses the given data description string and fills the +Param array of parameters with corresponding parameter structures. It returns +the number of parameters found, and fills the integer pointed to by Items with +the number of parameters to expect in the variable-length parameter list in +ParseStructure.*/ int ParseDescription(MemoryManager* memory, char* DataDescription, Parameter** Param, int* Items) { char Description[256]; @@ -375,44 +440,62 @@ (*Items) = 0; strcpy(Description, DataDescription); - + /*Tokenize the string around commas, the delimiters.*/ Token = strtok(Description, ","); if (Token) { do { + /*Reac the parameter type and name strings.*/ if (sscanf(Token, "%s %s", Type, Name) == 2) { + /*For search purposes, get a copy of the type string and add a space to + the end.*/ strcpy(Type2, Type); strcat(Type2, " "); ToAdd = 0; + /*If the type is a matrix, int, double, or string, then only one item + should be expected in the parameter list corresponding to this parameter.*/ if (strstr("matrix int double string ", Type2)) { ToAdd = 1; } + /*If the type is an array type, there will be two items in + ParseStructure's parameter list: the array pointer and the pointer to + the integer destined to hold the array length.*/ else if (strstr("arrayi arrayd indexarray ", Type2)) { ToAdd = 2; } + /*If the parameter was recognized...*/ if (ToAdd) { + /*If the parameter has not already been defined...*/ if (FindParameter(Name, (*Param), TokenCount) >= 0) { + /*If it has, empty the list and fail.*/ free(*Param); merror(0, "READER: Data description containts duplicate item names"); return 0; } + /*Add a new element to the array of parameter description structures + and fill in its members.*/ (*Param) = realloc(*Param, (TokenCount + 1) * sizeof(Parameter)); (*Param + TokenCount)->Name = mcalloc(memory, strlen(Name) + 1, sizeof(char)); strcpy((*Param + TokenCount)->Name, Name); (*Param + TokenCount)->Type = mcalloc(memory, strlen(Type) + 1, sizeof(char)); strcpy((*Param + TokenCount)->Type, Type); + /*Start indicates which element in a variable-length parameter list + will be the first element corresponding to this parameter. It has + to be adjusted separately from TokenCount because some parameters + need multiple elements in the parameter list.*/ (*Param + TokenCount)->Start = *Items; TokenCount++; (*Items) += ToAdd; } else { + /*If we get here the parameter type was not recognized. Fail.*/ free(*Param); merror(0, "READER: Bad data description type"); return 0; @@ -420,17 +503,22 @@ } else { + /*If we get here there were problems reading the description group (a + single comma-surrounded token from the original data description). + Fail.*/ free(*Param); printf("Warning: Bad Data Description Group '%s %s'.\n", Type, Name); merror(0, "READER: Bad data description group"); return 0; } } while (Token = strtok(0, ",")); + /*Add the parameter structure array to the list of memory to be freed later.*/ ManageMemory(memory, *Param); return TokenCount; } else { + /*If there was an error tokenizing the string, return 0.*/ return 0; } } Deleted: spnbox/tests/clean.bsh =================================================================== --- spnbox/tests/clean.bsh 2009-06-18 19:27:22 UTC (rev 73) +++ spnbox/tests/clean.bsh 2009-06-18 20:18:15 UTC (rev 74) @@ -1,3 +0,0 @@ -rm *.o -rm *.exe -rm *.stackdump Added: spnbox/tests/test-nltrans.mak =================================================================== --- spnbox/tests/test-nltrans.mak (rev 0) +++ spnbox/tests/test-nltrans.mak 2009-06-18 20:18:15 UTC (rev 74) @@ -0,0 +1,34 @@ +COMPILER=gcc -g -ggdb + +test-nltrans: test-nltrans.o pns.o matrix.o general.o matrixmath.o ipsolve.o MemoryManager.o ipslv.o StructuredIO.o nltrans.o + $(COMPILER) -o test-nltrans.exe pns.o matrix.o general.o matrixmath.o test-nltrans.o ipsolve.o ipslv.o MemoryManager.o StructuredIO.o nltrans.o ../lp_solve_5.5/lpsolve55/liblpsolve55.a + +matrix.o: ../../pnheaders/matrix.c ../../pnheaders/matrix.h ../../pnheaders/pns.h + $(COMPILER) -c ../../pnheaders/matrix.c + +pns.o: ../../pnheaders/pns.h ../../pnheaders/pns.c ../../pnheaders/general.h + $(COMPILER) -c ../../pnheaders/pns.c + +general.o: ../../pnheaders/general.h ../../pnheaders/general.c + $(COMPILER) -c ../../pnheaders/general.c + +matrixmath.o: ../matrixmath.c ../matrixmath.h ../../pnheaders/general.h ../../pnheaders/matrix.h + $(COMPILER) -c ../matrixmath.c + +ipsolve.o: ../spnbox.h ../matrixmath.h ../../pnheaders/general.h ../../pnheaders/matrix.h ../MemoryManager.h ../ipsolve.c + $(COMPILER) -c ../ipsolve.c + +ipslv.o: ../spnbox.h ../ipslv.c + $(COMPILER) -c ../ipslv.c + +MemoryManager.o: ../MemoryManager.h ../MemoryManager.c ../../pnheaders/general.h ../../pnheaders/matrix.h + $(COMPILER) -c ../MemoryManager.c + +test-nltrans.o: test-nltrans.c ../spnbox.h ../MemoryManager.h + $(COMPILER) -c test-nltrans.c + +StructuredIO.o: StructuredIO.c StructuredIO.h ../../pnheaders/matrix.h + $(COMPILER) -c StructuredIO.c + +nltrans.o: ../nltrans.c ../spnbox.h ../../pnheaders/matrix.h ../matrixmath.h ../MemoryManager.h + $(COMPILER) -c ../nltrans.c Added: spnbox/tests/test-nltrans.txt =================================================================== --- spnbox/tests/test-nltrans.txt (rev 0) +++ spnbox/tests/test-nltrans.txt 2009-06-18 20:18:15 UTC (rev 74) @@ -0,0 +1,26 @@ +rem test-nltrans type/keyword pairs: matrix D, arrayi URT +echo Problem 1 +echo No predefined unraisable transitions. + +D 3 3 +-1 0 0 +-1 2 -1 +-3 1 0 + + +done + +echo Problem 2 +D 4 4 +1 1 2 2 +1 2 1 3 +3 1 0 1 +1 1 1 1 + +URT 3 +0 2 3 + +done + +quit + \ No newline at end of file Added: spnbox/tests/test-pn2acpn.c =================================================================== --- spnbox/tests/test-pn2acpn.c (rev 0) +++ spnbox/tests/test-pn2acpn.c 2009-06-18 20:18:15 UTC (rev 74) @@ -0,0 +1,154 @@ +#include <stdio.h> +#include "../../pnheaders/pns.h" +#include "../../pnheaders/matrix.h" +#include "../matrixmath.h" +#include "../spnbox.h" +#include "../MemoryManager.h" +#include "StructuredIO.h" + +/*Reference materil: + +pn2acpn function definition: +pn2acpn_r pn2acpn(matrix* Dm, matrix* Dp, int* Mask, matrix* MX, matrix* L0, matrix* L, int *ipl, int ipCount, int* dpl, int dpCount) + +pn2acpn_r structure definition: +typedef struct pn2acpn_r +{ + matrix Df; + matrix Dmf; + matrix Dpf; + matrix MXF; + matrix L0F; + matrix LF; + int *iplf; + int iplfCount; +} pn2acpn_r; + +ParseStructure test function definition: +int ParseStructure(FILE *file, char* DataDescription, int** FilledMask, MemoryManager* Memory, ...); + +DisplayStructure test function definition: +void DisplayStructure(char* DataDescription, int* Mask, ...); +*/ + +void FillDmDp(int* Filled, matrix* D, matrix* Dm, matrix* Dp); +int HasSelfLoops(matrix* Dm, matrix* Dp); + +int main(int argc, char* argv[]) +{ + char InputDesc[] = "matrix D, matrix Dm, matrix Dp, matrix MX, matrix L0, matrix L, arrayi Mask, arrayi ipl, arrayi dpl"; + char OutputDesc[] = "matrix Df, matrix Dmf, matrix Dpf, matrix MXF, matrix L0F, matrix LF, arrayi ipl"; + FILE* input; + MemoryManager mem; + matrix Dm, Dp, MX, L0, L, D; + int *Mask, *ipl, *dpl, *Filled; + int MaskCount, ipCount, dpCount, ResFilled[8], i; + pn2acpn_r result; + + /*Initialize the filled mask that will be used with the result display*/ + for (i = 0; i < 8; i++) + { + ResFilled[i] = 1; + } + + /*Get the input stream. If there was a command line argument, treat it as a + filename and attempt to open it for read access, terminating on failure. + Otherwise set stdin as the input stream.*/ + if (argc > 1) + { + if (input = fopen(argv[1], "r")) + { + printf("Taking input from file '%s'...\n", argv[1]); + } + else + { + printf("Failed to open file '%s' for read access! Terminating.\n", argv[1]); + return 1; + } + } + else + { + input = stdin; + printf("Taking input from console...\n"); + } + + /*Initialize the memory manager. We don't know how many matrices and arrays + we'll need so just pick a nice round number as the initial address block size + and use the default additional block size.*/ + mem = CreateMemoryManager(5, 5, 0, 0); + + /*Attempt to parse a problem from the file and fill all the problem parts. + Continue doing so until a fatal input error or a quit command is encountered.*/ + while(ParseStructure(input, InputDesc, &Filled, &mem, &D, &Dm, &Dp, &MX, &L0, &L, &Mask, &MaskCount, &ipl, &ipCount, &dpl, &dpCount)) + { + /*If D was given, fill Dm and Dp appropriately.*/ + FillDmDp(Filled, &D, &Dm, &Dp); + /*Display the problem.*/ + DisplayStructure(InputDesc, Filled, &D, &Dm, &Dp, &MX, &L0, &L, Mask, MaskCount, ipl, ipCount, dpl, dpCount); + + /*Get the solution.*/ + result = pn2acpn(Filled[1] ? &Dm : 0, Filled[2] ? &Dp : 0, Filled[6] ? Mask : 0, Filled[3] ? &MX : 0, Filled[4] ? &L0 : 0, Filled[5] ? &L : 0, Filled[7] ? ipl : 0, ipCount, Filled[8] ? dpl : 0, dpCount); + + /*Display the solution. Show Dm and Dp only if there are self-loops and + D only if there are not self-loops.*/ + if (HasSelfLoops(&Dm, &Dp)) + { + ResFilled[0] = 0; + ResFilled[1] = 1; + ResFilled[2] = 1; + } + else + { + ResFilled[0] = 1; + ResFilled[1] = 0; + ResFilled[2] = 0; + } + printf("Solution:\n"); + DisplayStructure(OutputDesc, ResFilled, &result.Df, &result.Dmf, &result.Dpf, &result.MXF, &result.L0F, &result.LF, result.iplf, result.iplfCount); + printf("---------------------------------------------------------------------------\n"); + FreeMemory(&mem); + mem = CreateMemoryManager(5, 5, 0, 0); + } + FreeMemory(&mem); + return 0; +} + +int HasSelfLoops(matrix* Dm, matrix* Dp) +{ + int i, j; + for (i = 0; i < NumberOfRows(*Dm); i++) + { + for (j = 0; j < NumberOfColumns(*Dm); j++) + { + if (GetMatrixEl(Dm, i, j) && GetMatrixEl(Dp, i, j)) + { + return 1; + } + } + } + return 0; +} + +void FillDmDp(int* Filled, matrix* D, matrix* Dm, matrix* Dp) +{ + /*If D has been filled...*/ + if (Filled[0]) + { + /*We want to ignore any given Dm and Dp and instead fill Dm and Dp with + matrices developed from D.*/ + if (Filled[1]) + { + DeallocateMatrix(Dm); + } + if (Filled[2]) + { + DeallocateMatrix(Dp); + } + AllocateMatrixType(2, Dm, NumberOfRows(*D), NumberOfColumns(*D)); + AllocateMatrixType(2, Dp, NumberOfRows(*D), NumberOfColumns(*D)); + d2dd(D, Dm, Dp); + Filled[0] = 0; + Filled[1] = 1; + Filled[2] = 1; + } +} Added: spnbox/tests/test-pn2acpn.mak =================================================================== --- spnbox/tests/test-pn2acpn.mak (rev 0) +++ spnbox/tests/test-pn2acpn.mak 2009-06-18 20:18:15 UTC (rev 74) @@ -0,0 +1,32 @@ +COMPILER=gcc -g -ggdb + +test-mpsplit: test-pn2acpn.o matrix.o StructuredIO.o MemoryManager.o general.o pns.o matrixmath.o pn2acpn.o + $(COMPILER) -o test-pn2acpn.exe test-pn2acpn.o matrix.o StructuredIO.o MemoryManager.o general.o pns.o pn2acpn.o matrixmath.o ../lp_solve_5.5/lpsolve55/liblpsolve55.a + +general.o: ../../pnheaders/general.c ../../pnheaders/general.h + $(COMPILER) -c ../../pnheaders/general.c + +pns.o: ../../pnheaders/pns.c ../../pnheaders/pns.h + $(COMPILER) -c ../../pnheaders/pns.c + +matrix.o: ../../pnheaders/matrix.c ../../pnheaders/matrix.h ../../pnheaders/pns.h + $(COMPILER) -c ../../pnheaders/matrix.c + +reader.o: ../spnbox.h ../MemoryManager.h reader.c + $(COMPILER) -c reader.c + +MemoryManager.o: ../MemoryManager.h ../MemoryManager.c ../../pnheaders/general.h ../../pnheaders/matrix.h + $(COMPILER) -c ../MemoryManager.c + +StructuredIO.o: ../MemoryManager.h ../../pnheaders/matrix.h StructuredIO.h StructuredIO.c + $(COMPILER) -c StructuredIO.c + +test-pn2acpn.o: test-pn2acpn.c ../spnbox.h ../MemoryManager.h StructuredIO.h ../matrixmath.h + $(COMPILER) -c test-pn2acpn.c + +matrixmath.o: ../matrixmath.c ../matrixmath.h ../../pnheaders/matrix.h + $(COMPILER) -c ../matrixmath.c + +pn2acpn.o: ../spnbox.h ../../pnheaders/matrix.h ../MemoryManager.h ../pn2acpn.c + $(COMPILER) -c ../pn2acpn.c + \ No newline at end of file Added: spnbox/tests/test-pn2acpn.txt =================================================================== --- spnbox/tests/test-pn2acpn.txt (rev 0) +++ spnbox/tests/test-pn2acpn.txt 2009-06-18 20:18:15 UTC (rev 74) @@ -0,0 +1,52 @@ +rem Acceptable problem parts: +rem D incidence matrix +rem Dm output matrix +rem Dp input matrix +rem MX Transformation matrix from independent to dependent marking +rem L0 Initial marking constraint matrix +rem L Marking constraint matrix. +rem Mask An integer array, one element for each place of the Petri net. Serves +rem as a mask on which places will be processed. +rem ipl An array of the indices of independent places. +rem dpl An array of the indices of dependent places. +rem As always, matrices are defined by the keyword followed by the matrix +rem dimensions followed by the elements of the matrix. Arrays are defined by the +rem keyword followed by the length of the array followed by the array elements. +rem If D is given Dm and Dp are ignored. + +rem ---------------------------------------------------------------------------- +echo Problem 1 +echo Example 5.2 from the thesis. + +Dp 3 5 +0 1 0 1 0 +0 0 1 0 1 +1 0 0 0 0 + +Dm 3 5 +1 0 0 0 1 +1 0 0 1 0 +0 2 2 0 0 + +done + +rem ---------------------------------------------------------------------------- +echo Problem 2 +echo Example 5.1 from the thesis. +Dm 4 5 +1 0 1 0 1 +0 0 0 1 0 +0 1 0 0 1 +1 0 1 0 0 + +Dp 4 5 +0 0 0 1 0 +0 0 2 0 1 +3 0 0 0 0 +0 1 0 0 0 + +done + +quit + + This was sent by the SourceForge.net collaborative development platform, the world's largest Open Source development site. |
From: <the...@us...> - 2009-06-18 19:27:26
|
Revision: 73 http://pntool.svn.sourceforge.net/pntool/?rev=73&view=rev Author: thecodeweasel Date: 2009-06-18 19:27:22 +0000 (Thu, 18 Jun 2009) Log Message: ----------- Added support for segments, select functions, and nondeterministic places Modified Paths: -------------- translator/pngenerator.c translator/pngenerator.g translator/pngenerator.h Modified: translator/pngenerator.c =================================================================== --- translator/pngenerator.c 2009-06-18 19:19:46 UTC (rev 72) +++ translator/pngenerator.c 2009-06-18 19:27:22 UTC (rev 73) @@ -2,7 +2,7 @@ * This C source file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pngenerator.g - * - On : 2009-06-18 14:18:47 + * - On : 2009-06-18 14:26:24 * - for the tree parser : pngeneratorTreeParser * * Editing it, at least manually, is not wise. * @@ -645,252 +645,252 @@ /** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def191 */ static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def191_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def191 = { FOLLOW_CODE_BLOCK_in_trans_def191_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def204 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def204_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def204 = { FOLLOW_ID_in_trans_def204_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def211 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def211_bits[] = { ANTLR3_UINT64_LIT(0x0000000000001208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def211 = { FOLLOW_ID_in_trans_def211_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def220 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def220_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def220 = { FOLLOW_CODE_BLOCK_in_trans_def220_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def238 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def238_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def238 = { FOLLOW_ID_in_trans_def238_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def245 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def245_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def245 = { FOLLOW_ID_in_trans_def245_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def252 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def252_bits[] = { ANTLR3_UINT64_LIT(0x0000000000001208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def252 = { FOLLOW_ID_in_trans_def252_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def261 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def261_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def261 = { FOLLOW_CODE_BLOCK_in_trans_def261_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SELECT_DEF_in_select_functions278 */ -static ANTLR3_BITWORD FOLLOW_SELECT_DEF_in_select_functions278_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SELECT_DEF_in_select_functions278 = { FOLLOW_SELECT_DEF_in_select_functions278_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_select_functions280 */ -static ANTLR3_BITWORD FOLLOW_ID_in_select_functions280_bits[] = { ANTLR3_UINT64_LIT(0x0000000000001000) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_select_functions280 = { FOLLOW_ID_in_select_functions280_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_select_functions282 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_select_functions282_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_select_functions282 = { FOLLOW_CODE_BLOCK_in_select_functions282_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_44_in_nondeterm293 */ -static ANTLR3_BITWORD FOLLOW_44_in_nondeterm293_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_44_in_nondeterm293 = { FOLLOW_44_in_nondeterm293_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_nondeterm295 */ -static ANTLR3_BITWORD FOLLOW_ID_in_nondeterm295_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_nondeterm295 = { FOLLOW_ID_in_nondeterm295_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_init_in_proc_instantiations307 */ -static ANTLR3_BITWORD FOLLOW_proc_init_in_proc_instantiations307_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_init_in_proc_instantiations307 = { FOLLOW_proc_init_in_proc_instantiations307_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_sync_def_in_proc_instantiations311 */ -static ANTLR3_BITWORD FOLLOW_sync_def_in_proc_instantiations311_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_sync_def_in_proc_instantiations311 = { FOLLOW_sync_def_in_proc_instantiations311_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_start_in_proc_instantiations315 */ -static ANTLR3_BITWORD FOLLOW_proc_start_in_proc_instantiations315_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_start_in_proc_instantiations315 = { FOLLOW_proc_start_in_proc_instantiations315_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init325 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_init325_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init325 = { FOLLOW_ID_in_proc_init325_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init327 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_init327_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000200) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init327 = { FOLLOW_ID_in_proc_init327_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_numbered_ID_in_proc_init329 */ -static ANTLR3_BITWORD FOLLOW_numbered_ID_in_proc_init329_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_numbered_ID_in_proc_init329 = { FOLLOW_numbered_ID_in_proc_init329_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SYNC_TOK_in_sync_def341 */ -static ANTLR3_BITWORD FOLLOW_SYNC_TOK_in_sync_def341_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SYNC_TOK_in_sync_def341 = { FOLLOW_SYNC_TOK_in_sync_def341_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_sync_def343 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def343_bits[] = { ANTLR3_UINT64_LIT(0x0000000000080208) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_sync_def343 = { FOLLOW_group_elements_in_sync_def343_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints356 */ -static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints356_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints356 = { FOLLOW_constraint_block_in_constraints356_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints358 */ -static ANTLR3_BITWORD FOLLOW_eq_in_constraints358_bits[] = { ANTLR3_UINT64_LIT(0x0001C001A60A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints358 = { FOLLOW_eq_in_constraints358_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints361 */ -static ANTLR3_BITWORD FOLLOW_live_def_in_constraints361_bits[] = { ANTLR3_UINT64_LIT(0x0000000180000008) }; -static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints361 = { FOLLOW_live_def_in_constraints361_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints364 */ -static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints364_bits[] = { ANTLR3_UINT64_LIT(0x0000000100000008) }; -static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints364 = { FOLLOW_uncontrol_in_constraints364_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints367 */ -static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints367_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints367 = { FOLLOW_unobserve_in_constraints367_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start380 */ -static ANTLR3_BITWORD FOLLOW_START_in_proc_start380_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start380 = { FOLLOW_START_in_proc_start380_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start382 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_start382_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start382 = { FOLLOW_ID_in_proc_start382_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block393 */ -static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block393_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block393 = { FOLLOW_ID_in_constraint_block393_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq403 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq403_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq403 = { FOLLOW_relationalExpression_in_eq403_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq409 */ -static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq409_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq409 = { FOLLOW_EQS_OP_in_eq409_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq411 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq411_bits[] = { ANTLR3_UINT64_LIT(0x0001C001A60A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq411 = { FOLLOW_eq_in_eq411_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq413 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq413_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq413 = { FOLLOW_eq_in_eq413_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression429 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression429_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression429 = { FOLLOW_additiveExpression_in_relationalExpression429_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression438 */ -static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression438_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression438 = { FOLLOW_EQ_OP_in_relationalExpression438_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression440 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression440_bits[] = { ANTLR3_UINT64_LIT(0x0001C000040A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression440 = { FOLLOW_relationalExpression_in_relationalExpression440_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression442 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression442_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression442 = { FOLLOW_relationalExpression_in_relationalExpression442_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression458 */ -static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression458_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression458 = { FOLLOW_primary_in_additiveExpression458_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_additiveExpression467 */ -static ANTLR3_BITWORD FOLLOW_ADD_in_additiveExpression467_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ADD_in_additiveExpression467 = { FOLLOW_ADD_in_additiveExpression467_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression469 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression469_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression469 = { FOLLOW_additiveExpression_in_additiveExpression469_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression471 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression471_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression471 = { FOLLOW_additiveExpression_in_additiveExpression471_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SUB_in_additiveExpression481 */ -static ANTLR3_BITWORD FOLLOW_SUB_in_additiveExpression481_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SUB_in_additiveExpression481 = { FOLLOW_SUB_in_additiveExpression481_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression483 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression483_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression483 = { FOLLOW_additiveExpression_in_additiveExpression483_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression485 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression485_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression485 = { FOLLOW_additiveExpression_in_additiveExpression485_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_primary500 */ -static ANTLR3_BITWORD FOLLOW_ID_in_primary500_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_primary500 = { FOLLOW_ID_in_primary500_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary508 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_primary508_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary508 = { FOLLOW_group_elements_in_primary508_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_primary516 */ -static ANTLR3_BITWORD FOLLOW_NUM_in_primary516_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_NUM_in_primary516 = { FOLLOW_NUM_in_primary516_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary525 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_primary525_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary525 = { FOLLOW_MULT_in_primary525_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_primary527 */ -static ANTLR3_BITWORD FOLLOW_NUM_in_primary527_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_NUM_in_primary527 = { FOLLOW_NUM_in_primary527_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary529 */ -static ANTLR3_BITWORD FOLLOW_primary_in_primary529_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary529 = { FOLLOW_primary_in_primary529_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_primary539 */ -static ANTLR3_BITWORD FOLLOW_ADD_in_primary539_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ADD_in_primary539 = { FOLLOW_ADD_in_primary539_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary541 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary541_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary541 = { FOLLOW_additiveExpression_in_primary541_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary543 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary543_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary543 = { FOLLOW_additiveExpression_in_primary543_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SUB_in_primary553 */ -static ANTLR3_BITWORD FOLLOW_SUB_in_primary553_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SUB_in_primary553 = { FOLLOW_SUB_in_primary553_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary555 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary555_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary555 = { FOLLOW_additiveExpression_in_primary555_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary557 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary557_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary557 = { FOLLOW_additiveExpression_in_primary557_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def568 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def568_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def568 = { FOLLOW_LIVE_in_live_def568_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def570 */ -static ANTLR3_BITWORD FOLLOW_ALL_in_live_def570_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def570 = { FOLLOW_ALL_in_live_def570_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def572 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def572_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def572 = { FOLLOW_ID_in_live_def572_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def580 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def580_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def580 = { FOLLOW_LIVE_in_live_def580_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def582 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def582_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def582 = { FOLLOW_ID_in_live_def582_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol594 */ -static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol594_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol594 = { FOLLOW_UNCONTROL_in_uncontrol594_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol596 */ -static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol596_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol596 = { FOLLOW_ID_in_uncontrol596_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve608 */ -static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve608_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve608 = { FOLLOW_UNOBSERVE_in_unobserve608_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve610 */ -static ANTLR3_BITWORD FOLLOW_ID_in_unobserve610_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve610 = { FOLLOW_ID_in_unobserve610_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands622 */ -static ANTLR3_BITWORD FOLLOW_print_in_other_commands622_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands622 = { FOLLOW_print_in_other_commands622_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print632 */ -static ANTLR3_BITWORD FOLLOW_PRINT_in_print632_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print632 = { FOLLOW_PRINT_in_print632_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print634 */ -static ANTLR3_BITWORD FOLLOW_ID_in_print634_bits[] = { ANTLR3_UINT64_LIT(0x0000000000080208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_print634 = { FOLLOW_ID_in_print634_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print636 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_print636_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print636 = { FOLLOW_group_elements_in_print636_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements647 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements647_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements647 = { FOLLOW_ID_in_group_elements647_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_DOT_in_group_elements653 */ -static ANTLR3_BITWORD FOLLOW_DOT_in_group_elements653_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_DOT_in_group_elements653 = { FOLLOW_DOT_in_group_elements653_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_group_elements655 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_group_elements655_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000200) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_group_elements655 = { FOLLOW_group_elements_in_group_elements655_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements657 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements657_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements657 = { FOLLOW_ID_in_group_elements657_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID667 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID667_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID667 = { FOLLOW_ID_in_numbered_ID667_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID673 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID673_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID673 = { FOLLOW_ID_in_numbered_ID673_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID675 */ -static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID675_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID675 = { FOLLOW_INT_in_numbered_ID675_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def205 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def205_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def205 = { FOLLOW_ID_in_trans_def205_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def212 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def212_bits[] = { ANTLR3_UINT64_LIT(0x0000000000001208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def212 = { FOLLOW_ID_in_trans_def212_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def221 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def221_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def221 = { FOLLOW_CODE_BLOCK_in_trans_def221_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def239 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def239_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def239 = { FOLLOW_ID_in_trans_def239_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def246 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def246_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def246 = { FOLLOW_ID_in_trans_def246_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def253 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def253_bits[] = { ANTLR3_UINT64_LIT(0x0000000000001208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def253 = { FOLLOW_ID_in_trans_def253_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def262 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def262_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def262 = { FOLLOW_CODE_BLOCK_in_trans_def262_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SELECT_DEF_in_select_functions279 */ +static ANTLR3_BITWORD FOLLOW_SELECT_DEF_in_select_functions279_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SELECT_DEF_in_select_functions279 = { FOLLOW_SELECT_DEF_in_select_functions279_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_select_functions281 */ +static ANTLR3_BITWORD FOLLOW_ID_in_select_functions281_bits[] = { ANTLR3_UINT64_LIT(0x0000000000001000) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_select_functions281 = { FOLLOW_ID_in_select_functions281_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_select_functions283 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_select_functions283_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_select_functions283 = { FOLLOW_CODE_BLOCK_in_select_functions283_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_44_in_nondeterm296 */ +static ANTLR3_BITWORD FOLLOW_44_in_nondeterm296_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_44_in_nondeterm296 = { FOLLOW_44_in_nondeterm296_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_nondeterm299 */ +static ANTLR3_BITWORD FOLLOW_ID_in_nondeterm299_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_nondeterm299 = { FOLLOW_ID_in_nondeterm299_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_init_in_proc_instantiations314 */ +static ANTLR3_BITWORD FOLLOW_proc_init_in_proc_instantiations314_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_init_in_proc_instantiations314 = { FOLLOW_proc_init_in_proc_instantiations314_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_sync_def_in_proc_instantiations318 */ +static ANTLR3_BITWORD FOLLOW_sync_def_in_proc_instantiations318_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_sync_def_in_proc_instantiations318 = { FOLLOW_sync_def_in_proc_instantiations318_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_start_in_proc_instantiations322 */ +static ANTLR3_BITWORD FOLLOW_proc_start_in_proc_instantiations322_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_start_in_proc_instantiations322 = { FOLLOW_proc_start_in_proc_instantiations322_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init332 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_init332_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init332 = { FOLLOW_ID_in_proc_init332_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init334 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_init334_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000200) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init334 = { FOLLOW_ID_in_proc_init334_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_numbered_ID_in_proc_init336 */ +static ANTLR3_BITWORD FOLLOW_numbered_ID_in_proc_init336_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_numbered_ID_in_proc_init336 = { FOLLOW_numbered_ID_in_proc_init336_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SYNC_TOK_in_sync_def348 */ +static ANTLR3_BITWORD FOLLOW_SYNC_TOK_in_sync_def348_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SYNC_TOK_in_sync_def348 = { FOLLOW_SYNC_TOK_in_sync_def348_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_sync_def350 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def350_bits[] = { ANTLR3_UINT64_LIT(0x0000000000080208) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_sync_def350 = { FOLLOW_group_elements_in_sync_def350_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints363 */ +static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints363_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints363 = { FOLLOW_constraint_block_in_constraints363_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints365 */ +static ANTLR3_BITWORD FOLLOW_eq_in_constraints365_bits[] = { ANTLR3_UINT64_LIT(0x0001C001A60A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints365 = { FOLLOW_eq_in_constraints365_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints368 */ +static ANTLR3_BITWORD FOLLOW_live_def_in_constraints368_bits[] = { ANTLR3_UINT64_LIT(0x0000000180000008) }; +static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints368 = { FOLLOW_live_def_in_constraints368_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints371 */ +static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints371_bits[] = { ANTLR3_UINT64_LIT(0x0000000100000008) }; +static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints371 = { FOLLOW_uncontrol_in_constraints371_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints374 */ +static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints374_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints374 = { FOLLOW_unobserve_in_constraints374_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start387 */ +static ANTLR3_BITWORD FOLLOW_START_in_proc_start387_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start387 = { FOLLOW_START_in_proc_start387_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start389 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_start389_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start389 = { FOLLOW_ID_in_proc_start389_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block400 */ +static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block400_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block400 = { FOLLOW_ID_in_constraint_block400_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq410 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq410_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq410 = { FOLLOW_relationalExpression_in_eq410_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq416 */ +static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq416_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq416 = { FOLLOW_EQS_OP_in_eq416_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq418 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq418_bits[] = { ANTLR3_UINT64_LIT(0x0001C001A60A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq418 = { FOLLOW_eq_in_eq418_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq420 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq420_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq420 = { FOLLOW_eq_in_eq420_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression436 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression436_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression436 = { FOLLOW_additiveExpression_in_relationalExpression436_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression445 */ +static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression445_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression445 = { FOLLOW_EQ_OP_in_relationalExpression445_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression447 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression447_bits[] = { ANTLR3_UINT64_LIT(0x0001C000040A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression447 = { FOLLOW_relationalExpression_in_relationalExpression447_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression449 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression449_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression449 = { FOLLOW_relationalExpression_in_relationalExpression449_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression465 */ +static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression465_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression465 = { FOLLOW_primary_in_additiveExpression465_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_additiveExpression474 */ +static ANTLR3_BITWORD FOLLOW_ADD_in_additiveExpression474_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ADD_in_additiveExpression474 = { FOLLOW_ADD_in_additiveExpression474_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression476 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression476_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression476 = { FOLLOW_additiveExpression_in_additiveExpression476_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression478 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression478_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression478 = { FOLLOW_additiveExpression_in_additiveExpression478_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SUB_in_additiveExpression488 */ +static ANTLR3_BITWORD FOLLOW_SUB_in_additiveExpression488_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SUB_in_additiveExpression488 = { FOLLOW_SUB_in_additiveExpression488_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression490 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression490_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression490 = { FOLLOW_additiveExpression_in_additiveExpression490_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression492 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression492_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression492 = { FOLLOW_additiveExpression_in_additiveExpression492_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_primary507 */ +static ANTLR3_BITWORD FOLLOW_ID_in_primary507_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_primary507 = { FOLLOW_ID_in_primary507_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary515 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_primary515_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary515 = { FOLLOW_group_elements_in_primary515_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_primary523 */ +static ANTLR3_BITWORD FOLLOW_NUM_in_primary523_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_NUM_in_primary523 = { FOLLOW_NUM_in_primary523_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary532 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_primary532_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary532 = { FOLLOW_MULT_in_primary532_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_primary534 */ +static ANTLR3_BITWORD FOLLOW_NUM_in_primary534_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_NUM_in_primary534 = { FOLLOW_NUM_in_primary534_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary536 */ +static ANTLR3_BITWORD FOLLOW_primary_in_primary536_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary536 = { FOLLOW_primary_in_primary536_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_primary546 */ +static ANTLR3_BITWORD FOLLOW_ADD_in_primary546_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ADD_in_primary546 = { FOLLOW_ADD_in_primary546_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary548 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary548_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary548 = { FOLLOW_additiveExpression_in_primary548_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary550 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary550_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary550 = { FOLLOW_additiveExpression_in_primary550_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SUB_in_primary560 */ +static ANTLR3_BITWORD FOLLOW_SUB_in_primary560_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SUB_in_primary560 = { FOLLOW_SUB_in_primary560_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary562 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary562_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary562 = { FOLLOW_additiveExpression_in_primary562_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary564 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary564_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary564 = { FOLLOW_additiveExpression_in_primary564_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def575 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def575_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def575 = { FOLLOW_LIVE_in_live_def575_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def577 */ +static ANTLR3_BITWORD FOLLOW_ALL_in_live_def577_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def577 = { FOLLOW_ALL_in_live_def577_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def579 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def579_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def579 = { FOLLOW_ID_in_live_def579_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def587 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def587_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def587 = { FOLLOW_LIVE_in_live_def587_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def589 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def589_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def589 = { FOLLOW_ID_in_live_def589_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol601 */ +static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol601_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol601 = { FOLLOW_UNCONTROL_in_uncontrol601_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol603 */ +static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol603_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol603 = { FOLLOW_ID_in_uncontrol603_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve615 */ +static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve615_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve615 = { FOLLOW_UNOBSERVE_in_unobserve615_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve617 */ +static ANTLR3_BITWORD FOLLOW_ID_in_unobserve617_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve617 = { FOLLOW_ID_in_unobserve617_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands629 */ +static ANTLR3_BITWORD FOLLOW_print_in_other_commands629_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands629 = { FOLLOW_print_in_other_commands629_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print639 */ +static ANTLR3_BITWORD FOLLOW_PRINT_in_print639_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print639 = { FOLLOW_PRINT_in_print639_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print641 */ +static ANTLR3_BITWORD FOLLOW_ID_in_print641_bits[] = { ANTLR3_UINT64_LIT(0x0000000000080208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_print641 = { FOLLOW_ID_in_print641_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print643 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_print643_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print643 = { FOLLOW_group_elements_in_print643_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements654 */ +static ANTLR3_BITWORD FOLLOW_ID_in_group_elements654_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements654 = { FOLLOW_ID_in_group_elements654_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_DOT_in_group_elements660 */ +static ANTLR3_BITWORD FOLLOW_DOT_in_group_elements660_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_DOT_in_group_elements660 = { FOLLOW_DOT_in_group_elements660_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_group_elements662 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_group_elements662_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000200) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_group_elements662 = { FOLLOW_group_elements_in_group_elements662_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements664 */ +static ANTLR3_BITWORD FOLLOW_ID_in_group_elements664_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements664 = { FOLLOW_ID_in_group_elements664_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID674 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID674_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID674 = { FOLLOW_ID_in_numbered_ID674_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID680 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID680_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID680 = { FOLLOW_ID_in_numbered_ID680_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID682 */ +static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID682_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID682 = { FOLLOW_INT_in_numbered_ID682_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_synpred2_pngenerator80 */ static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_synpred2_pngenerator80_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_synpred2_pngenerator80 = { FOLLOW_proc_instantiations_in_synpred2_pngenerator80_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred29_pngenerator458 */ -static ANTLR3_BITWORD FOLLOW_primary_in_synpred29_pngenerator458_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred29_pngenerator458 = { FOLLOW_primary_in_synpred29_pngenerator458_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_synpred30_pngenerator467 */ -static ANTLR3_BITWORD FOLLOW_ADD_in_synpred30_pngenerator467_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ADD_in_synpred30_pngenerator467 = { FOLLOW_ADD_in_synpred30_pngenerator467_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_synpred30_pngenerator469 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_synpred30_pngenerator469_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_synpred30_pngenerator469 = { FOLLOW_additiveExpression_in_synpred30_pngenerator469_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_synpred30_pngenerator471 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_synpred30_pngenerator471_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_synpred30_pngenerator471 = { FOLLOW_additiveExpression_in_synpred30_pngenerator471_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_synpred31_pngenerator500 */ -static ANTLR3_BITWORD FOLLOW_ID_in_synpred31_pngenerator500_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_synpred31_pngenerator500 = { FOLLOW_ID_in_synpred31_pngenerator500_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_synpred32_pngenerator508 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_synpred32_pngenerator508_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_synpred32_pngenerator508 = { FOLLOW_group_elements_in_synpred32_pngenerator508_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred29_pngenerator465 */ +static ANTLR3_BITWORD FOLLOW_primary_in_synpred29_pngenerator465_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred29_pngenerator465 = { FOLLOW_primary_in_synpred29_pngenerator465_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_synpred30_pngenerator474 */ +static ANTLR3_BITWORD FOLLOW_ADD_in_synpred30_pngenerator474_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ADD_in_synpred30_pngenerator474 = { FOLLOW_ADD_in_synpred30_pngenerator474_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_synpred30_pngenerator476 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_synpred30_pngenerator476_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_synpred30_pngenerator476 = { FOLLOW_additiveExpression_in_synpred30_pngenerator476_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_synpred30_pngenerator478 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_synpred30_pngenerator478_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_synpred30_pngenerator478 = { FOLLOW_additiveExpression_in_synpred30_pngenerator478_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_synpred31_pngenerator507 */ +static ANTLR3_BITWORD FOLLOW_ID_in_synpred31_pngenerator507_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_synpred31_pngenerator507 = { FOLLOW_ID_in_synpred31_pngenerator507_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_synpred32_pngenerator515 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_synpred32_pngenerator515_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_synpred32_pngenerator515 = { FOLLOW_group_elements_in_synpred32_pngenerator515_bits, 1 }; @@ -930,16 +930,16 @@ static const ANTLR3_INT32 dfa2_T0[] = { - 3, 7, -1, -1, -1, -1, -1, 6, -1, -1, -1, -1, -1, -1, -1, 2, -1, 2, -1, - -1, -1, -1, -1, 2, 2, -1, -1, 2, -1, 2, 2, -1, -1, -1, -1, -1, -1, -1, - -1, -1, -1, -1, -1, -1, 2, 2, 2 + 1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 3, 3, -1, -1, -1, -1, -1, + -1, -1, -1, -1, -1, 2 };static const ANTLR3_INT32 dfa2_T1[] = { -1 };static const ANTLR3_INT32 dfa2_T2[] = { - 1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 3, 3, -1, -1, -1, -1, -1, - -1, -1, -1, -1, -1, 2 + 3, 7, -1, -1, -1, -1, -1, 6, -1, -1, -1, -1, -1, -1, -1, 2, -1, 2, -1, + -1, -1, -1, -1, 2, 2, -1, -1, 2, -1, 2, 2, -1, -1, -1, -1, -1, -1, -1, + -1, -1, -1, -1, -1, -1, 2, 2, 2 };static const ANTLR3_INT32 dfa2_T3[] = { 2, -1, -1, -1, -1, -1, 5, -1, -1, -1, -1, -1, -1, -1, 2, -1, 2, -1, -1, @@ -947,12 +947,12 @@ -1, -1, -1, -1, -1, 2, 2, 2 };static const ANTLR3_INT32 dfa2_T4[] = { + 4 + };static const ANTLR3_INT32 dfa2_T5[] = + { 2, -1, -1, -1, -1, -1, 6, -1, -1, -1, -1, -1, -1, -1, 2, -1, 2, -1, -1, -1, -1, -1, 2, 2, -1, -1, 2, -1, 2, 2, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 2, 2, 2 - };static const ANTLR3_INT32 dfa2_T5[] = - { - 4 }; /* Transition tables are a table of sub tables, with some tables @@ -960,7 +960,7 @@ */ static const ANTLR3_INT32 * const dfa2_transitions[] = { - dfa2_T2, dfa2_T5, dfa2_T_empty, dfa2_T_empty, dfa2_T3, dfa2_T4, dfa2_T0, + dfa2_T0, dfa2_T4, dfa2_T_empty, dfa2_T_empty, dfa2_T3, dfa2_T5, dfa2_T2, dfa2_T1 }; @@ -1959,8 +1959,10 @@ pANTLR3_BASE_TREE tran; pANTLR3_BASE_TREE place; pANTLR3_BASE_TREE pInit; - pANTLR3_BASE_TREE CODE_BLOCK5; + pANTLR3_BASE_TREE ID5; pANTLR3_BASE_TREE CODE_BLOCK6; + pANTLR3_BASE_TREE CODE_BLOCK7; + pANTLR3_BASE_TREE CODE_BLOCK8; /* Initialize rule variables */ @@ -1981,8 +1983,10 @@ tran = NULL; place = NULL; pInit = NULL; - CODE_BLOCK5 = NULL; + ID5 = NULL; CODE_BLOCK6 = NULL; + CODE_BLOCK7 = NULL; + CODE_BLOCK8 = NULL; { { @@ -2102,7 +2106,7 @@ case 1: // /Users/bion/projects/iordache/translator/pngenerator.g:138:4: ^( ID CODE_BLOCK ) { - MATCHT(ID, &FOLLOW_ID_in_trans_def189); + ID5 = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_trans_def189); if (HASEXCEPTION()) { goto ruletrans_defEx; @@ -2121,7 +2125,7 @@ { return ; } - MATCHT(CODE_BLOCK, &FOLLOW_CODE_BLOCK_in_trans_def191); + CODE_BLOCK6 = (pANTLR3_BASE_TREE) MATCHT(CODE_BLOCK, &FOLLOW_CODE_BLOCK_in_trans_def191); if (HASEXCEPTION()) { goto ruletrans_defEx; @@ -2130,7 +2134,17 @@ { return ; } + if ( BACKTRACKING==0 ) + { + static int place; + static char* code; + place = *((int*) (SCOPE_TOP(proc_definitions))->places->get( (SCOPE_TOP(proc_definitions))->places, (char*) (ID5->getText(ID5))->chars)); + code = (char*) (CODE_BLOCK6->getText(CODE_BLOCK6))->chars; + updatepn( (SCOPE_TOP(proc_definitions))->proc->pn, "segment", place, code); + + } + MATCHT(ANTLR3_TOKEN_UP, NULL); if (HASEXCEPTION()) { @@ -2144,9 +2158,9 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pngenerator.g:140:4: ^(tran= ID (place= ID )+ ( CODE_BLOCK )? ) + // /Users/bion/projects/iordache/translator/pngenerator.g:146:4: ^(tran= ID (place= ID )+ ( CODE_BLOCK )? ) { - tran = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_trans_def204); + tran = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_trans_def205); if (HASEXCEPTION()) { goto ruletrans_defEx; @@ -2172,7 +2186,7 @@ { return ; } - // /Users/bion/projects/iordache/translator/pngenerator.g:142:5: (place= ID )+ + // /Users/bion/projects/iordache/translator/pngenerator.g:148:5: (place= ID )+ { int cnt11=0; @@ -2192,9 +2206,9 @@ switch (alt11) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:142:6: place= ID + // /Users/bion/projects/iordache/translator/pngenerator.g:148:6: place= ID { - place = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_trans_def211); + place = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_trans_def212); if (HASEXCEPTION()) { goto ruletrans_defEx; @@ -2251,7 +2265,7 @@ } - // /Users/bion/projects/iordache/translator/pngenerator.g:153:5: ( CODE_BLOCK )? + // /Users/bion/projects/iordache/translator/pngenerator.g:159:5: ( CODE_BLOCK )? { int alt12=2; { @@ -2264,9 +2278,9 @@ switch (alt12) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:153:6: CODE_BLOCK + // /Users/bion/projects/iordache/translator/pngenerator.g:159:6: CODE_BLOCK { - CODE_BLOCK5 = (pANTLR3_BASE_TREE) MATCHT(CODE_BLOCK, &FOLLOW_CODE_BLOCK_in_trans_def220); + CODE_BLOCK7 = (pANTLR3_BASE_TREE) MATCHT(CODE_BLOCK, &FOLLOW_CODE_BLOCK_in_trans_def221); ... [truncated message content] |
From: <the...@us...> - 2009-06-18 19:20:04
|
Revision: 72 http://pntool.svn.sourceforge.net/pntool/?rev=72&view=rev Author: thecodeweasel Date: 2009-06-18 19:19:46 +0000 (Thu, 18 Jun 2009) Log Message: ----------- Adding arcs for non-extern processes Modified Paths: -------------- translator/pngenerator.c translator/pngenerator.g translator/pngenerator.h Modified: translator/pngenerator.c =================================================================== --- translator/pngenerator.c 2009-06-18 19:10:10 UTC (rev 71) +++ translator/pngenerator.c 2009-06-18 19:19:46 UTC (rev 72) @@ -2,7 +2,7 @@ * This C source file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pngenerator.g - * - On : 2009-06-18 12:58:49 + * - On : 2009-06-18 14:18:47 * - for the tree parser : pngeneratorTreeParser * * Editing it, at least manually, is not wise. * @@ -639,258 +639,258 @@ /** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_extern_trans_def169 */ static ANTLR3_BITWORD FOLLOW_ID_in_extern_trans_def169_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; static ANTLR3_BITSET_LIST FOLLOW_ID_in_extern_trans_def169 = { FOLLOW_ID_in_extern_trans_def169_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def184 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def184_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def184 = { FOLLOW_ID_in_trans_def184_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def186 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def186_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def186 = { FOLLOW_CODE_BLOCK_in_trans_def186_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def194 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def194_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def194 = { FOLLOW_ID_in_trans_def194_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def196 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def196_bits[] = { ANTLR3_UINT64_LIT(0x0000000000001208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def196 = { FOLLOW_ID_in_trans_def196_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def199 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def199_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def199 = { FOLLOW_CODE_BLOCK_in_trans_def199_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def207 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def207_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def207 = { FOLLOW_ID_in_trans_def207_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def210 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def210_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def210 = { FOLLOW_ID_in_trans_def210_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def212 */ -static ANTLR3_BITWORD FOLLOW_ID_in_trans_def212_bits[] = { ANTLR3_UINT64_LIT(0x0000000000001208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def212 = { FOLLOW_ID_in_trans_def212_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def215 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def215_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def215 = { FOLLOW_CODE_BLOCK_in_trans_def215_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SELECT_DEF_in_select_functions227 */ -static ANTLR3_BITWORD FOLLOW_SELECT_DEF_in_select_functions227_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SELECT_DEF_in_select_functions227 = { FOLLOW_SELECT_DEF_in_select_functions227_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_select_functions229 */ -static ANTLR3_BITWORD FOLLOW_ID_in_select_functions229_bits[] = { ANTLR3_UINT64_LIT(0x0000000000001000) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_select_functions229 = { FOLLOW_ID_in_select_functions229_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_select_functions231 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_select_functions231_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_select_functions231 = { FOLLOW_CODE_BLOCK_in_select_functions231_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_44_in_nondeterm242 */ -static ANTLR3_BITWORD FOLLOW_44_in_nondeterm242_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_44_in_nondeterm242 = { FOLLOW_44_in_nondeterm242_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_nondeterm244 */ -static ANTLR3_BITWORD FOLLOW_ID_in_nondeterm244_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_nondeterm244 = { FOLLOW_ID_in_nondeterm244_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_init_in_proc_instantiations256 */ -static ANTLR3_BITWORD FOLLOW_proc_init_in_proc_instantiations256_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_init_in_proc_instantiations256 = { FOLLOW_proc_init_in_proc_instantiations256_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_sync_def_in_proc_instantiations260 */ -static ANTLR3_BITWORD FOLLOW_sync_def_in_proc_instantiations260_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_sync_def_in_proc_instantiations260 = { FOLLOW_sync_def_in_proc_instantiations260_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_start_in_proc_instantiations264 */ -static ANTLR3_BITWORD FOLLOW_proc_start_in_proc_instantiations264_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_start_in_proc_instantiations264 = { FOLLOW_proc_start_in_proc_instantiations264_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init274 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_init274_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init274 = { FOLLOW_ID_in_proc_init274_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init276 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_init276_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000200) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init276 = { FOLLOW_ID_in_proc_init276_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_numbered_ID_in_proc_init278 */ -static ANTLR3_BITWORD FOLLOW_numbered_ID_in_proc_init278_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_numbered_ID_in_proc_init278 = { FOLLOW_numbered_ID_in_proc_init278_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SYNC_TOK_in_sync_def290 */ -static ANTLR3_BITWORD FOLLOW_SYNC_TOK_in_sync_def290_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SYNC_TOK_in_sync_def290 = { FOLLOW_SYNC_TOK_in_sync_def290_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_sync_def292 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def292_bits[] = { ANTLR3_UINT64_LIT(0x0000000000080208) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_sync_def292 = { FOLLOW_group_elements_in_sync_def292_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints305 */ -static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints305_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints305 = { FOLLOW_constraint_block_in_constraints305_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints307 */ -static ANTLR3_BITWORD FOLLOW_eq_in_constraints307_bits[] = { ANTLR3_UINT64_LIT(0x0001C001A60A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints307 = { FOLLOW_eq_in_constraints307_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints310 */ -static ANTLR3_BITWORD FOLLOW_live_def_in_constraints310_bits[] = { ANTLR3_UINT64_LIT(0x0000000180000008) }; -static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints310 = { FOLLOW_live_def_in_constraints310_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints313 */ -static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints313_bits[] = { ANTLR3_UINT64_LIT(0x0000000100000008) }; -static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints313 = { FOLLOW_uncontrol_in_constraints313_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints316 */ -static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints316_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints316 = { FOLLOW_unobserve_in_constraints316_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start329 */ -static ANTLR3_BITWORD FOLLOW_START_in_proc_start329_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start329 = { FOLLOW_START_in_proc_start329_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start331 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_start331_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start331 = { FOLLOW_ID_in_proc_start331_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block342 */ -static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block342_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block342 = { FOLLOW_ID_in_constraint_block342_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq352 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq352_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq352 = { FOLLOW_relationalExpression_in_eq352_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq358 */ -static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq358_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq358 = { FOLLOW_EQS_OP_in_eq358_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq360 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq360_bits[] = { ANTLR3_UINT64_LIT(0x0001C001A60A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq360 = { FOLLOW_eq_in_eq360_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq362 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq362_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq362 = { FOLLOW_eq_in_eq362_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression378 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression378_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression378 = { FOLLOW_additiveExpression_in_relationalExpression378_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression387 */ -static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression387_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression387 = { FOLLOW_EQ_OP_in_relationalExpression387_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression389 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression389_bits[] = { ANTLR3_UINT64_LIT(0x0001C000040A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression389 = { FOLLOW_relationalExpression_in_relationalExpression389_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression391 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression391_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression391 = { FOLLOW_relationalExpression_in_relationalExpression391_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression407 */ -static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression407_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression407 = { FOLLOW_primary_in_additiveExpression407_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_additiveExpression416 */ -static ANTLR3_BITWORD FOLLOW_ADD_in_additiveExpression416_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ADD_in_additiveExpression416 = { FOLLOW_ADD_in_additiveExpression416_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression418 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression418_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression418 = { FOLLOW_additiveExpression_in_additiveExpression418_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression420 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression420_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression420 = { FOLLOW_additiveExpression_in_additiveExpression420_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SUB_in_additiveExpression430 */ -static ANTLR3_BITWORD FOLLOW_SUB_in_additiveExpression430_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SUB_in_additiveExpression430 = { FOLLOW_SUB_in_additiveExpression430_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression432 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression432_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression432 = { FOLLOW_additiveExpression_in_additiveExpression432_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression434 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression434_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression434 = { FOLLOW_additiveExpression_in_additiveExpression434_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_primary449 */ -static ANTLR3_BITWORD FOLLOW_ID_in_primary449_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_primary449 = { FOLLOW_ID_in_primary449_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary457 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_primary457_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary457 = { FOLLOW_group_elements_in_primary457_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_primary465 */ -static ANTLR3_BITWORD FOLLOW_NUM_in_primary465_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_NUM_in_primary465 = { FOLLOW_NUM_in_primary465_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary474 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_primary474_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary474 = { FOLLOW_MULT_in_primary474_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_primary476 */ -static ANTLR3_BITWORD FOLLOW_NUM_in_primary476_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_NUM_in_primary476 = { FOLLOW_NUM_in_primary476_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary478 */ -static ANTLR3_BITWORD FOLLOW_primary_in_primary478_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary478 = { FOLLOW_primary_in_primary478_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_primary488 */ -static ANTLR3_BITWORD FOLLOW_ADD_in_primary488_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ADD_in_primary488 = { FOLLOW_ADD_in_primary488_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary490 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary490_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary490 = { FOLLOW_additiveExpression_in_primary490_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary492 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary492_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary492 = { FOLLOW_additiveExpression_in_primary492_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SUB_in_primary502 */ -static ANTLR3_BITWORD FOLLOW_SUB_in_primary502_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SUB_in_primary502 = { FOLLOW_SUB_in_primary502_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary504 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary504_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary504 = { FOLLOW_additiveExpression_in_primary504_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary506 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary506_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary506 = { FOLLOW_additiveExpression_in_primary506_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def517 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def517_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def517 = { FOLLOW_LIVE_in_live_def517_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def519 */ -static ANTLR3_BITWORD FOLLOW_ALL_in_live_def519_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def519 = { FOLLOW_ALL_in_live_def519_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def521 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def521_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def521 = { FOLLOW_ID_in_live_def521_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def529 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def529_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def529 = { FOLLOW_LIVE_in_live_def529_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def531 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def531_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def531 = { FOLLOW_ID_in_live_def531_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol543 */ -static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol543_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol543 = { FOLLOW_UNCONTROL_in_uncontrol543_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol545 */ -static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol545_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol545 = { FOLLOW_ID_in_uncontrol545_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve557 */ -static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve557_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve557 = { FOLLOW_UNOBSERVE_in_unobserve557_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve559 */ -static ANTLR3_BITWORD FOLLOW_ID_in_unobserve559_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve559 = { FOLLOW_ID_in_unobserve559_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands571 */ -static ANTLR3_BITWORD FOLLOW_print_in_other_commands571_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands571 = { FOLLOW_print_in_other_commands571_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print581 */ -static ANTLR3_BITWORD FOLLOW_PRINT_in_print581_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print581 = { FOLLOW_PRINT_in_print581_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print583 */ -static ANTLR3_BITWORD FOLLOW_ID_in_print583_bits[] = { ANTLR3_UINT64_LIT(0x0000000000080208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_print583 = { FOLLOW_ID_in_print583_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print585 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_print585_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print585 = { FOLLOW_group_elements_in_print585_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements596 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements596_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements596 = { FOLLOW_ID_in_group_elements596_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_DOT_in_group_elements602 */ -static ANTLR3_BITWORD FOLLOW_DOT_in_group_elements602_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_DOT_in_group_elements602 = { FOLLOW_DOT_in_group_elements602_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_group_elements604 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_group_elements604_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000200) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_group_elements604 = { FOLLOW_group_elements_in_group_elements604_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements606 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements606_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements606 = { FOLLOW_ID_in_group_elements606_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID616 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID616_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID616 = { FOLLOW_ID_in_numbered_ID616_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID622 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID622_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID622 = { FOLLOW_ID_in_numbered_ID622_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID624 */ -static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID624_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID624 = { FOLLOW_INT_in_numbered_ID624_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def189 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def189_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def189 = { FOLLOW_ID_in_trans_def189_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def191 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def191_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def191 = { FOLLOW_CODE_BLOCK_in_trans_def191_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def204 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def204_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def204 = { FOLLOW_ID_in_trans_def204_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def211 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def211_bits[] = { ANTLR3_UINT64_LIT(0x0000000000001208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def211 = { FOLLOW_ID_in_trans_def211_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def220 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def220_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def220 = { FOLLOW_CODE_BLOCK_in_trans_def220_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def238 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def238_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def238 = { FOLLOW_ID_in_trans_def238_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def245 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def245_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def245 = { FOLLOW_ID_in_trans_def245_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def252 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def252_bits[] = { ANTLR3_UINT64_LIT(0x0000000000001208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def252 = { FOLLOW_ID_in_trans_def252_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def261 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def261_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def261 = { FOLLOW_CODE_BLOCK_in_trans_def261_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SELECT_DEF_in_select_functions278 */ +static ANTLR3_BITWORD FOLLOW_SELECT_DEF_in_select_functions278_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SELECT_DEF_in_select_functions278 = { FOLLOW_SELECT_DEF_in_select_functions278_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_select_functions280 */ +static ANTLR3_BITWORD FOLLOW_ID_in_select_functions280_bits[] = { ANTLR3_UINT64_LIT(0x0000000000001000) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_select_functions280 = { FOLLOW_ID_in_select_functions280_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_select_functions282 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_select_functions282_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_select_functions282 = { FOLLOW_CODE_BLOCK_in_select_functions282_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_44_in_nondeterm293 */ +static ANTLR3_BITWORD FOLLOW_44_in_nondeterm293_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_44_in_nondeterm293 = { FOLLOW_44_in_nondeterm293_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_nondeterm295 */ +static ANTLR3_BITWORD FOLLOW_ID_in_nondeterm295_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_nondeterm295 = { FOLLOW_ID_in_nondeterm295_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_init_in_proc_instantiations307 */ +static ANTLR3_BITWORD FOLLOW_proc_init_in_proc_instantiations307_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_init_in_proc_instantiations307 = { FOLLOW_proc_init_in_proc_instantiations307_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_sync_def_in_proc_instantiations311 */ +static ANTLR3_BITWORD FOLLOW_sync_def_in_proc_instantiations311_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_sync_def_in_proc_instantiations311 = { FOLLOW_sync_def_in_proc_instantiations311_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_start_in_proc_instantiations315 */ +static ANTLR3_BITWORD FOLLOW_proc_start_in_proc_instantiations315_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_start_in_proc_instantiations315 = { FOLLOW_proc_start_in_proc_instantiations315_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init325 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_init325_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init325 = { FOLLOW_ID_in_proc_init325_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init327 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_init327_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000200) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init327 = { FOLLOW_ID_in_proc_init327_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_numbered_ID_in_proc_init329 */ +static ANTLR3_BITWORD FOLLOW_numbered_ID_in_proc_init329_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_numbered_ID_in_proc_init329 = { FOLLOW_numbered_ID_in_proc_init329_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SYNC_TOK_in_sync_def341 */ +static ANTLR3_BITWORD FOLLOW_SYNC_TOK_in_sync_def341_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SYNC_TOK_in_sync_def341 = { FOLLOW_SYNC_TOK_in_sync_def341_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_sync_def343 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def343_bits[] = { ANTLR3_UINT64_LIT(0x0000000000080208) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_sync_def343 = { FOLLOW_group_elements_in_sync_def343_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints356 */ +static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints356_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints356 = { FOLLOW_constraint_block_in_constraints356_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints358 */ +static ANTLR3_BITWORD FOLLOW_eq_in_constraints358_bits[] = { ANTLR3_UINT64_LIT(0x0001C001A60A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints358 = { FOLLOW_eq_in_constraints358_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints361 */ +static ANTLR3_BITWORD FOLLOW_live_def_in_constraints361_bits[] = { ANTLR3_UINT64_LIT(0x0000000180000008) }; +static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints361 = { FOLLOW_live_def_in_constraints361_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints364 */ +static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints364_bits[] = { ANTLR3_UINT64_LIT(0x0000000100000008) }; +static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints364 = { FOLLOW_uncontrol_in_constraints364_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints367 */ +static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints367_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints367 = { FOLLOW_unobserve_in_constraints367_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start380 */ +static ANTLR3_BITWORD FOLLOW_START_in_proc_start380_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start380 = { FOLLOW_START_in_proc_start380_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start382 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_start382_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start382 = { FOLLOW_ID_in_proc_start382_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block393 */ +static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block393_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block393 = { FOLLOW_ID_in_constraint_block393_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq403 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq403_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq403 = { FOLLOW_relationalExpression_in_eq403_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq409 */ +static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq409_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq409 = { FOLLOW_EQS_OP_in_eq409_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq411 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq411_bits[] = { ANTLR3_UINT64_LIT(0x0001C001A60A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq411 = { FOLLOW_eq_in_eq411_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq413 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq413_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq413 = { FOLLOW_eq_in_eq413_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression429 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression429_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression429 = { FOLLOW_additiveExpression_in_relationalExpression429_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression438 */ +static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression438_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression438 = { FOLLOW_EQ_OP_in_relationalExpression438_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression440 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression440_bits[] = { ANTLR3_UINT64_LIT(0x0001C000040A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression440 = { FOLLOW_relationalExpression_in_relationalExpression440_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression442 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression442_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression442 = { FOLLOW_relationalExpression_in_relationalExpression442_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression458 */ +static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression458_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression458 = { FOLLOW_primary_in_additiveExpression458_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_additiveExpression467 */ +static ANTLR3_BITWORD FOLLOW_ADD_in_additiveExpression467_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ADD_in_additiveExpression467 = { FOLLOW_ADD_in_additiveExpression467_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression469 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression469_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression469 = { FOLLOW_additiveExpression_in_additiveExpression469_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression471 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression471_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression471 = { FOLLOW_additiveExpression_in_additiveExpression471_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SUB_in_additiveExpression481 */ +static ANTLR3_BITWORD FOLLOW_SUB_in_additiveExpression481_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SUB_in_additiveExpression481 = { FOLLOW_SUB_in_additiveExpression481_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression483 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression483_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression483 = { FOLLOW_additiveExpression_in_additiveExpression483_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression485 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression485_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression485 = { FOLLOW_additiveExpression_in_additiveExpression485_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_primary500 */ +static ANTLR3_BITWORD FOLLOW_ID_in_primary500_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_primary500 = { FOLLOW_ID_in_primary500_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary508 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_primary508_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary508 = { FOLLOW_group_elements_in_primary508_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_primary516 */ +static ANTLR3_BITWORD FOLLOW_NUM_in_primary516_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_NUM_in_primary516 = { FOLLOW_NUM_in_primary516_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary525 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_primary525_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary525 = { FOLLOW_MULT_in_primary525_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_NUM_in_primary527 */ +static ANTLR3_BITWORD FOLLOW_NUM_in_primary527_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_NUM_in_primary527 = { FOLLOW_NUM_in_primary527_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary529 */ +static ANTLR3_BITWORD FOLLOW_primary_in_primary529_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary529 = { FOLLOW_primary_in_primary529_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_primary539 */ +static ANTLR3_BITWORD FOLLOW_ADD_in_primary539_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ADD_in_primary539 = { FOLLOW_ADD_in_primary539_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary541 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary541_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary541 = { FOLLOW_additiveExpression_in_primary541_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary543 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary543_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary543 = { FOLLOW_additiveExpression_in_primary543_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SUB_in_primary553 */ +static ANTLR3_BITWORD FOLLOW_SUB_in_primary553_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SUB_in_primary553 = { FOLLOW_SUB_in_primary553_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary555 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary555_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary555 = { FOLLOW_additiveExpression_in_primary555_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_primary557 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_primary557_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_primary557 = { FOLLOW_additiveExpression_in_primary557_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def568 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def568_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def568 = { FOLLOW_LIVE_in_live_def568_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def570 */ +static ANTLR3_BITWORD FOLLOW_ALL_in_live_def570_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def570 = { FOLLOW_ALL_in_live_def570_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def572 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def572_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def572 = { FOLLOW_ID_in_live_def572_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def580 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def580_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def580 = { FOLLOW_LIVE_in_live_def580_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def582 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def582_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def582 = { FOLLOW_ID_in_live_def582_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol594 */ +static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol594_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol594 = { FOLLOW_UNCONTROL_in_uncontrol594_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol596 */ +static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol596_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol596 = { FOLLOW_ID_in_uncontrol596_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve608 */ +static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve608_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve608 = { FOLLOW_UNOBSERVE_in_unobserve608_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve610 */ +static ANTLR3_BITWORD FOLLOW_ID_in_unobserve610_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve610 = { FOLLOW_ID_in_unobserve610_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands622 */ +static ANTLR3_BITWORD FOLLOW_print_in_other_commands622_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands622 = { FOLLOW_print_in_other_commands622_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print632 */ +static ANTLR3_BITWORD FOLLOW_PRINT_in_print632_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print632 = { FOLLOW_PRINT_in_print632_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print634 */ +static ANTLR3_BITWORD FOLLOW_ID_in_print634_bits[] = { ANTLR3_UINT64_LIT(0x0000000000080208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_print634 = { FOLLOW_ID_in_print634_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print636 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_print636_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print636 = { FOLLOW_group_elements_in_print636_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements647 */ +static ANTLR3_BITWORD FOLLOW_ID_in_group_elements647_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements647 = { FOLLOW_ID_in_group_elements647_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_DOT_in_group_elements653 */ +static ANTLR3_BITWORD FOLLOW_DOT_in_group_elements653_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_DOT_in_group_elements653 = { FOLLOW_DOT_in_group_elements653_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_group_elements655 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_group_elements655_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000200) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_group_elements655 = { FOLLOW_group_elements_in_group_elements655_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements657 */ +static ANTLR3_BITWORD FOLLOW_ID_in_group_elements657_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements657 = { FOLLOW_ID_in_group_elements657_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID667 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID667_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID667 = { FOLLOW_ID_in_numbered_ID667_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID673 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID673_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID673 = { FOLLOW_ID_in_numbered_ID673_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID675 */ +static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID675_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID675 = { FOLLOW_INT_in_numbered_ID675_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_synpred2_pngenerator80 */ static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_synpred2_pngenerator80_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_synpred2_pngenerator80 = { FOLLOW_proc_instantiations_in_synpred2_pngenerator80_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred29_pngenerator407 */ -static ANTLR3_BITWORD FOLLOW_primary_in_synpred29_pngenerator407_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred29_pngenerator407 = { FOLLOW_primary_in_synpred29_pngenerator407_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_synpred30_pngenerator416 */ -static ANTLR3_BITWORD FOLLOW_ADD_in_synpred30_pngenerator416_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ADD_in_synpred30_pngenerator416 = { FOLLOW_ADD_in_synpred30_pngenerator416_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_synpred30_pngenerator418 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_synpred30_pngenerator418_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_synpred30_pngenerator418 = { FOLLOW_additiveExpression_in_synpred30_pngenerator418_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_synpred30_pngenerator420 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_synpred30_pngenerator420_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_synpred30_pngenerator420 = { FOLLOW_additiveExpression_in_synpred30_pngenerator420_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_synpred31_pngenerator449 */ -static ANTLR3_BITWORD FOLLOW_ID_in_synpred31_pngenerator449_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_synpred31_pngenerator449 = { FOLLOW_ID_in_synpred31_pngenerator449_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_synpred32_pngenerator457 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_synpred32_pngenerator457_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_synpred32_pngenerator457 = { FOLLOW_group_elements_in_synpred32_pngenerator457_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred29_pngenerator458 */ +static ANTLR3_BITWORD FOLLOW_primary_in_synpred29_pngenerator458_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred29_pngenerator458 = { FOLLOW_primary_in_synpred29_pngenerator458_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ADD_in_synpred30_pngenerator467 */ +static ANTLR3_BITWORD FOLLOW_ADD_in_synpred30_pngenerator467_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ADD_in_synpred30_pngenerator467 = { FOLLOW_ADD_in_synpred30_pngenerator467_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_synpred30_pngenerator469 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_synpred30_pngenerator469_bits[] = { ANTLR3_UINT64_LIT(0x0001C000000A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_synpred30_pngenerator469 = { FOLLOW_additiveExpression_in_synpred30_pngenerator469_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_synpred30_pngenerator471 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_synpred30_pngenerator471_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_synpred30_pngenerator471 = { FOLLOW_additiveExpression_in_synpred30_pngenerator471_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_synpred31_pngenerator500 */ +static ANTLR3_BITWORD FOLLOW_ID_in_synpred31_pngenerator500_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_synpred31_pngenerator500 = { FOLLOW_ID_in_synpred31_pngenerator500_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_synpred32_pngenerator508 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_synpred32_pngenerator508_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_synpred32_pngenerator508 = { FOLLOW_group_elements_in_synpred32_pngenerator508_bits, 1 }; @@ -930,29 +930,29 @@ static const ANTLR3_INT32 dfa2_T0[] = { - 1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 3, 3, -1, -1, -1, -1, -1, - -1, -1, -1, -1, -1, 2 + 3, 7, -1, -1, -1, -1, -1, 6, -1, -1, -1, -1, -1, -1, -1, 2, -1, 2, -1, + -1, -1, -1, -1, 2, 2, -1, -1, 2, -1, 2, 2, -1, -1, -1, -1, -1, -1, -1, + -1, -1, -1, -1, -1, -1, 2, 2, 2 };static const ANTLR3_INT32 dfa2_T1[] = { -1 };static const ANTLR3_INT32 dfa2_T2[] = { + 1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 3, 3, -1, -1, -1, -1, -1, + -1, -1, -1, -1, -1, 2 + };static const ANTLR3_INT32 dfa2_T3[] = + { 2, -1, -1, -1, -1, -1, 5, -1, -1, -1, -1, -1, -1, -1, 2, -1, 2, -1, -1, -1, -1, -1, 2, 2, -1, -1, 2, -1, 2, 2, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 2, 2, 2 - };static const ANTLR3_INT32 dfa2_T3[] = - { - 3, 7, -1, -1, -1, -1, -1, 6, -1, -1, -1, -1, -1, -1, -1, 2, -1, 2, -1, - -1, -1, -1, -1, 2, 2, -1, -1, 2, -1, 2, 2, -1, -1, -1, -1, -1, -1, -1, - -1, -1, -1, -1, -1, -1, 2, 2, 2 };static const ANTLR3_INT32 dfa2_T4[] = { - 4 - };static const ANTLR3_INT32 dfa2_T5[] = - { 2, -1, -1, -1, -1, -1, 6, -1, -1, -1, -1, -1, -1, -1, 2, -1, 2, -1, -1, -1, -1, -1, 2, 2, -1, -1, 2, -1, 2, 2, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 2, 2, 2 + };static const ANTLR3_INT32 dfa2_T5[] = + { + 4 }; /* Transition tables are a table of sub tables, with some tables @@ -960,7 +960,7 @@ */ static const ANTLR3_INT32 * const dfa2_transitions[] = { - dfa2_T0, dfa2_T4, dfa2_T_empty, dfa2_T_empty, dfa2_T2, dfa2_T5, dfa2_T3, + dfa2_T2, dfa2_T5, dfa2_T_empty, dfa2_T_empty, dfa2_T3, dfa2_T4, dfa2_T0, dfa2_T1 }; @@ -1951,18 +1951,42 @@ /** * $ANTLR start trans_def - * /Users/bion/projects/iordache/translator/pngenerator.g:125:1: trans_def : ( ^( ID CODE_BLOCK ) | ^( ID ( ID )+ ( CODE_BLOCK )? ) | ^( ID ^( ID ( ID )+ ( CODE_BLOCK )? ) ) ); + * /Users/bion/projects/iordache/translator/pngenerator.g:125:1: trans_def : ( ^( ID CODE_BLOCK ) | ^(tran= ID (place= ID )+ ( CODE_BLOCK )? ) | ^(tran= ID ^(pInit= ID (place= ID )+ ( CODE_BLOCK )? ) ) ); */ static void trans_def(ppngenerator ctx) { + pANTLR3_BASE_TREE tran; + pANTLR3_BASE_TREE place; + pANTLR3_BASE_TREE pInit; + pANTLR3_BASE_TREE CODE_BLOCK5; + pANTLR3_BASE_TREE CODE_BLOCK6; + /* Initialize rule variables */ + + static int trans; + static struct placelist* places; + struct placelist* currentPlace; + struct placelist* lastPlace; + static arcs* arcs; + + currentPlace = tmalloc(sizeof(struct placelist)); + places = currentPlace; + arcs = tmalloc(sizeof(arcs)); + arcs->next = 0; //I'm not even sure what a next arc would mean... + + tran = NULL; + place = NULL; + pInit = NULL; + CODE_BLOCK5 = NULL; + CODE_BLOCK6 = NULL; + { { - // /Users/bion/projects/iordache/translator/pngenerator.g:126:2: ( ^( ID CODE_BLOCK ) | ^( ID ( ID )+ ( CODE_BLOCK )? ) | ^( ID ^( ID ( ID )+ ( CODE_BLOCK )? ) ) ) + // /Users/bion/projects/iordache/translator/pngenerator.g:138:2: ( ^( ID CODE_BLOCK ) | ^(tran= ID (place= ID )+ ( CODE_BLOCK )? ) | ^(tran= ID ^(pInit= ID (place= ID )+ ( CODE_BLOCK )? ) ) ) ANTLR3_UINT32 alt15; @@ -2076,9 +2100,9 @@ switch (alt15) { case 1: - // /Users/bion/projects/iordache/translator/pngenerator.g:126:4: ^( ID CODE_BLOCK ) + // /Users/bion/projects/iordache/translator/pngenerator.g:138:4: ^( ID CODE_BLOCK ) { - MATCHT(ID, &FOLLOW_ID_in_trans_def184); + MATCHT(ID, &FOLLOW_ID_in_trans_def189); if (HASEXCEPTION()) { goto ruletrans_defEx; @@ -2097,7 +2121,7 @@ { return ; } - MATCHT(CODE_BLOCK, &FOLLOW_CODE_BLOCK_in_trans_def186); + MATCHT(CODE_BLOCK, &FOLLOW_CODE_BLOCK_in_trans_def191); if (HASEXCEPTION()) { goto ruletrans_defEx; @@ -2120,9 +2144,9 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pngenerator.g:127:4: ^( ID ( ID )+ ( CODE_BLOCK )? ) + // /Users/bion/projects/iordache/translator/pngenerator.g:140:4: ^(tran= ID (place= ID )+ ( CODE_BLOCK )? ) { - MATCHT(ID, &FOLLOW_ID_in_trans_def194); + tran = (pANTLR3_BASE_TREE) MATCHT(ID, &FOLLOW_ID_in_trans_def204); if (HASEXCEPTION()) { goto ruletrans_defEx; @@ -2132,6 +2156,13 @@ return ; } + if ( BACKTRACKING==0 ) + { + + trans = *((int*) (SCOPE_TOP(proc_definitions))->trans->get( (SCOPE_TOP(proc_definitions))->trans, (char*) (tran->getText(tran))->chars)); + ... [truncated message content] |
From: <the...@us...> - 2009-06-18 19:10:25
|
Revision: 71 http://pntool.svn.sourceforge.net/pntool/?rev=71&view=rev Author: thecodeweasel Date: 2009-06-18 19:10:10 +0000 (Thu, 18 Jun 2009) Log Message: ----------- Oops. Lingering debug statement. Modified Paths: -------------- translator/pnscript.g translator/pnscriptLexer.c translator/pnscriptLexer.h translator/pnscriptParser.c translator/pnscriptParser.h Modified: translator/pnscript.g =================================================================== --- translator/pnscript.g 2009-06-18 18:02:49 UTC (rev 70) +++ translator/pnscript.g 2009-06-18 19:10:10 UTC (rev 71) @@ -204,7 +204,6 @@ //silly user! We'll try to help them out here... addTrans($proc_definitions::trans, t->getText(t)->chars); } - printf("p = \%s\n", $p.text->chars); })+) -> ^(FROM[$p, $p.text->chars] $t+) | (p=ID { if(NULL == $proc_definitions::places->get($proc_definitions::places, (char*) $p.text->chars)) { Modified: translator/pnscriptLexer.c =================================================================== --- translator/pnscriptLexer.c 2009-06-18 18:02:49 UTC (rev 70) +++ translator/pnscriptLexer.c 2009-06-18 19:10:10 UTC (rev 71) @@ -2,7 +2,7 @@ * This C source file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pnscript.g - * - On : 2009-06-18 12:45:21 + * - On : 2009-06-18 14:09:04 * - for the lexer : pnscriptLexerLexer * * Editing it, at least manually, is not wise. * @@ -1275,7 +1275,7 @@ } // $ANTLR end T__45 -// Comes from: 498:2: ( 'extern' ) +// Comes from: 497:2: ( 'extern' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start EXTERN @@ -1295,8 +1295,8 @@ _type = EXTERN; - // /Users/bion/projects/iordache/translator/pnscript.g:498:2: ( 'extern' ) - // /Users/bion/projects/iordache/translator/pnscript.g:498:4: 'extern' + // /Users/bion/projects/iordache/translator/pnscript.g:497:2: ( 'extern' ) + // /Users/bion/projects/iordache/translator/pnscript.g:497:4: 'extern' { MATCHS(lit_4); if (HASEXCEPTION()) @@ -1318,7 +1318,7 @@ } // $ANTLR end EXTERN -// Comes from: 500:2: ( 'process' ) +// Comes from: 499:2: ( 'process' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start PROCESS @@ -1338,8 +1338,8 @@ _type = PROCESS; - // /Users/bion/projects/iordache/translator/pnscript.g:500:2: ( 'process' ) - // /Users/bion/projects/iordache/translator/pnscript.g:500:4: 'process' + // /Users/bion/projects/iordache/translator/pnscript.g:499:2: ( 'process' ) + // /Users/bion/projects/iordache/translator/pnscript.g:499:4: 'process' { MATCHS(lit_5); if (HASEXCEPTION()) @@ -1361,7 +1361,7 @@ } // $ANTLR end PROCESS -// Comes from: 502:2: ( 'build' ':' ) +// Comes from: 501:2: ( 'build' ':' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start BUILD @@ -1381,8 +1381,8 @@ _type = BUILD; - // /Users/bion/projects/iordache/translator/pnscript.g:502:2: ( 'build' ':' ) - // /Users/bion/projects/iordache/translator/pnscript.g:502:4: 'build' ':' + // /Users/bion/projects/iordache/translator/pnscript.g:501:2: ( 'build' ':' ) + // /Users/bion/projects/iordache/translator/pnscript.g:501:4: 'build' ':' { MATCHS(lit_6); if (HASEXCEPTION()) @@ -1410,7 +1410,7 @@ } // $ANTLR end BUILD -// Comes from: 504:2: ( 'include' ':' ) +// Comes from: 503:2: ( 'include' ':' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start INCLUDE @@ -1430,8 +1430,8 @@ _type = INCLUDE; - // /Users/bion/projects/iordache/translator/pnscript.g:504:2: ( 'include' ':' ) - // /Users/bion/projects/iordache/translator/pnscript.g:504:4: 'include' ':' + // /Users/bion/projects/iordache/translator/pnscript.g:503:2: ( 'include' ':' ) + // /Users/bion/projects/iordache/translator/pnscript.g:503:4: 'include' ':' { MATCHS(lit_7); if (HASEXCEPTION()) @@ -1459,7 +1459,7 @@ } // $ANTLR end INCLUDE -// Comes from: 507:2: ( '.PN:' ) +// Comes from: 506:2: ( '.PN:' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start PNDEF @@ -1479,8 +1479,8 @@ _type = PNDEF; - // /Users/bion/projects/iordache/translator/pnscript.g:507:2: ( '.PN:' ) - // /Users/bion/projects/iordache/translator/pnscript.g:507:4: '.PN:' + // /Users/bion/projects/iordache/translator/pnscript.g:506:2: ( '.PN:' ) + // /Users/bion/projects/iordache/translator/pnscript.g:506:4: '.PN:' { MATCHS(lit_8); if (HASEXCEPTION()) @@ -1502,7 +1502,7 @@ } // $ANTLR end PNDEF -// Comes from: 509:2: ( 'places' ':' ) +// Comes from: 508:2: ( 'places' ':' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start PLACES @@ -1522,8 +1522,8 @@ _type = PLACES; - // /Users/bion/projects/iordache/translator/pnscript.g:509:2: ( 'places' ':' ) - // /Users/bion/projects/iordache/translator/pnscript.g:509:4: 'places' ':' + // /Users/bion/projects/iordache/translator/pnscript.g:508:2: ( 'places' ':' ) + // /Users/bion/projects/iordache/translator/pnscript.g:508:4: 'places' ':' { MATCHS(lit_9); if (HASEXCEPTION()) @@ -1551,7 +1551,7 @@ } // $ANTLR end PLACES -// Comes from: 511:2: ( 'trans' ( 'itions' )? ':' ) +// Comes from: 510:2: ( 'trans' ( 'itions' )? ':' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start TRANS @@ -1571,8 +1571,8 @@ _type = TRANS; - // /Users/bion/projects/iordache/translator/pnscript.g:511:2: ( 'trans' ( 'itions' )? ':' ) - // /Users/bion/projects/iordache/translator/pnscript.g:511:4: 'trans' ( 'itions' )? ':' + // /Users/bion/projects/iordache/translator/pnscript.g:510:2: ( 'trans' ( 'itions' )? ':' ) + // /Users/bion/projects/iordache/translator/pnscript.g:510:4: 'trans' ( 'itions' )? ':' { MATCHS(lit_10); if (HASEXCEPTION()) @@ -1582,7 +1582,7 @@ - // /Users/bion/projects/iordache/translator/pnscript.g:511:12: ( 'itions' )? + // /Users/bion/projects/iordache/translator/pnscript.g:510:12: ( 'itions' )? { int alt1=2; { @@ -1595,7 +1595,7 @@ switch (alt1) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:511:12: 'itions' + // /Users/bion/projects/iordache/translator/pnscript.g:510:12: 'itions' { MATCHS(lit_11); if (HASEXCEPTION()) @@ -1629,7 +1629,7 @@ } // $ANTLR end TRANS -// Comes from: 513:2: ( '.code:' ) +// Comes from: 512:2: ( '.code:' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start CODE @@ -1649,8 +1649,8 @@ _type = CODE; - // /Users/bion/projects/iordache/translator/pnscript.g:513:2: ( '.code:' ) - // /Users/bion/projects/iordache/translator/pnscript.g:513:4: '.code:' + // /Users/bion/projects/iordache/translator/pnscript.g:512:2: ( '.code:' ) + // /Users/bion/projects/iordache/translator/pnscript.g:512:4: '.code:' { MATCHS(lit_12); if (HASEXCEPTION()) @@ -1672,7 +1672,7 @@ } // $ANTLR end CODE -// Comes from: 515:2: ( 'select function' ) +// Comes from: 514:2: ( 'select function' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start SELECT_DEF @@ -1692,8 +1692,8 @@ _type = SELECT_DEF; - // /Users/bion/projects/iordache/translator/pnscript.g:515:2: ( 'select function' ) - // /Users/bion/projects/iordache/translator/pnscript.g:515:4: 'select function' + // /Users/bion/projects/iordache/translator/pnscript.g:514:2: ( 'select function' ) + // /Users/bion/projects/iordache/translator/pnscript.g:514:4: 'select function' { MATCHS(lit_13); if (HASEXCEPTION()) @@ -1715,7 +1715,7 @@ } // $ANTLR end SELECT_DEF -// Comes from: 518:2: ( 'sync' ) +// Comes from: 517:2: ( 'sync' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start SYNC_TOK @@ -1735,8 +1735,8 @@ _type = SYNC_TOK; - // /Users/bion/projects/iordache/translator/pnscript.g:518:2: ( 'sync' ) - // /Users/bion/projects/iordache/translator/pnscript.g:518:4: 'sync' + // /Users/bion/projects/iordache/translator/pnscript.g:517:2: ( 'sync' ) + // /Users/bion/projects/iordache/translator/pnscript.g:517:4: 'sync' { MATCHS(lit_14); if (HASEXCEPTION()) @@ -1758,7 +1758,7 @@ } // $ANTLR end SYNC_TOK -// Comes from: 520:2: ( 'start' ) +// Comes from: 519:2: ( 'start' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start START @@ -1778,8 +1778,8 @@ _type = START; - // /Users/bion/projects/iordache/translator/pnscript.g:520:2: ( 'start' ) - // /Users/bion/projects/iordache/translator/pnscript.g:520:4: 'start' + // /Users/bion/projects/iordache/translator/pnscript.g:519:2: ( 'start' ) + // /Users/bion/projects/iordache/translator/pnscript.g:519:4: 'start' { MATCHS(lit_15); if (HASEXCEPTION()) @@ -1801,7 +1801,7 @@ } // $ANTLR end START -// Comes from: 523:2: ( '.constraints:' ) +// Comes from: 522:2: ( '.constraints:' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start CONSTRAINTS @@ -1821,8 +1821,8 @@ _type = CONSTRAINTS; - // /Users/bion/projects/iordache/translator/pnscript.g:523:2: ( '.constraints:' ) - // /Users/bion/projects/iordache/translator/pnscript.g:523:4: '.constraints:' + // /Users/bion/projects/iordache/translator/pnscript.g:522:2: ( '.constraints:' ) + // /Users/bion/projects/iordache/translator/pnscript.g:522:4: '.constraints:' { MATCHS(lit_16); if (HASEXCEPTION()) @@ -1844,7 +1844,7 @@ } // $ANTLR end CONSTRAINTS -// Comes from: 525:2: ( '||' | '&&' | 'or' | 'OR' | 'and' | 'AND' ) +// Comes from: 524:2: ( '||' | '&&' | 'or' | 'OR' | 'and' | 'AND' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start EQS_OP @@ -1865,7 +1865,7 @@ { - // /Users/bion/projects/iordache/translator/pnscript.g:525:2: ( '||' | '&&' | 'or' | 'OR' | 'and' | 'AND' ) + // /Users/bion/projects/iordache/translator/pnscript.g:524:2: ( '||' | '&&' | 'or' | 'OR' | 'and' | 'AND' ) ANTLR3_UINT32 alt2; @@ -1918,7 +1918,7 @@ switch (alt2) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:525:4: '||' + // /Users/bion/projects/iordache/translator/pnscript.g:524:4: '||' { MATCHS(lit_17); if (HASEXCEPTION()) @@ -1931,7 +1931,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pnscript.g:525:9: '&&' + // /Users/bion/projects/iordache/translator/pnscript.g:524:9: '&&' { MATCHS(lit_18); if (HASEXCEPTION()) @@ -1944,7 +1944,7 @@ } break; case 3: - // /Users/bion/projects/iordache/translator/pnscript.g:525:14: 'or' + // /Users/bion/projects/iordache/translator/pnscript.g:524:14: 'or' { MATCHS(lit_19); if (HASEXCEPTION()) @@ -1957,7 +1957,7 @@ } break; case 4: - // /Users/bion/projects/iordache/translator/pnscript.g:525:19: 'OR' + // /Users/bion/projects/iordache/translator/pnscript.g:524:19: 'OR' { MATCHS(lit_20); if (HASEXCEPTION()) @@ -1970,7 +1970,7 @@ } break; case 5: - // /Users/bion/projects/iordache/translator/pnscript.g:525:24: 'and' + // /Users/bion/projects/iordache/translator/pnscript.g:524:24: 'and' { MATCHS(lit_21); if (HASEXCEPTION()) @@ -1983,7 +1983,7 @@ } break; case 6: - // /Users/bion/projects/iordache/translator/pnscript.g:525:30: 'AND' + // /Users/bion/projects/iordache/translator/pnscript.g:524:30: 'AND' { MATCHS(lit_22); if (HASEXCEPTION()) @@ -2008,7 +2008,7 @@ } // $ANTLR end EQS_OP -// Comes from: 527:2: ( '<' | '<=' | '=' | '!=' | '>=' | '>' ) +// Comes from: 526:2: ( '<' | '<=' | '=' | '!=' | '>=' | '>' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start EQ_OP @@ -2029,7 +2029,7 @@ { - // /Users/bion/projects/iordache/translator/pnscript.g:527:2: ( '<' | '<=' | '=' | '!=' | '>=' | '>' ) + // /Users/bion/projects/iordache/translator/pnscript.g:526:2: ( '<' | '<=' | '=' | '!=' | '>=' | '>' ) ANTLR3_UINT32 alt3; @@ -2092,7 +2092,7 @@ switch (alt3) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:527:4: '<' + // /Users/bion/projects/iordache/translator/pnscript.g:526:4: '<' { MATCHC('<'); if (HASEXCEPTION()) @@ -2104,7 +2104,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pnscript.g:527:8: '<=' + // /Users/bion/projects/iordache/translator/pnscript.g:526:8: '<=' { MATCHS(lit_23); if (HASEXCEPTION()) @@ -2117,7 +2117,7 @@ } break; case 3: - // /Users/bion/projects/iordache/translator/pnscript.g:527:13: '=' + // /Users/bion/projects/iordache/translator/pnscript.g:526:13: '=' { MATCHC('='); if (HASEXCEPTION()) @@ -2129,7 +2129,7 @@ } break; case 4: - // /Users/bion/projects/iordache/translator/pnscript.g:527:17: '!=' + // /Users/bion/projects/iordache/translator/pnscript.g:526:17: '!=' { MATCHS(lit_24); if (HASEXCEPTION()) @@ -2142,7 +2142,7 @@ } break; case 5: - // /Users/bion/projects/iordache/translator/pnscript.g:527:22: '>=' + // /Users/bion/projects/iordache/translator/pnscript.g:526:22: '>=' { MATCHS(lit_25); if (HASEXCEPTION()) @@ -2155,7 +2155,7 @@ } break; case 6: - // /Users/bion/projects/iordache/translator/pnscript.g:527:27: '>' + // /Users/bion/projects/iordache/translator/pnscript.g:526:27: '>' { MATCHC('>'); if (HASEXCEPTION()) @@ -2179,7 +2179,7 @@ } // $ANTLR end EQ_OP -// Comes from: 529:2: ( '*' ) +// Comes from: 528:2: ( '*' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start MULT @@ -2199,8 +2199,8 @@ _type = MULT; - // /Users/bion/projects/iordache/translator/pnscript.g:529:2: ( '*' ) - // /Users/bion/projects/iordache/translator/pnscript.g:529:4: '*' + // /Users/bion/projects/iordache/translator/pnscript.g:528:2: ( '*' ) + // /Users/bion/projects/iordache/translator/pnscript.g:528:4: '*' { MATCHC('*'); if (HASEXCEPTION()) @@ -2221,7 +2221,7 @@ } // $ANTLR end MULT -// Comes from: 531:2: ( 'live:' ) +// Comes from: 530:2: ( 'live:' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start LIVE @@ -2241,8 +2241,8 @@ _type = LIVE; - // /Users/bion/projects/iordache/translator/pnscript.g:531:2: ( 'live:' ) - // /Users/bion/projects/iordache/translator/pnscript.g:531:4: 'live:' + // /Users/bion/projects/iordache/translator/pnscript.g:530:2: ( 'live:' ) + // /Users/bion/projects/iordache/translator/pnscript.g:530:4: 'live:' { MATCHS(lit_26); if (HASEXCEPTION()) @@ -2264,7 +2264,7 @@ } // $ANTLR end LIVE -// Comes from: 532:5: ( 'all' | 'All' | 'ALL' ) +// Comes from: 531:5: ( 'all' | 'All' | 'ALL' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start ALL @@ -2285,7 +2285,7 @@ { - // /Users/bion/projects/iordache/translator/pnscript.g:532:5: ( 'all' | 'All' | 'ALL' ) + // /Users/bion/projects/iordache/translator/pnscript.g:531:5: ( 'all' | 'All' | 'ALL' ) ANTLR3_UINT32 alt4; @@ -2341,7 +2341,7 @@ switch (alt4) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:532:7: 'all' + // /Users/bion/projects/iordache/translator/pnscript.g:531:7: 'all' { MATCHS(lit_27); if (HASEXCEPTION()) @@ -2354,7 +2354,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pnscript.g:532:13: 'All' + // /Users/bion/projects/iordache/translator/pnscript.g:531:13: 'All' { MATCHS(lit_28); if (HASEXCEPTION()) @@ -2367,7 +2367,7 @@ } break; case 3: - // /Users/bion/projects/iordache/translator/pnscript.g:532:19: 'ALL' + // /Users/bion/projects/iordache/translator/pnscript.g:531:19: 'ALL' { MATCHS(lit_29); if (HASEXCEPTION()) @@ -2392,7 +2392,7 @@ } // $ANTLR end ALL -// Comes from: 534:2: ( 'uncontrollable: ' ) +// Comes from: 533:2: ( 'uncontrollable: ' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start UNCONTROL @@ -2412,8 +2412,8 @@ _type = UNCONTROL; - // /Users/bion/projects/iordache/translator/pnscript.g:534:2: ( 'uncontrollable: ' ) - // /Users/bion/projects/iordache/translator/pnscript.g:534:4: 'uncontrollable: ' + // /Users/bion/projects/iordache/translator/pnscript.g:533:2: ( 'uncontrollable: ' ) + // /Users/bion/projects/iordache/translator/pnscript.g:533:4: 'uncontrollable: ' { MATCHS(lit_30); if (HASEXCEPTION()) @@ -2435,7 +2435,7 @@ } // $ANTLR end UNCONTROL -// Comes from: 536:2: ( 'unobservable: ' ) +// Comes from: 535:2: ( 'unobservable: ' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start UNOBSERVE @@ -2455,8 +2455,8 @@ _type = UNOBSERVE; - // /Users/bion/projects/iordache/translator/pnscript.g:536:2: ( 'unobservable: ' ) - // /Users/bion/projects/iordache/translator/pnscript.g:536:4: 'unobservable: ' + // /Users/bion/projects/iordache/translator/pnscript.g:535:2: ( 'unobservable: ' ) + // /Users/bion/projects/iordache/translator/pnscript.g:535:4: 'unobservable: ' { MATCHS(lit_31); if (HASEXCEPTION()) @@ -2478,7 +2478,7 @@ } // $ANTLR end UNOBSERVE -// Comes from: 539:2: ( 'print' ) +// Comes from: 538:2: ( 'print' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start PRINT @@ -2498,8 +2498,8 @@ _type = PRINT; - // /Users/bion/projects/iordache/translator/pnscript.g:539:2: ( 'print' ) - // /Users/bion/projects/iordache/translator/pnscript.g:539:4: 'print' + // /Users/bion/projects/iordache/translator/pnscript.g:538:2: ( 'print' ) + // /Users/bion/projects/iordache/translator/pnscript.g:538:4: 'print' { MATCHS(lit_32); if (HASEXCEPTION()) @@ -2521,7 +2521,7 @@ } // $ANTLR end PRINT -// Comes from: 544:2: ( '{' ( CODE_BLOCK | STRING | ~ ( '{' | '}' | '\\\"' | '\\'' ) )* '}' ) +// Comes from: 543:2: ( '{' ( CODE_BLOCK | STRING | ~ ( '{' | '}' | '\\\"' | '\\'' ) )* '}' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start CODE_BLOCK @@ -2541,8 +2541,8 @@ _type = CODE_BLOCK; - // /Users/bion/projects/iordache/translator/pnscript.g:544:2: ( '{' ( CODE_BLOCK | STRING | ~ ( '{' | '}' | '\\\"' | '\\'' ) )* '}' ) - // /Users/bion/projects/iordache/translator/pnscript.g:544:4: '{' ( CODE_BLOCK | STRING | ~ ( '{' | '}' | '\\\"' | '\\'' ) )* '}' + // /Users/bion/projects/iordache/translator/pnscript.g:543:2: ( '{' ( CODE_BLOCK | STRING | ~ ( '{' | '}' | '\\\"' | '\\'' ) )* '}' ) + // /Users/bion/projects/iordache/translator/pnscript.g:543:4: '{' ( CODE_BLOCK | STRING | ~ ( '{' | '}' | '\\\"' | '\\'' ) )* '}' { MATCHC('{'); if (HASEXCEPTION()) @@ -2551,7 +2551,7 @@ } - // /Users/bion/projects/iordache/translator/pnscript.g:544:8: ( CODE_BLOCK | STRING | ~ ( '{' | '}' | '\\\"' | '\\'' ) )* + // /Users/bion/projects/iordache/translator/pnscript.g:543:8: ( CODE_BLOCK | STRING | ~ ( '{' | '}' | '\\\"' | '\\'' ) )* for (;;) { @@ -2577,9 +2577,9 @@ switch (alt5) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:544:10: CODE_BLOCK + // /Users/bion/projects/iordache/translator/pnscript.g:543:10: CODE_BLOCK { - /* 544:10: CODE_BLOCK */ + /* 543:10: CODE_BLOCK */ mCODE_BLOCK(ctx ); if (HASEXCEPTION()) { @@ -2590,9 +2590,9 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pnscript.g:544:23: STRING + // /Users/bion/projects/iordache/translator/pnscript.g:543:23: STRING { - /* 544:23: STRING */ + /* 543:23: STRING */ mSTRING(ctx ); if (HASEXCEPTION()) { @@ -2603,7 +2603,7 @@ } break; case 3: - // /Users/bion/projects/iordache/translator/pnscript.g:544:32: ~ ( '{' | '}' | '\\\"' | '\\'' ) + // /Users/bion/projects/iordache/translator/pnscript.g:543:32: ~ ( '{' | '}' | '\\\"' | '\\'' ) { if ( ((LA(1) >= 0x0000) && (LA(1) <= '!')) || ((LA(1) >= '#') && (LA(1) <= '&')) || ((LA(1) >= '(') && (LA(1) <= 'z')) || LA(1) == '|' || ((LA(1) >= '~') && (LA(1) <= 0xFFFF)) ) { @@ -2649,7 +2649,7 @@ } // $ANTLR end CODE_BLOCK -// Comes from: 547:2: ( '\\'' ( CHAR_ESC | ~ ( '\\\\' | '\\'' ) )* '\\'' | '\\\"' ( CHAR_ESC | ~ ( '\\\\' | '\\\"' ) )* '\\\"' ) +// Comes from: 546:2: ( '\\'' ( CHAR_ESC | ~ ( '\\\\' | '\\'' ) )* '\\'' | '\\\"' ( CHAR_ESC | ~ ( '\\\\' | '\\\"' ) )* '\\\"' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start STRING @@ -2670,7 +2670,7 @@ { - // /Users/bion/projects/iordache/translator/pnscript.g:547:2: ( '\\'' ( CHAR_ESC | ~ ( '\\\\' | '\\'' ) )* '\\'' | '\\\"' ( CHAR_ESC | ~ ( '\\\\' | '\\\"' ) )* '\\\"' ) + // /Users/bion/projects/iordache/translator/pnscript.g:546:2: ( '\\'' ( CHAR_ESC | ~ ( '\\\\' | '\\'' ) )* '\\'' | '\\\"' ( CHAR_ESC | ~ ( '\\\\' | '\\\"' ) )* '\\\"' ) ANTLR3_UINT32 alt8; @@ -2703,7 +2703,7 @@ switch (alt8) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:547:4: '\\'' ( CHAR_ESC | ~ ( '\\\\' | '\\'' ) )* '\\'' + // /Users/bion/projects/iordache/translator/pnscript.g:546:4: '\\'' ( CHAR_ESC | ~ ( '\\\\' | '\\'' ) )* '\\'' { MATCHC('\''); if (HASEXCEPTION()) @@ -2712,7 +2712,7 @@ } - // /Users/bion/projects/iordache/translator/pnscript.g:547:9: ( CHAR_ESC | ~ ( '\\\\' | '\\'' ) )* + // /Users/bion/projects/iordache/translator/pnscript.g:546:9: ( CHAR_ESC | ~ ( '\\\\' | '\\'' ) )* for (;;) { @@ -2734,9 +2734,9 @@ switch (alt6) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:547:10: CHAR_ESC + // /Users/bion/projects/iordache/translator/pnscript.g:546:10: CHAR_ESC { - /* 547:10: CHAR_ESC */ + /* 546:10: CHAR_ESC */ mCHAR_ESC(ctx ); if (HASEXCEPTION()) { @@ -2747,7 +2747,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pnscript.g:547:19: ~ ( '\\\\' | '\\'' ) + // /Users/bion/projects/iordache/translator/pnscript.g:546:19: ~ ( '\\\\' | '\\'' ) { if ( ((LA(1) >= 0x0000) && (LA(1) <= '&')) || ((LA(1) >= '(') && (LA(1) <= '[')) || ((LA(1) >= ']') && (LA(1) <= 0xFFFF)) ) { @@ -2784,7 +2784,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pnscript.g:548:4: '\\\"' ( CHAR_ESC | ~ ( '\\\\' | '\\\"' ) )* '\\\"' + // /Users/bion/projects/iordache/translator/pnscript.g:547:4: '\\\"' ( CHAR_ESC | ~ ( '\\\\' | '\\\"' ) )* '\\\"' { MATCHC('\"'); if (HASEXCEPTION()) @@ -2793,7 +2793,7 @@ } - // /Users/bion/projects/iordache/translator/pnscript.g:548:9: ( CHAR_ESC | ~ ( '\\\\' | '\\\"' ) )* + // /Users/bion/projects/iordache/translator/pnscript.g:547:9: ( CHAR_ESC | ~ ( '\\\\' | '\\\"' ) )* for (;;) { @@ -2815,9 +2815,9 @@ switch (alt7) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:548:10: CHAR_ESC + // /Users/bion/projects/iordache/translator/pnscript.g:547:10: CHAR_ESC { - /* 548:10: CHAR_ESC */ + /* 547:10: CHAR_ESC */ mCHAR_ESC(ctx ); if (HASEXCEPTION()) { @@ -2828,7 +2828,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pnscript.g:548:19: ~ ( '\\\\' | '\\\"' ) + // /Users/bion/projects/iordache/translator/pnscript.g:547:19: ~ ( '\\\\' | '\\\"' ) { if ( ((LA(1) >= 0x0000) && (LA(1) <= '!')) || ((LA(1) >= '#') && (LA(1) <= '[')) || ((LA(1) >= ']') && (LA(1) <= 0xFFFF)) ) { @@ -2877,7 +2877,7 @@ } // $ANTLR end STRING -// Comes from: 550:2: ( '\\\\\\'' | '\\\\\\\"' | '\\\\' ~ ( '\\'' | '\\\"' ) ) +// Comes from: 549:2: ( '\\\\\\'' | '\\\\\\\"' | '\\\\' ~ ( '\\'' | '\\\"' ) ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start CHAR_ESC @@ -2898,7 +2898,7 @@ { - // /Users/bion/projects/iordache/translator/pnscript.g:550:2: ( '\\\\\\'' | '\\\\\\\"' | '\\\\' ~ ( '\\'' | '\\\"' ) ) + // /Users/bion/projects/iordache/translator/pnscript.g:549:2: ( '\\\\\\'' | '\\\\\\\"' | '\\\\' ~ ( '\\'' | '\\\"' ) ) ANTLR3_UINT32 alt9; @@ -2954,7 +2954,7 @@ switch (alt9) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:550:4: '\\\\\\'' + // /Users/bion/projects/iordache/translator/pnscript.g:549:4: '\\\\\\'' { MATCHS(lit_33); if (HASEXCEPTION()) @@ -2967,7 +2967,7 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pnscript.g:551:4: '\\\\\\\"' + // /Users/bion/projects/iordache/translator/pnscript.g:550:4: '\\\\\\\"' { MATCHS(lit_34); if (HASEXCEPTION()) @@ -2980,7 +2980,7 @@ } break; case 3: - // /Users/bion/projects/iordache/translator/pnscript.g:552:4: '\\\\' ~ ( '\\'' | '\\\"' ) + // /Users/bion/projects/iordache/translator/pnscript.g:551:4: '\\\\' ~ ( '\\'' | '\\\"' ) { MATCHC('\\'); if (HASEXCEPTION()) @@ -3018,7 +3018,7 @@ } // $ANTLR end CHAR_ESC -// Comes from: 555:2: ( '.' ) +// Comes from: 554:2: ( '.' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start DOT @@ -3038,8 +3038,8 @@ _type = DOT; - // /Users/bion/projects/iordache/translator/pnscript.g:555:2: ( '.' ) - // /Users/bion/projects/iordache/translator/pnscript.g:555:4: '.' + // /Users/bion/projects/iordache/translator/pnscript.g:554:2: ( '.' ) + // /Users/bion/projects/iordache/translator/pnscript.g:554:4: '.' { MATCHC('.'); if (HASEXCEPTION()) @@ -3060,7 +3060,7 @@ } // $ANTLR end DOT -// Comes from: 557:2: ( '+' ) +// Comes from: 556:2: ( '+' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start PLUS @@ -3080,8 +3080,8 @@ _type = PLUS; - // /Users/bion/projects/iordache/translator/pnscript.g:557:2: ( '+' ) - // /Users/bion/projects/iordache/translator/pnscript.g:557:4: '+' + // /Users/bion/projects/iordache/translator/pnscript.g:556:2: ( '+' ) + // /Users/bion/projects/iordache/translator/pnscript.g:556:4: '+' { MATCHC('+'); if (HASEXCEPTION()) @@ -3102,7 +3102,7 @@ } // $ANTLR end PLUS -// Comes from: 559:2: ( '-' ) +// Comes from: 558:2: ( '-' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start MINUS @@ -3122,8 +3122,8 @@ _type = MINUS; - // /Users/bion/projects/iordache/translator/pnscript.g:559:2: ( '-' ) - // /Users/bion/projects/iordache/translator/pnscript.g:559:4: '-' + // /Users/bion/projects/iordache/translator/pnscript.g:558:2: ( '-' ) + // /Users/bion/projects/iordache/translator/pnscript.g:558:4: '-' { MATCHC('-'); if (HASEXCEPTION()) @@ -3144,7 +3144,7 @@ } // $ANTLR end MINUS -// Comes from: 561:2: ( ( '0' .. '9' )+ ) +// Comes from: 560:2: ( ( '0' .. '9' )+ ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start INT @@ -3164,10 +3164,10 @@ _type = INT; - // /Users/bion/projects/iordache/translator/pnscript.g:561:2: ( ( '0' .. '9' )+ ) - // /Users/bion/projects/iordache/translator/pnscript.g:561:5: ( '0' .. '9' )+ + // /Users/bion/projects/iordache/translator/pnscript.g:560:2: ( ( '0' .. '9' )+ ) + // /Users/bion/projects/iordache/translator/pnscript.g:560:5: ( '0' .. '9' )+ { - // /Users/bion/projects/iordache/translator/pnscript.g:561:5: ( '0' .. '9' )+ + // /Users/bion/projects/iordache/translator/pnscript.g:560:5: ( '0' .. '9' )+ { int cnt10=0; @@ -3187,7 +3187,7 @@ switch (alt10) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:561:5: '0' .. '9' + // /Users/bion/projects/iordache/translator/pnscript.g:560:5: '0' .. '9' { MATCHRANGE('0', '9'); if (HASEXCEPTION()) @@ -3231,7 +3231,7 @@ } // $ANTLR end INT -// Comes from: 563:2: ( ( 'A' .. 'Z' | 'a' .. 'z' ) ( 'A' .. 'Z' | 'a' .. 'z' | '0' .. '9' | '_' )* ) +// Comes from: 562:2: ( ( 'A' .. 'Z' | 'a' .. 'z' ) ( 'A' .. 'Z' | 'a' .. 'z' | '0' .. '9' | '_' )* ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start ID @@ -3251,8 +3251,8 @@ _type = ID; - // /Users/bion/projects/iordache/translator/pnscript.g:563:2: ( ( 'A' .. 'Z' | 'a' .. 'z' ) ( 'A' .. 'Z' | 'a' .. 'z' | '0' .. '9' | '_' )* ) - // /Users/bion/projects/iordache/translator/pnscript.g:563:4: ( 'A' .. 'Z' | 'a' .. 'z' ) ( 'A' .. 'Z' | 'a' .. 'z' | '0' .. '9' | '_' )* + // /Users/bion/projects/iordache/translator/pnscript.g:562:2: ( ( 'A' .. 'Z' | 'a' .. 'z' ) ( 'A' .. 'Z' | 'a' .. 'z' | '0' .. '9' | '_' )* ) + // /Users/bion/projects/iordache/translator/pnscript.g:562:4: ( 'A' .. 'Z' | 'a' .. 'z' ) ( 'A' .. 'Z' | 'a' .. 'z' | '0' .. '9' | '_' )* { if ( ((LA(1) >= 'A') && (LA(1) <= 'Z')) || ((LA(1) >= 'a') && (LA(1) <= 'z')) ) { @@ -3269,7 +3269,7 @@ } - // /Users/bion/projects/iordache/translator/pnscript.g:563:24: ( 'A' .. 'Z' | 'a' .. 'z' | '0' .. '9' | '_' )* + // /Users/bion/projects/iordache/translator/pnscript.g:562:24: ( 'A' .. 'Z' | 'a' .. 'z' | '0' .. '9' | '_' )* for (;;) { @@ -3327,7 +3327,7 @@ } // $ANTLR end ID -// Comes from: 567:2: ( ( ';' )+ ) +// Comes from: 566:2: ( ( ';' )+ ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start END @@ -3347,10 +3347,10 @@ _type = END; - // /Users/bion/projects/iordache/translator/pnscript.g:567:2: ( ( ';' )+ ) - // /Users/bion/projects/iordache/translator/pnscript.g:567:4: ( ';' )+ + // /Users/bion/projects/iordache/translator/pnscript.g:566:2: ( ( ';' )+ ) + // /Users/bion/projects/iordache/translator/pnscript.g:566:4: ( ';' )+ { - // /Users/bion/projects/iordache/translator/pnscript.g:567:4: ( ';' )+ + // /Users/bion/projects/iordache/translator/pnscript.g:566:4: ( ';' )+ { int cnt12=0; @@ -3370,7 +3370,7 @@ switch (alt12) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:567:4: ';' + // /Users/bion/projects/iordache/translator/pnscript.g:566:4: ';' { MATCHC(';'); if (HASEXCEPTION()) @@ -3414,7 +3414,7 @@ } // $ANTLR end END -// Comes from: 571:2: ( ( ' ' | '\\t' | '\\r' | '\\n' )+ ) +// Comes from: 570:2: ( ( ' ' | '\\t' | '\\r' | '\\n' )+ ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start WS @@ -3434,10 +3434,10 @@ _type = WS; - // /Users/bion/projects/iordache/translator/pnscript.g:571:2: ( ( ' ' | '\\t' | '\\r' | '\\n' )+ ) - // /Users/bion/projects/iordache/translator/pnscript.g:571:5: ( ' ' | '\\t' | '\\r' | '\\n' )+ + // /Users/bion/projects/iordache/translator/pnscript.g:570:2: ( ( ' ' | '\\t' | '\\r' | '\\n' )+ ) + // /Users/bion/projects/iordache/translator/pnscript.g:570:5: ( ' ' | '\\t' | '\\r' | '\\n' )+ { - // /Users/bion/projects/iordache/translator/pnscript.g:571:5: ( ' ' | '\\t' | '\\r' | '\\n' )+ + // /Users/bion/projects/iordache/translator/pnscript.g:570:5: ( ' ' | '\\t' | '\\r' | '\\n' )+ { int cnt13=0; @@ -3512,7 +3512,7 @@ } // $ANTLR end WS -// Comes from: 574:2: ( '//' ( . )* '\\n' ) +// Comes from: 573:2: ( '//' ( . )* '\\n' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start COMMENT @@ -3532,8 +3532,8 @@ _type = COMMENT; - // /Users/bion/projects/iordache/translator/pnscript.g:574:2: ( '//' ( . )* '\\n' ) - // /Users/bion/projects/iordache/translator/pnscript.g:574:5: '//' ( . )* '\\n' + // /Users/bion/projects/iordache/translator/pnscript.g:573:2: ( '//' ( . )* '\\n' ) + // /Users/bion/projects/iordache/translator/pnscript.g:573:5: '//' ( . )* '\\n' { MATCHS(lit_35); if (HASEXCEPTION()) @@ -3543,7 +3543,7 @@ - // /Users/bion/projects/iordache/translator/pnscript.g:574:10: ( . )* + // /Users/bion/projects/iordache/translator/pnscript.g:573:10: ( . )* for (;;) { @@ -3565,7 +3565,7 @@ switch (alt14) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:574:10: . + // /Users/bion/projects/iordache/translator/pnscript.g:573:10: . { MATCHANY(); if (HASEXCEPTION()) @@ -3606,7 +3606,7 @@ } // $ANTLR end COMMENT -// Comes from: 577:2: ( '/*' ( . )* '*/' ) +// Comes from: 576:2: ( '/*' ( . )* '*/' ) /** \brief Lexer rule generated by ANTLR3 * * $ANTLR start BLOCK_COMMENT @@ -3626,8 +3626,8 @@ _type = BLOCK_COMMENT; - // /Users/bion/projects/iordache/translator/pnscript.g:577:2: ( '/*' ( . )* '*/' ) - // /Users/bion/projects/iordache/translator/pnscript.g:577:5: '/*' ( . )* '*/' + // /Users/bion/projects/iordache/translator/pnscript.g:576:2: ( '/*' ( . )* '*/' ) + // /Users/bion/projects/iordache/translator/pnscript.g:576:5: '/*' ( . )* '*/' { MATCHS(lit_36); if (HASEXCEPTION()) @@ -3637,7 +3637,7 @@ - // /Users/bion/projects/iordache/translator/pnscript.g:577:10: ( . )* + // /Users/bion/projects/iordache/translator/pnscript.g:576:10: ( . )* for (;;) { @@ -3672,7 +3672,7 @@ switch (alt15) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:577:10: . + // /Users/bion/projects/iordache/translator/pnscript.g:576:10: . { MATCHANY(); if (HASEXCEPTION()) Modified: translator/pnscriptLexer.h =================================================================== --- translator/pnscriptLexer.h 2009-06-18 18:02:49 UTC (rev 70) +++ translator/pnscriptLexer.h 2009-06-18 19:10:10 UTC (rev 71) @@ -2,7 +2,7 @@ * This C header file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pnscript.g - * - On : 2009-06-18 12:45:21 + * - On : 2009-06-18 14:09:04 * - for the lexer : pnscriptLexerLexer * * Editing it, at least manually, is not wise. * Modified: translator/pnscriptParser.c =================================================================== --- translator/pnscriptParser.c 2009-06-18 18:02:49 UTC (rev 70) +++ translator/pnscriptParser.c 2009-06-18 19:10:10 UTC (rev 71) @@ -2,7 +2,7 @@ * This C source file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pnscript.g - * - On : 2009-06-18 12:45:21 + * - On : 2009-06-18 14:09:03 * - for the parser : pnscriptParserParser * * Editing it, at least manually, is not wise. * @@ -1919,7 +1919,7 @@ /* AST REWRITE - * elements : ID, EXTERN + * elements : EXTERN, ID * token labels : * rule labels : retval * token list labels : @@ -2822,7 +2822,7 @@ /* AST REWRITE - * elements : PLACES, ID + * elements : ID, PLACES * token labels : * rule labels : retval * token list labels : @@ -3026,7 +3026,7 @@ /* AST REWRITE - * elements : ID, TRANS + * elements : TRANS, ID * token labels : * rule labels : retval * token list labels : @@ -3463,7 +3463,6 @@ //silly user! We'll try to help them out here... addTrans( (SCOPE_TOP(proc_definitions))->trans, t->getText(t)->chars); } - printf("p = %s\n", (p->getText(p))->chars); } @@ -3510,9 +3509,9 @@ root_0 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR)); retval.tree = root_0; - // 208:8: -> ^( FROM[$p, $p.text->chars] ( $t)+ ) + // 207:8: -> ^( FROM[$p, $p.text->chars] ( $t)+ ) { - // /Users/bion/projects/iordache/translator/pnscript.g:208:11: ^( FROM[$p, $p.text->chars] ( $t)+ ) + // /Users/bion/projects/iordache/translator/pnscript.g:207:11: ^( FROM[$p, $p.text->chars] ( $t)+ ) { pANTLR3_BASE_TREE root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR)); root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->becomeRoot(ADAPTOR, @@ -3552,10 +3551,10 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pnscript.g:209:4: (p= ID '*:' (t+= ID )+ ) + // /Users/bion/projects/iordache/translator/pnscript.g:208:4: (p= ID '*:' (t+= ID )+ ) { - // /Users/bion/projects/iordache/translator/pnscript.g:209:4: (p= ID '*:' (t+= ID )+ ) - // /Users/bion/projects/iordache/translator/pnscript.g:209:5: p= ID '*:' (t+= ID )+ + // /Users/bion/projects/iordache/translator/pnscript.g:208:4: (p= ID '*:' (t+= ID )+ ) + // /Users/bion/projects/iordache/translator/pnscript.g:208:5: p= ID '*:' (t+= ID )+ { p = (pANTLR3_COMMON_TOKEN) MATCHT(ID, &FOLLOW_ID_in_extern_trans_def373); if (HASEXCEPTION()) @@ -3583,7 +3582,7 @@ CREATE_stream_40; stream_40->add(stream_40, string_literal39, NULL); - // /Users/bion/projects/iordache/translator/pnscript.g:216:10: (t+= ID )+ + // /Users/bion/projects/iordache/translator/pnscript.g:215:10: (t+= ID )+ { int cnt17=0; @@ -3603,7 +3602,7 @@ switch (alt17) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:216:11: t+= ID + // /Users/bion/projects/iordache/translator/pnscript.g:215:11: t+= ID { t = (pANTLR3_COMMON_TOKEN) MATCHT(ID, &FOLLOW_ID_in_extern_trans_def382); if (HASEXCEPTION()) @@ -3672,9 +3671,9 @@ root_0 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR)); retval.tree = root_0; - // 223:8: -> ^( TO[$p, $p.text->chars] ( $t)+ ) + // 222:8: -> ^( TO[$p, $p.text->chars] ( $t)+ ) { - // /Users/bion/projects/iordache/translator/pnscript.g:223:11: ^( TO[$p, $p.text->chars] ( $t)+ ) + // /Users/bion/projects/iordache/translator/pnscript.g:222:11: ^( TO[$p, $p.text->chars] ( $t)+ ) { pANTLR3_BASE_TREE root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR)); root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->becomeRoot(ADAPTOR, @@ -3746,7 +3745,7 @@ /** * $ANTLR start trans_def - * /Users/bion/projects/iordache/translator/pnscript.g:224:1: trans_def : ( ( ID CODE CODE_BLOCK -> ^( ID CODE_BLOCK ) ) | (start= '(' items+= ID ( ',' items+= ID )+ ')' ( DOT CODE_BLOCK )? -> {place != NULL}? ^( ID[tran, tran->getText(tran)->chars] ^( ID[place, place->getText(place)->chars] ( $items)+ ( CODE_BLOCK )? ) ) -> ^( ID[tran, tran->getText(tran)->chars] ( $items)+ ( CODE_BLOCK )? ) ) ); + * /Users/bion/projects/iordache/translator/pnscript.g:223:1: trans_def : ( ( ID CODE CODE_BLOCK -> ^( ID CODE_BLOCK ) ) | (start= '(' items+= ID ( ',' items+= ID )+ ')' ( DOT CODE_BLOCK )? -> {place != NULL}? ^( ID[tran, tran->getText(tran)->chars] ^( ID[place, place->getText(place)->chars] ( $items)+ ( CODE_BLOCK )? ) ) -> ^( ID[tran, tran->getText(tran)->chars] ( $items)+ ( CODE_BLOCK )? ) ) ); */ static pnscriptParser_trans_def_return trans_def(ppnscriptParser ctx) @@ -3835,7 +3834,7 @@ retval.tree = NULL; { { - // /Users/bion/projects/iordache/translator/pnscript.g:231:2: ( ( ID CODE CODE_BLOCK -> ^( ID CODE_BLOCK ) ) | (start= '(' items+= ID ( ',' items+= ID )+ ')' ( DOT CODE_BLOCK )? -> {place != NULL}? ^( ID[tran, tran->getText(tran)->chars] ^( ID[place, place->getText(place)->chars] ( $items)+ ( CODE_BLOCK )? ) ) -> ^( ID[tran, tran->getText(tran)->chars] ( $items)+ ( CODE_BLOCK )? ) ) ) + // /Users/bion/projects/iordache/translator/pnscript.g:230:2: ( ( ID CODE CODE_BLOCK -> ^( ID CODE_BLOCK ) ) | (start= '(' items+= ID ( ',' items+= ID )+ ')' ( DOT CODE_BLOCK )? -> {place != NULL}? ^( ID[tran, tran->getText(tran)->chars] ^( ID[place, place->getText(place)->chars] ( $items)+ ( CODE_BLOCK )? ) ) -> ^( ID[tran, tran->getText(tran)->chars] ( $items)+ ( CODE_BLOCK )? ) ) ) ANTLR3_UINT32 alt21; @@ -3868,10 +3867,10 @@ switch (alt21) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:231:4: ( ID CODE CODE_BLOCK -> ^( ID CODE_BLOCK ) ) + // /Users/bion/projects/iordache/translator/pnscript.g:230:4: ( ID CODE CODE_BLOCK -> ^( ID CODE_BLOCK ) ) { - // /Users/bion/projects/iordache/translator/pnscript.g:231:4: ( ID CODE CODE_BLOCK -> ^( ID CODE_BLOCK ) ) - // /Users/bion/projects/iordache/translator/pnscript.g:231:5: ID CODE CODE_BLOCK + // /Users/bion/projects/iordache/translator/pnscript.g:230:4: ( ID CODE CODE_BLOCK -> ^( ID CODE_BLOCK ) ) + // /Users/bion/projects/iordache/translator/pnscript.g:230:5: ID CODE CODE_BLOCK { ID40 = (pANTLR3_COMMON_TOKEN) MATCHT(ID, &FOLLOW_ID_in_trans_def413); if (HASEXCEPTION()) @@ -3910,7 +3909,7 @@ /* AST REWRITE - * elements : ID, CODE_BLOCK + * elements : CODE_BLOCK, ID * token labels : * rule labels : retval * token list labels : @@ -3923,9 +3922,9 @@ root_0 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR)); retval.tree = root_0; - // 238:21: -> ^( ID CODE_BLOCK ) + // 237:21: -> ^( ID CODE_BLOCK ) { - // /Users/bion/projects/iordache/translator/pnscript.g:238:24: ^( ID CODE_BLOCK ) + // /Users/bion/projects/iordache/translator/pnscript.g:237:24: ^( ID CODE_BLOCK ) { pANTLR3_BASE_TREE root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR)); root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->becomeRoot(ADAPTOR, stream_ID == NULL ? NULL : stream_ID->nextNode(stream_ID), root_1)); @@ -3948,10 +3947,10 @@ } break; case 2: - // /Users/bion/projects/iordache/translator/pnscript.g:239:4: (start= '(' items+= ID ( ',' items+= ID )+ ')' ( DOT CODE_BLOCK )? -> {place != NULL}? ^( ID[tran, tran->getText(tran)->chars] ^( ID[place, place->getText(place)->chars] ( $items)+ ( CODE_BLOCK )? ) ) -> ^( ID[tran, tran->getText(tran)->chars] ( $items)+ ( CODE_BLOCK )? ) ) + // /Users/bion/projects/iordache/translator/pnscript.g:238:4: (start= '(' items+= ID ( ',' items+= ID )+ ')' ( DOT CODE_BLOCK )? -> {place != NULL}? ^( ID[tran, tran->getText(tran)->chars] ^( ID[place, place->getText(place)->chars] ( $items)+ ( CODE_BLOCK )? ) ) -> ^( ID[tran, tran->getText(tran)->chars] ( $items)+ ( CODE_BLOCK )? ) ) { - // /Users/bion/projects/iordache/translator/pnscript.g:239:4: (start= '(' items+= ID ( ',' items+= ID )+ ')' ( DOT CODE_BLOCK )? -> {place != NULL}? ^( ID[tran, tran->getText(tran)->chars] ^( ID[place, place->getText(place)->chars] ( $items)+ ( CODE_BLOCK )? ) ) -> ^( ID[tran, tran->getText(tran)->chars] ( $items)+ ( CODE_BLOCK )? ) ) - // /Users/bion/projects/iordache/translator/pnscript.g:239:5: start= '(' items+= ID ( ',' items+= ID )+ ')' ( DOT CODE_BLOCK )? + // /Users/bion/projects/iordache/translator/pnscript.g:238:4: (start= '(' items+= ID ( ',' items+= ID )+ ')' ( DOT CODE_BLOCK )? -> {place != NULL}? ^( ID[tran, tran->getText(tran)->chars] ^( ID[place, place->getText(place)->chars] ( $items)+ ( CODE_BLOCK )? ) ) -> ^( ID[tran, tran->getText(tran)->chars] ( $items)+ ( CODE_BLOCK )? ) ) + // /Users/bion/projects/iordache/translator/pnscript.g:238:5: start= '(' items+= ID ( ',' items+= ID )+ ')' ( DOT CODE_BLOCK )? { start = (pANTLR3_COMMON_TOKEN) MATCHT(41, &FOLLOW_41_in_trans_def436); if (HASEXCEPTION()) @@ -3974,7 +3973,7 @@ list_items=ctx->vectors->newVector(ctx->vectors); } list_items->add(list_items, items, NULL); - // /Users/bion/projects/iordache/translator/pnscript.g:239:25: ( ',' items+= ID )+ + // /Users/bion/projects/iordache/translator/pnscript.g:238:25: ( ',' items+= ID )+ { int cnt19=0; @@ -3994,7 +3993,7 @@ switch (alt19) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:239:26: ',' items+= ID + // /Users/bion/projects/iordache/translator/pnscript.g:238:26: ',' items+= ID { char_literal43 = (pANTLR3_COMMON_TOKEN) MATCHT(42, &FOLLOW_42_in_trans_def443); if (HASEXCEPTION()) @@ -4074,7 +4073,7 @@ } - // /Users/bion/projects/iordache/translator/pnscript.g:261:5: ( DOT CODE_BLOCK )? + // /Users/bion/projects/iordache/translator/pnscript.g:260:5: ( DOT CODE_BLOCK )? { int alt20=2; { @@ -4087,7 +4086,7 @@ switch (alt20) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:261:6: DOT CODE_BLOCK + // /Users/bion/projects/iordache/translator/pnscript.g:260:6: DOT CODE_BLOCK { DOT45 = (pANTLR3_COMMON_TOKEN) MATCHT(DOT, &FOLLOW_DOT_in_trans_def456); if (HASEXCEPTION()) @@ -4114,7 +4113,7 @@ /* AST REWRITE - * elements : CODE_BLOCK, ID, ID, CODE_BLOCK, items, ID, items + * elements : items, ID, ID, CODE_BLOCK, CODE_BLOCK, ID, items * token labels : * rule labels : retval * token list labels : items @@ -4129,10 +4128,10 @@ root_0 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR)); retval.tree = root_0; - // 261:23: -> {place != NULL}? ^( ID[tran, tran->getText(tran)->chars] ^( ID[place, place->getText(place)->chars] ( $items)+ ( CODE_BLOCK )? ) ) + // 260:23: -> {place != NULL}? ^( ID[tran, tran->getText(tran)->chars] ^( ID[place, place->getText(place)->chars] ( $items)+ ( CODE_BLOCK )? ) ) if (place != NULL) { - // /Users/bion/projects/iordache/translator/pnscript.g:261:43: ^( ID[tran, tran->getText(tran)->chars] ^( ID[place, place->getText(place)->chars] ( $items)+ ( CODE_BLOCK )? ) ) + // /Users/bion/projects/iordache/translator/pnscript.g:260:43: ^( ID[tran, tran->getText(tran)->chars] ^( ID[place, place->getText(place)->chars] ( $items)+ ( CODE_BLOCK )? ) ) { pANTLR3_BASE_TREE root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR)); root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->becomeRoot(ADAPTOR, @@ -4143,7 +4142,7 @@ #endif , root_1)); - // /Users/bion/projects/iordache/translator/pnscript.g:261:82: ^( ID[place, place->getText(place)->chars] ( $items)+ ( CODE_BLOCK )? ) + // /Users/bion/projects/iordache/translator/pnscript.g:260:82: ^( ID[place, place->getText(place)->chars] ( $items)+ ( CODE_BLOCK )? ) { pANTLR3_BASE_TREE root_2 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR)); root_2 = (pANTLR3_BASE_TREE)(ADAPTOR->becomeRoot(ADAPTOR, @@ -4168,7 +4167,7 @@ } stream_items->reset(stream_items); - }// /Users/bion/projects/iordache/translator/pnscript.g:261:132: ( CODE_BLOCK )? + }// /Users/bion/projects/iordache/translator/pnscript.g:260:132: ( CODE_BLOCK )? { if ( (stream_CODE_BLOCK != NULL && stream_CODE_BLOCK->hasNext(stream_CODE_BLOCK)) ) { @@ -4186,9 +4185,9 @@ } } - else // 262:8: -> ^( ID[tran, tran->getText(tran)->chars] ( $items)+ ( CODE_BLOCK )? ) + else // 261:8: -> ^( ID[tran, tran->getText(tran)->chars] ( $items)+ ( CODE_BLOCK )? ) { - // /Users/bion/projects/iordache/translator/pnscript.g:262:15: ^( ID[tran, tran->getText(tran)->chars] ( $items)+ ( CODE_BLOCK )? ) + // /Users/bion/projects/iordache/translator/pnscript.g:261:15: ^( ID[tran, tran->getText(tran)->chars] ( $items)+ ( CODE_BLOCK )? ) { pANTLR3_BASE_TREE root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR)); root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->becomeRoot(ADAPTOR, @@ -4213,7 +4212,7 @@ } stream_items->reset(stream_items); - }// /Users/bion/projects/iordache/translator/pnscript.g:262:62: ( CODE_BLOCK )? + }// /Users/bion/projects/iordache/translator/pnscript.g:261:62: ( CODE_BLOCK )? { if ( (stream_CODE_BLOCK != NULL && stream_CODE_BLOCK->hasNext(stream_CODE_BLOCK)) ) { @@ -4276,7 +4275,7 @@ /** * $ANTLR start select_functions - * /Users/bion/projects/iordache/translator/pnscript.g:263:1: select_functions : SELECT_DEF ID DOT CODE_BLOCK END -> ^( SELECT_DEF ID CODE_BLOCK ) ; + * /Users/bion/projects/iordache/translator/pnscript.g:262:1: select_functions : SELECT_DEF ID DOT CODE_BLOCK END -> ^( SELECT_DEF ID CODE_BLOCK ) ; */ static pnscriptParser_select_functions_return select_functions(ppnscriptParser ctx) @@ -4334,8 +4333,8 @@ retval.tree = NULL; { - // /Users/bion/projects/iordache/translator/pnscript.g:264:2: ( SELECT_DEF ID DOT CODE_BLOCK END -> ^( SELECT_DEF ID CODE_BLOCK ) ) - // /Users/bion/projects/iordache/translator/pnscript.g:264:4: SELECT_DEF ID DOT CODE_BLOCK END + // /Users/bion/projects/iordache/translator/pnscript.g:263:2: ( SELECT_DEF ID DOT CODE_BLOCK END -> ^( SELECT_DEF ID CODE_BLOCK ) ) + // /Users/bion/projects/iordache/translator/pnscript.g:263:4: SELECT_DEF ID DOT CODE_BLOCK END { SELECT_DEF47 = (pANTLR3_COMMON_TOKEN) MATCHT(SELECT_DEF, &FOLLOW_SELECT_DEF_in_select_functions516); if (HASEXCEPTION()) @@ -4389,7 +4388,7 @@ /* AST REWRITE - * elements : SELECT_DEF, ID, CODE_BLOCK + * elements : ID, SELECT_DEF, CODE_BLOCK * token labels : * rule labels : retval * token list labels : @@ -4402,9 +4401,9 @@ root_0 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR)); retval.tree = root_0; - // 270:24: -> ^( SELECT_DEF ID CODE_BLOCK ) + // 269:24: -> ^( SELECT_DEF ID CODE_BLOCK ) { - // /Users/bion/projects/iordache/translator/pnscript.g:270:27: ^( SELECT_DEF ID CODE_BLOCK ) + // /Users/bion/projects/iordache/translator/pnscript.g:269:27: ^( SELECT_DEF ID CODE_BLOCK ) { pANTLR3_BASE_TREE root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR)); root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->becomeRoot(ADAPTOR, stream_SELECT_DEF == NULL ? NULL : stream_SELECT_DEF->nextNode(stream_SELECT_DEF), root_1)); @@ -4455,7 +4454,7 @@ /** * $ANTLR start nondeterm - * /Users/bion/projects/iordache/translator/pnscript.g:271:1: nondeterm : text= 'nondeterministic places: ' ( ID )+ END -> ^( $text ( ID )+ ) ; + * /Users/bion/projects/iordache/translator/pnscript.g:270:1: nondeterm : text= 'nondeterministic places: ' ( ID )+ END -> ^( $text ( ID )+ ) ; */ static pnscriptParser_nondeterm_return nondeterm(ppnscriptParser ctx) @@ -4499,8 +4498,8 @@ retval.tree = NULL; { - // /Users/bion/projects/iordache/translator/pnscript.g:272:2: (text= 'nondeterministic places: ' ( ID )+ END -> ^( $text ( ID )+ ) ) - // /Users/bion/projects/iordache/translator/pnscript.g:272:4: text= 'nondeterministic places: ' ( ID )+ END + // /Users/bion/projects/iordache/translator/pnscript.g:271:2: (text= 'nondeterministic places: ' ( ID )+ END -> ^( $text ( ID )+ ) ) + // /Users/bion/projects/iordache/translator/pnscript.g:271:4: text= 'nondeterministic places: ' ( ID )+ END { text = (pANTLR3_COMMON_TOKEN) MATCHT(44, &FOLLOW_44_in_nondeterm547); if (HASEXCEPTION()) @@ -4510,7 +4509,7 @@ CREATE_stream_44; stream_44->add(stream_44, text, NULL); - // /Users/bion/projects/iordache/translator/pnscript.g:272:37: ( ID )+ + // /Users/bion/projects/iordache/translator/pnscript.g:271:37: ( ID )+ { int cnt22=0; @@ -4530,7 +4529,7 @@ switch (alt22) { case 1: - // /Users/bion/projects/iordache/translator/pnscript.g:272:38: ID + // /Users/bion/projects/iordache/translator/pnscript.g:271:38: ID { ID52 = (pANTLR3_COMMON_TOKEN) MATCHT(ID, &FOLLOW_ID_in_nondeterm550); if (HASEXCEPTION()) @@ -4599,9 +4598,9 @@ root_0 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR)); retval.tree = root_0; - // 279:11: -> ^( $text ( ID )+ ) + // 278:11: -> ^( $text ( ID )+ ) { - // /Users/bion/projects/iordache/translator/pnscript.g:279:14: ^( $text ( ID )+ ) + // /Users/bion/projects/iordache/translator/pnscript.g:278:14: ^( $text ( ID )+ ) { pANTLR3_BASE_TREE root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->nilNode(ADAPTOR)); root_1 = (pANTLR3_BASE_TREE)(ADAPTOR->becomeRootToken(ADAPTOR, stream_text == NULL ? NULL : stream_text->nextToken(stream_text), root_1)); @@ -4663,7 +4662,7 @@ /** * $ANTLR start proc_instantiations - * /Users/bion/projects/iordache/translator/pnscript.g:283:1: proc_instantiations : ( proc_init | sync_def | proc_start ) END ; + * /Users/bion/projects/iordache/translator/pnscript.g:282:1: proc_instantiations : ( proc_init | sync_def | proc_start ) END ; */ static pnscriptParser_proc_instantiations_return proc_instantiations(ppnscriptParser ctx) @@ -4707,13 +4706,13 @@ retval.tree = NULL; { - // /Users/bion/projects/iordache/translator/pnscript.g:284:2: ( ( proc_init | sync_def | proc_start ) END ) - // /Users/bion/projects/iordache/translator/pnscript.g:284:4: ( proc_init | sync_def | proc_start ) END + // /Users/bion/projects/iordache/translator/pnscript.g:283:2: ( ( proc_init | sync_def | proc_start ) END ) + // /Users/bion/projects/iordache/translator/pnscript.g:283:4: ( proc_init | sync_def | proc_start ) END { root_0 = (pANTLR3_BASE_TREE)(ADAPTOR->ni... [truncated message content] |
From: <the...@us...> - 2009-06-18 18:03:05
|
Revision: 70 http://pntool.svn.sourceforge.net/pntool/?rev=70&view=rev Author: thecodeweasel Date: 2009-06-18 18:02:49 +0000 (Thu, 18 Jun 2009) Log Message: ----------- So, parenthesis... How I hate them. Disambiguated transition arcs for downstream parsers Modified Paths: -------------- translator/pncompactor.c translator/pncompactor.g translator/pncompactor.h translator/pngenerator.c translator/pngenerator.g translator/pngenerator.h translator/pnscript.g translator/pnscriptLexer.c translator/pnscriptLexer.h translator/pnscriptParser.c translator/pnscriptParser.h Modified: translator/pncompactor.c =================================================================== --- translator/pncompactor.c 2009-06-18 03:44:40 UTC (rev 69) +++ translator/pncompactor.c 2009-06-18 18:02:49 UTC (rev 70) @@ -2,7 +2,7 @@ * This C source file was generated by $ANTLR version 3.1.2 * * - From the grammar source file : /Users/bion/projects/iordache/translator/pncompactor.g - * - On : 2009-06-17 18:32:07 + * - On : 2009-06-18 12:48:28 * - for the tree parser : pncompactorTreeParser * * Editing it, at least manually, is not wise. * @@ -344,9 +344,9 @@ // // If the user supplied the scope entries with a free function,then call it first // - if (SCOPE_TOP(constraints)>free != NULL) + if (SCOPE_TOP(constraints)->free != NULL) { - SCOPE_TOP(constraints)>->free(SCOPE_TOP(constraints)); + SCOPE_TOP(constraints)->free(SCOPE_TOP(constraints)); } // Now we decrement the scope's upper limit bound. We do not actually pop the scope as @@ -387,12 +387,12 @@ static pncompactor_group_elements_return group_elements (ppncompactor ctx); static pncompactor_numbered_ID_return numbered_ID (ppncompactor ctx); static ANTLR3_BOOLEAN synpred2_pncompactor (ppncompactor ctx); -static ANTLR3_BOOLEAN synpred26_pncompactor (ppncompactor ctx); -static ANTLR3_BOOLEAN synpred28_pncompactor (ppncompactor ctx); static ANTLR3_BOOLEAN synpred29_pncompactor (ppncompactor ctx); -static ANTLR3_BOOLEAN synpred30_pncompactor (ppncompactor ctx); static ANTLR3_BOOLEAN synpred31_pncompactor (ppncompactor ctx); static ANTLR3_BOOLEAN synpred32_pncompactor (ppncompactor ctx); +static ANTLR3_BOOLEAN synpred33_pncompactor (ppncompactor ctx); +static ANTLR3_BOOLEAN synpred34_pncompactor (ppncompactor ctx); +static ANTLR3_BOOLEAN synpred35_pncompactor (ppncompactor ctx); static void pncompactorFree(ppncompactor ctx); /* For use in tree output where we are accumulating rule labels via label += ruleRef * we need a function that knows how to free a return scope when the list is destroyed. @@ -490,12 +490,12 @@ ctx->group_elements = group_elements; ctx->numbered_ID = numbered_ID; ctx->synpred2_pncompactor = synpred2_pncompactor; - ctx->synpred26_pncompactor = synpred26_pncompactor; - ctx->synpred28_pncompactor = synpred28_pncompactor; ctx->synpred29_pncompactor = synpred29_pncompactor; - ctx->synpred30_pncompactor = synpred30_pncompactor; ctx->synpred31_pncompactor = synpred31_pncompactor; ctx->synpred32_pncompactor = synpred32_pncompactor; + ctx->synpred33_pncompactor = synpred33_pncompactor; + ctx->synpred34_pncompactor = synpred34_pncompactor; + ctx->synpred35_pncompactor = synpred35_pncompactor; ctx->free = pncompactorFree; ctx->getGrammarFileName = getGrammarFileName; @@ -616,246 +616,258 @@ /** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def184 */ static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def184_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def184 = { FOLLOW_CODE_BLOCK_in_trans_def184_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SELECT_DEF_in_select_functions195 */ -static ANTLR3_BITWORD FOLLOW_SELECT_DEF_in_select_functions195_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SELECT_DEF_in_select_functions195 = { FOLLOW_SELECT_DEF_in_select_functions195_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_select_functions197 */ -static ANTLR3_BITWORD FOLLOW_ID_in_select_functions197_bits[] = { ANTLR3_UINT64_LIT(0x0000000000001000) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_select_functions197 = { FOLLOW_ID_in_select_functions197_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_select_functions199 */ -static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_select_functions199_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_select_functions199 = { FOLLOW_CODE_BLOCK_in_select_functions199_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_44_in_nondeterm210 */ -static ANTLR3_BITWORD FOLLOW_44_in_nondeterm210_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_44_in_nondeterm210 = { FOLLOW_44_in_nondeterm210_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_nondeterm212 */ -static ANTLR3_BITWORD FOLLOW_ID_in_nondeterm212_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_nondeterm212 = { FOLLOW_ID_in_nondeterm212_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_init_in_proc_instantiations224 */ -static ANTLR3_BITWORD FOLLOW_proc_init_in_proc_instantiations224_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_init_in_proc_instantiations224 = { FOLLOW_proc_init_in_proc_instantiations224_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_sync_def_in_proc_instantiations228 */ -static ANTLR3_BITWORD FOLLOW_sync_def_in_proc_instantiations228_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_sync_def_in_proc_instantiations228 = { FOLLOW_sync_def_in_proc_instantiations228_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_start_in_proc_instantiations232 */ -static ANTLR3_BITWORD FOLLOW_proc_start_in_proc_instantiations232_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_proc_start_in_proc_instantiations232 = { FOLLOW_proc_start_in_proc_instantiations232_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init242 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_init242_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init242 = { FOLLOW_ID_in_proc_init242_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init244 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_init244_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000200) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init244 = { FOLLOW_ID_in_proc_init244_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_numbered_ID_in_proc_init246 */ -static ANTLR3_BITWORD FOLLOW_numbered_ID_in_proc_init246_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_numbered_ID_in_proc_init246 = { FOLLOW_numbered_ID_in_proc_init246_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_SYNC_TOK_in_sync_def258 */ -static ANTLR3_BITWORD FOLLOW_SYNC_TOK_in_sync_def258_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_SYNC_TOK_in_sync_def258 = { FOLLOW_SYNC_TOK_in_sync_def258_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_sync_def260 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def260_bits[] = { ANTLR3_UINT64_LIT(0x0000000000080208) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_sync_def260 = { FOLLOW_group_elements_in_sync_def260_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start272 */ -static ANTLR3_BITWORD FOLLOW_START_in_proc_start272_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start272 = { FOLLOW_START_in_proc_start272_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start274 */ -static ANTLR3_BITWORD FOLLOW_ID_in_proc_start274_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start274 = { FOLLOW_ID_in_proc_start274_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints291 */ -static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints291_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints291 = { FOLLOW_constraint_block_in_constraints291_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints296 */ -static ANTLR3_BITWORD FOLLOW_eq_in_constraints296_bits[] = { ANTLR3_UINT64_LIT(0x00000001BE8A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints296 = { FOLLOW_eq_in_constraints296_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints302 */ -static ANTLR3_BITWORD FOLLOW_live_def_in_constraints302_bits[] = { ANTLR3_UINT64_LIT(0x0000000180000008) }; -static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints302 = { FOLLOW_live_def_in_constraints302_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints305 */ -static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints305_bits[] = { ANTLR3_UINT64_LIT(0x0000000100000008) }; -static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints305 = { FOLLOW_uncontrol_in_constraints305_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints308 */ -static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints308_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints308 = { FOLLOW_unobserve_in_constraints308_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block318 */ -static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block318_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block318 = { FOLLOW_ID_in_constraint_block318_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq327 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq327_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq327 = { FOLLOW_relationalExpression_in_eq327_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq333 */ -static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq333_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq333 = { FOLLOW_EQS_OP_in_eq333_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq335 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq335_bits[] = { ANTLR3_UINT64_LIT(0x00000001BE8A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq335 = { FOLLOW_eq_in_eq335_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq337 */ -static ANTLR3_BITWORD FOLLOW_eq_in_eq337_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq337 = { FOLLOW_eq_in_eq337_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression353 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression353_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression353 = { FOLLOW_additiveExpression_in_relationalExpression353_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression362 */ -static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression362_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression362 = { FOLLOW_EQ_OP_in_relationalExpression362_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression364 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression364_bits[] = { ANTLR3_UINT64_LIT(0x000000001C8A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression364 = { FOLLOW_relationalExpression_in_relationalExpression364_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression368 */ -static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression368_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression368 = { FOLLOW_relationalExpression_in_relationalExpression368_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression389 */ -static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression389_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression389 = { FOLLOW_primary_in_additiveExpression389_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_PLUS_in_additiveExpression399 */ -static ANTLR3_BITWORD FOLLOW_PLUS_in_additiveExpression399_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_PLUS_in_additiveExpression399 = { FOLLOW_PLUS_in_additiveExpression399_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression403 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression403_bits[] = { ANTLR3_UINT64_LIT(0x00000000188A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression403 = { FOLLOW_additiveExpression_in_additiveExpression403_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def192 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def192_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def192 = { FOLLOW_ID_in_trans_def192_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def195 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def195_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def195 = { FOLLOW_ID_in_trans_def195_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_trans_def197 */ +static ANTLR3_BITWORD FOLLOW_ID_in_trans_def197_bits[] = { ANTLR3_UINT64_LIT(0x0000000000001208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_trans_def197 = { FOLLOW_ID_in_trans_def197_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_trans_def200 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_trans_def200_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_trans_def200 = { FOLLOW_CODE_BLOCK_in_trans_def200_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SELECT_DEF_in_select_functions212 */ +static ANTLR3_BITWORD FOLLOW_SELECT_DEF_in_select_functions212_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SELECT_DEF_in_select_functions212 = { FOLLOW_SELECT_DEF_in_select_functions212_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_select_functions214 */ +static ANTLR3_BITWORD FOLLOW_ID_in_select_functions214_bits[] = { ANTLR3_UINT64_LIT(0x0000000000001000) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_select_functions214 = { FOLLOW_ID_in_select_functions214_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_CODE_BLOCK_in_select_functions216 */ +static ANTLR3_BITWORD FOLLOW_CODE_BLOCK_in_select_functions216_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_CODE_BLOCK_in_select_functions216 = { FOLLOW_CODE_BLOCK_in_select_functions216_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_44_in_nondeterm227 */ +static ANTLR3_BITWORD FOLLOW_44_in_nondeterm227_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_44_in_nondeterm227 = { FOLLOW_44_in_nondeterm227_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_nondeterm229 */ +static ANTLR3_BITWORD FOLLOW_ID_in_nondeterm229_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_nondeterm229 = { FOLLOW_ID_in_nondeterm229_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_init_in_proc_instantiations241 */ +static ANTLR3_BITWORD FOLLOW_proc_init_in_proc_instantiations241_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_init_in_proc_instantiations241 = { FOLLOW_proc_init_in_proc_instantiations241_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_sync_def_in_proc_instantiations245 */ +static ANTLR3_BITWORD FOLLOW_sync_def_in_proc_instantiations245_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_sync_def_in_proc_instantiations245 = { FOLLOW_sync_def_in_proc_instantiations245_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_start_in_proc_instantiations249 */ +static ANTLR3_BITWORD FOLLOW_proc_start_in_proc_instantiations249_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_proc_start_in_proc_instantiations249 = { FOLLOW_proc_start_in_proc_instantiations249_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init259 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_init259_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init259 = { FOLLOW_ID_in_proc_init259_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_init261 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_init261_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000200) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_init261 = { FOLLOW_ID_in_proc_init261_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_numbered_ID_in_proc_init263 */ +static ANTLR3_BITWORD FOLLOW_numbered_ID_in_proc_init263_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_numbered_ID_in_proc_init263 = { FOLLOW_numbered_ID_in_proc_init263_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_SYNC_TOK_in_sync_def275 */ +static ANTLR3_BITWORD FOLLOW_SYNC_TOK_in_sync_def275_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_SYNC_TOK_in_sync_def275 = { FOLLOW_SYNC_TOK_in_sync_def275_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_sync_def277 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_sync_def277_bits[] = { ANTLR3_UINT64_LIT(0x0000000000080208) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_sync_def277 = { FOLLOW_group_elements_in_sync_def277_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_START_in_proc_start289 */ +static ANTLR3_BITWORD FOLLOW_START_in_proc_start289_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_START_in_proc_start289 = { FOLLOW_START_in_proc_start289_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_proc_start291 */ +static ANTLR3_BITWORD FOLLOW_ID_in_proc_start291_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_proc_start291 = { FOLLOW_ID_in_proc_start291_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_constraint_block_in_constraints308 */ +static ANTLR3_BITWORD FOLLOW_constraint_block_in_constraints308_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_constraint_block_in_constraints308 = { FOLLOW_constraint_block_in_constraints308_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_constraints313 */ +static ANTLR3_BITWORD FOLLOW_eq_in_constraints313_bits[] = { ANTLR3_UINT64_LIT(0x00000001BE8A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_constraints313 = { FOLLOW_eq_in_constraints313_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_live_def_in_constraints319 */ +static ANTLR3_BITWORD FOLLOW_live_def_in_constraints319_bits[] = { ANTLR3_UINT64_LIT(0x0000000180000008) }; +static ANTLR3_BITSET_LIST FOLLOW_live_def_in_constraints319 = { FOLLOW_live_def_in_constraints319_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_uncontrol_in_constraints322 */ +static ANTLR3_BITWORD FOLLOW_uncontrol_in_constraints322_bits[] = { ANTLR3_UINT64_LIT(0x0000000100000008) }; +static ANTLR3_BITSET_LIST FOLLOW_uncontrol_in_constraints322 = { FOLLOW_uncontrol_in_constraints322_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_unobserve_in_constraints325 */ +static ANTLR3_BITWORD FOLLOW_unobserve_in_constraints325_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_unobserve_in_constraints325 = { FOLLOW_unobserve_in_constraints325_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_constraint_block335 */ +static ANTLR3_BITWORD FOLLOW_ID_in_constraint_block335_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_constraint_block335 = { FOLLOW_ID_in_constraint_block335_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_eq344 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_eq344_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_eq344 = { FOLLOW_relationalExpression_in_eq344_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQS_OP_in_eq350 */ +static ANTLR3_BITWORD FOLLOW_EQS_OP_in_eq350_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQS_OP_in_eq350 = { FOLLOW_EQS_OP_in_eq350_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq352 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq352_bits[] = { ANTLR3_UINT64_LIT(0x00000001BE8A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq352 = { FOLLOW_eq_in_eq352_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_eq354 */ +static ANTLR3_BITWORD FOLLOW_eq_in_eq354_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_eq354 = { FOLLOW_eq_in_eq354_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_relationalExpression370 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_relationalExpression370_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_relationalExpression370 = { FOLLOW_additiveExpression_in_relationalExpression370_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_EQ_OP_in_relationalExpression379 */ +static ANTLR3_BITWORD FOLLOW_EQ_OP_in_relationalExpression379_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_EQ_OP_in_relationalExpression379 = { FOLLOW_EQ_OP_in_relationalExpression379_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression381 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression381_bits[] = { ANTLR3_UINT64_LIT(0x000000001C8A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression381 = { FOLLOW_relationalExpression_in_relationalExpression381_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_relationalExpression_in_relationalExpression385 */ +static ANTLR3_BITWORD FOLLOW_relationalExpression_in_relationalExpression385_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_relationalExpression_in_relationalExpression385 = { FOLLOW_relationalExpression_in_relationalExpression385_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_additiveExpression406 */ +static ANTLR3_BITWORD FOLLOW_primary_in_additiveExpression406_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_additiveExpression406 = { FOLLOW_primary_in_additiveExpression406_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_PLUS_in_additiveExpression416 */ +static ANTLR3_BITWORD FOLLOW_PLUS_in_additiveExpression416_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_PLUS_in_additiveExpression416 = { FOLLOW_PLUS_in_additiveExpression416_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression420 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression420_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression420_bits[] = { ANTLR3_UINT64_LIT(0x00000000188A0208) }; static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression420 = { FOLLOW_additiveExpression_in_additiveExpression420_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_additiveExpression470 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_additiveExpression470_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_additiveExpression470 = { FOLLOW_MINUS_in_additiveExpression470_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression474 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression474_bits[] = { ANTLR3_UINT64_LIT(0x00000000188A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression474 = { FOLLOW_additiveExpression_in_additiveExpression474_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression490 */ -static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression490_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression490 = { FOLLOW_additiveExpression_in_additiveExpression490_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_primary551 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_primary551_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_primary551 = { FOLLOW_MINUS_in_primary551_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary555 */ -static ANTLR3_BITWORD FOLLOW_eq_in_primary555_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary555 = { FOLLOW_eq_in_primary555_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_primary572 */ -static ANTLR3_BITWORD FOLLOW_ID_in_primary572_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_primary572 = { FOLLOW_ID_in_primary572_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary619 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_primary619_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary619 = { FOLLOW_group_elements_in_primary619_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary660 */ -static ANTLR3_BITWORD FOLLOW_number_in_primary660_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_primary660 = { FOLLOW_number_in_primary660_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary669 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_primary669_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary669 = { FOLLOW_MULT_in_primary669_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary671 */ -static ANTLR3_BITWORD FOLLOW_number_in_primary671_bits[] = { ANTLR3_UINT64_LIT(0x00000000108A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_primary671 = { FOLLOW_number_in_primary671_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary673 */ -static ANTLR3_BITWORD FOLLOW_primary_in_primary673_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary673 = { FOLLOW_primary_in_primary673_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary708 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_primary708_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary708 = { FOLLOW_MULT_in_primary708_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary710 */ -static ANTLR3_BITWORD FOLLOW_number_in_primary710_bits[] = { ANTLR3_UINT64_LIT(0x00000001BE8A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_primary710 = { FOLLOW_number_in_primary710_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary714 */ -static ANTLR3_BITWORD FOLLOW_eq_in_primary714_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary714 = { FOLLOW_eq_in_primary714_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def738 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def738_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def738 = { FOLLOW_LIVE_in_live_def738_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def740 */ -static ANTLR3_BITWORD FOLLOW_ALL_in_live_def740_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def740 = { FOLLOW_ALL_in_live_def740_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def742 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def742_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def742 = { FOLLOW_ID_in_live_def742_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def750 */ -static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def750_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def750 = { FOLLOW_LIVE_in_live_def750_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def752 */ -static ANTLR3_BITWORD FOLLOW_ID_in_live_def752_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def752 = { FOLLOW_ID_in_live_def752_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol764 */ -static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol764_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol764 = { FOLLOW_UNCONTROL_in_uncontrol764_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol766 */ -static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol766_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol766 = { FOLLOW_ID_in_uncontrol766_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve778 */ -static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve778_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve778 = { FOLLOW_UNOBSERVE_in_unobserve778_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve780 */ -static ANTLR3_BITWORD FOLLOW_ID_in_unobserve780_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve780 = { FOLLOW_ID_in_unobserve780_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands792 */ -static ANTLR3_BITWORD FOLLOW_print_in_other_commands792_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands792 = { FOLLOW_print_in_other_commands792_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print802 */ -static ANTLR3_BITWORD FOLLOW_PRINT_in_print802_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print802 = { FOLLOW_PRINT_in_print802_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print804 */ -static ANTLR3_BITWORD FOLLOW_ID_in_print804_bits[] = { ANTLR3_UINT64_LIT(0x0000000000080208) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_print804 = { FOLLOW_ID_in_print804_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print806 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_print806_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print806 = { FOLLOW_group_elements_in_print806_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number825 */ -static ANTLR3_BITWORD FOLLOW_INT_in_number825_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_number825 = { FOLLOW_INT_in_number825_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_number838 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_number838_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_number838 = { FOLLOW_MINUS_in_number838_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number840 */ -static ANTLR3_BITWORD FOLLOW_INT_in_number840_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_number840 = { FOLLOW_INT_in_number840_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements857 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements857_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements857 = { FOLLOW_ID_in_group_elements857_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_DOT_in_group_elements863 */ -static ANTLR3_BITWORD FOLLOW_DOT_in_group_elements863_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_DOT_in_group_elements863 = { FOLLOW_DOT_in_group_elements863_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_group_elements865 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_group_elements865_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000200) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_group_elements865 = { FOLLOW_group_elements_in_group_elements865_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements867 */ -static ANTLR3_BITWORD FOLLOW_ID_in_group_elements867_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements867 = { FOLLOW_ID_in_group_elements867_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID877 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID877_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID877 = { FOLLOW_ID_in_numbered_ID877_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID883 */ -static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID883_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID883 = { FOLLOW_ID_in_numbered_ID883_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID885 */ -static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID885_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID885 = { FOLLOW_INT_in_numbered_ID885_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression437 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression437_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression437 = { FOLLOW_additiveExpression_in_additiveExpression437_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_additiveExpression487 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_additiveExpression487_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_additiveExpression487 = { FOLLOW_MINUS_in_additiveExpression487_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression491 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression491_bits[] = { ANTLR3_UINT64_LIT(0x00000000188A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression491 = { FOLLOW_additiveExpression_in_additiveExpression491_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_additiveExpression_in_additiveExpression507 */ +static ANTLR3_BITWORD FOLLOW_additiveExpression_in_additiveExpression507_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_additiveExpression_in_additiveExpression507 = { FOLLOW_additiveExpression_in_additiveExpression507_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_primary568 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_primary568_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_primary568 = { FOLLOW_MINUS_in_primary568_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary572 */ +static ANTLR3_BITWORD FOLLOW_eq_in_primary572_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary572 = { FOLLOW_eq_in_primary572_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_primary589 */ +static ANTLR3_BITWORD FOLLOW_ID_in_primary589_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_primary589 = { FOLLOW_ID_in_primary589_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_primary636 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_primary636_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_primary636 = { FOLLOW_group_elements_in_primary636_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary677 */ +static ANTLR3_BITWORD FOLLOW_number_in_primary677_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_primary677 = { FOLLOW_number_in_primary677_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary686 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_primary686_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary686 = { FOLLOW_MULT_in_primary686_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary688 */ +static ANTLR3_BITWORD FOLLOW_number_in_primary688_bits[] = { ANTLR3_UINT64_LIT(0x00000000108A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_primary688 = { FOLLOW_number_in_primary688_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_primary690 */ +static ANTLR3_BITWORD FOLLOW_primary_in_primary690_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_primary690 = { FOLLOW_primary_in_primary690_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_primary725 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_primary725_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_primary725 = { FOLLOW_MULT_in_primary725_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_primary727 */ +static ANTLR3_BITWORD FOLLOW_number_in_primary727_bits[] = { ANTLR3_UINT64_LIT(0x00000001BE8A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_primary727 = { FOLLOW_number_in_primary727_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_primary731 */ +static ANTLR3_BITWORD FOLLOW_eq_in_primary731_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_primary731 = { FOLLOW_eq_in_primary731_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def755 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def755_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def755 = { FOLLOW_LIVE_in_live_def755_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ALL_in_live_def757 */ +static ANTLR3_BITWORD FOLLOW_ALL_in_live_def757_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ALL_in_live_def757 = { FOLLOW_ALL_in_live_def757_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def759 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def759_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def759 = { FOLLOW_ID_in_live_def759_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_LIVE_in_live_def767 */ +static ANTLR3_BITWORD FOLLOW_LIVE_in_live_def767_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_LIVE_in_live_def767 = { FOLLOW_LIVE_in_live_def767_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_live_def769 */ +static ANTLR3_BITWORD FOLLOW_ID_in_live_def769_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_live_def769 = { FOLLOW_ID_in_live_def769_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNCONTROL_in_uncontrol781 */ +static ANTLR3_BITWORD FOLLOW_UNCONTROL_in_uncontrol781_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNCONTROL_in_uncontrol781 = { FOLLOW_UNCONTROL_in_uncontrol781_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_uncontrol783 */ +static ANTLR3_BITWORD FOLLOW_ID_in_uncontrol783_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_uncontrol783 = { FOLLOW_ID_in_uncontrol783_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_UNOBSERVE_in_unobserve795 */ +static ANTLR3_BITWORD FOLLOW_UNOBSERVE_in_unobserve795_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_UNOBSERVE_in_unobserve795 = { FOLLOW_UNOBSERVE_in_unobserve795_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_unobserve797 */ +static ANTLR3_BITWORD FOLLOW_ID_in_unobserve797_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_unobserve797 = { FOLLOW_ID_in_unobserve797_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_print_in_other_commands809 */ +static ANTLR3_BITWORD FOLLOW_print_in_other_commands809_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_print_in_other_commands809 = { FOLLOW_print_in_other_commands809_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_PRINT_in_print819 */ +static ANTLR3_BITWORD FOLLOW_PRINT_in_print819_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_PRINT_in_print819 = { FOLLOW_PRINT_in_print819_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_print821 */ +static ANTLR3_BITWORD FOLLOW_ID_in_print821_bits[] = { ANTLR3_UINT64_LIT(0x0000000000080208) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_print821 = { FOLLOW_ID_in_print821_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_print823 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_print823_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_print823 = { FOLLOW_group_elements_in_print823_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number842 */ +static ANTLR3_BITWORD FOLLOW_INT_in_number842_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_number842 = { FOLLOW_INT_in_number842_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_number855 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_number855_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_number855 = { FOLLOW_MINUS_in_number855_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_number857 */ +static ANTLR3_BITWORD FOLLOW_INT_in_number857_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_number857 = { FOLLOW_INT_in_number857_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements874 */ +static ANTLR3_BITWORD FOLLOW_ID_in_group_elements874_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements874 = { FOLLOW_ID_in_group_elements874_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_DOT_in_group_elements880 */ +static ANTLR3_BITWORD FOLLOW_DOT_in_group_elements880_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_DOT_in_group_elements880 = { FOLLOW_DOT_in_group_elements880_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_group_elements882 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_group_elements882_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000200) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_group_elements882 = { FOLLOW_group_elements_in_group_elements882_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_group_elements884 */ +static ANTLR3_BITWORD FOLLOW_ID_in_group_elements884_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_group_elements884 = { FOLLOW_ID_in_group_elements884_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID894 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID894_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID894 = { FOLLOW_ID_in_numbered_ID894_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_numbered_ID900 */ +static ANTLR3_BITWORD FOLLOW_ID_in_numbered_ID900_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_numbered_ID900 = { FOLLOW_ID_in_numbered_ID900_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_INT_in_numbered_ID902 */ +static ANTLR3_BITWORD FOLLOW_INT_in_numbered_ID902_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_INT_in_numbered_ID902 = { FOLLOW_INT_in_numbered_ID902_bits, 1 }; /** Bitset defining follow set for error recovery in rule state: FOLLOW_proc_instantiations_in_synpred2_pncompactor90 */ static ANTLR3_BITWORD FOLLOW_proc_instantiations_in_synpred2_pncompactor90_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; static ANTLR3_BITSET_LIST FOLLOW_proc_instantiations_in_synpred2_pncompactor90 = { FOLLOW_proc_instantiations_in_synpred2_pncompactor90_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred26_pncompactor389 */ -static ANTLR3_BITWORD FOLLOW_primary_in_synpred26_pncompactor389_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred26_pncompactor389 = { FOLLOW_primary_in_synpred26_pncompactor389_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_synpred28_pncompactor551 */ -static ANTLR3_BITWORD FOLLOW_MINUS_in_synpred28_pncompactor551_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_synpred28_pncompactor551 = { FOLLOW_MINUS_in_synpred28_pncompactor551_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_synpred28_pncompactor555 */ -static ANTLR3_BITWORD FOLLOW_eq_in_synpred28_pncompactor555_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_eq_in_synpred28_pncompactor555 = { FOLLOW_eq_in_synpred28_pncompactor555_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_synpred29_pncompactor572 */ -static ANTLR3_BITWORD FOLLOW_ID_in_synpred29_pncompactor572_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_ID_in_synpred29_pncompactor572 = { FOLLOW_ID_in_synpred29_pncompactor572_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_synpred30_pncompactor619 */ -static ANTLR3_BITWORD FOLLOW_group_elements_in_synpred30_pncompactor619_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_synpred30_pncompactor619 = { FOLLOW_group_elements_in_synpred30_pncompactor619_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_synpred31_pncompactor660 */ -static ANTLR3_BITWORD FOLLOW_number_in_synpred31_pncompactor660_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_synpred31_pncompactor660 = { FOLLOW_number_in_synpred31_pncompactor660_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_synpred32_pncompactor669 */ -static ANTLR3_BITWORD FOLLOW_MULT_in_synpred32_pncompactor669_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; -static ANTLR3_BITSET_LIST FOLLOW_MULT_in_synpred32_pncompactor669 = { FOLLOW_MULT_in_synpred32_pncompactor669_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_synpred32_pncompactor671 */ -static ANTLR3_BITWORD FOLLOW_number_in_synpred32_pncompactor671_bits[] = { ANTLR3_UINT64_LIT(0x00000000108A0208) }; -static ANTLR3_BITSET_LIST FOLLOW_number_in_synpred32_pncompactor671 = { FOLLOW_number_in_synpred32_pncompactor671_bits, 1 }; -/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred32_pncompactor673 */ -static ANTLR3_BITWORD FOLLOW_primary_in_synpred32_pncompactor673_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; -static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred32_pncompactor673 = { FOLLOW_primary_in_synpred32_pncompactor673_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred29_pncompactor406 */ +static ANTLR3_BITWORD FOLLOW_primary_in_synpred29_pncompactor406_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred29_pncompactor406 = { FOLLOW_primary_in_synpred29_pncompactor406_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MINUS_in_synpred31_pncompactor568 */ +static ANTLR3_BITWORD FOLLOW_MINUS_in_synpred31_pncompactor568_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MINUS_in_synpred31_pncompactor568 = { FOLLOW_MINUS_in_synpred31_pncompactor568_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_eq_in_synpred31_pncompactor572 */ +static ANTLR3_BITWORD FOLLOW_eq_in_synpred31_pncompactor572_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_eq_in_synpred31_pncompactor572 = { FOLLOW_eq_in_synpred31_pncompactor572_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_ID_in_synpred32_pncompactor589 */ +static ANTLR3_BITWORD FOLLOW_ID_in_synpred32_pncompactor589_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_ID_in_synpred32_pncompactor589 = { FOLLOW_ID_in_synpred32_pncompactor589_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_group_elements_in_synpred33_pncompactor636 */ +static ANTLR3_BITWORD FOLLOW_group_elements_in_synpred33_pncompactor636_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_group_elements_in_synpred33_pncompactor636 = { FOLLOW_group_elements_in_synpred33_pncompactor636_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_synpred34_pncompactor677 */ +static ANTLR3_BITWORD FOLLOW_number_in_synpred34_pncompactor677_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000002) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_synpred34_pncompactor677 = { FOLLOW_number_in_synpred34_pncompactor677_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_MULT_in_synpred35_pncompactor686 */ +static ANTLR3_BITWORD FOLLOW_MULT_in_synpred35_pncompactor686_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000004) }; +static ANTLR3_BITSET_LIST FOLLOW_MULT_in_synpred35_pncompactor686 = { FOLLOW_MULT_in_synpred35_pncompactor686_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_number_in_synpred35_pncompactor688 */ +static ANTLR3_BITWORD FOLLOW_number_in_synpred35_pncompactor688_bits[] = { ANTLR3_UINT64_LIT(0x00000000108A0208) }; +static ANTLR3_BITSET_LIST FOLLOW_number_in_synpred35_pncompactor688 = { FOLLOW_number_in_synpred35_pncompactor688_bits, 1 }; +/** Bitset defining follow set for error recovery in rule state: FOLLOW_primary_in_synpred35_pncompactor690 */ +static ANTLR3_BITWORD FOLLOW_primary_in_synpred35_pncompactor690_bits[] = { ANTLR3_UINT64_LIT(0x0000000000000008) }; +static ANTLR3_BITSET_LIST FOLLOW_primary_in_synpred35_pncompactor690 = { FOLLOW_primary_in_synpred35_pncompactor690_bits, 1 }; @@ -899,8 +911,7 @@ -1, -1, 2, -1, 2, 2, 2, 2, 2, -1, 2, 2 };static const ANTLR3_INT32 dfa2_T1[] = { - 1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 3, 3, -1, -1, -1, -1, -1, - -1, -1, -1, -1, -1, 2 + -1 };static const ANTLR3_INT32 dfa2_T2[] = { 4 @@ -910,11 +921,12 @@ -1, 2, -1, 2, 2, 2, 2, 2, -1, 2, 2 };static const ANTLR3_INT32 dfa2_T4[] = { + 1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, 3, 3, -1, -1, -1, -1, -1, + -1, -1, -1, -1, -1, 2 + };static const ANTLR3_INT32 dfa2_T5[] = + { 2, -1, -1, -1, -1, -1, 5, -1, -1, -1, -1, -1, -1, -1, 2, -1, 2, -1, -1, -1, 2, -1, 2, 2, 2, 2, 2, -1, 2, 2 - };static const ANTLR3_INT32 dfa2_T5[] = - { - -1 }; /* Transition tables are a table of sub tables, with some tables @@ -922,8 +934,8 @@ */ static const ANTLR3_INT32 * const dfa2_transitions[] = { - dfa2_T1, dfa2_T2, dfa2_T_empty, dfa2_T_empty, dfa2_T4, dfa2_T3, dfa2_T0, - dfa2_T5 + dfa2_T4, dfa2_T2, dfa2_T_empty, dfa2_T_empty, dfa2_T5, dfa2_T3, dfa2_T0, + dfa2_T1 }; static ANTLR3_INT32 dfa2_sst(ppncompactor ctx, pANTLR3_BASE_RECOGNIZER recognizer, pANTLR3_INT_STREAM is, pANTLR3_CYCLIC_DFA dfa, ANTLR3_INT32 s) @@ -1005,41 +1017,41 @@ /* End of Cyclic DFA 2 * --------------------- *//** Static dfa state tables for Cyclic dfa: - * 145:1: primary[bool enableAlt] : ( ^( MINUS eq ) -> eq | ID -> {!enableAlt || i == 1}? ID -> ^( MULT[tok2, newVal2] NUM[tok, newVal] ID ) | group_elements -> {!enableAlt || i == 1}? group_elements -> ^( MULT[tok2, newVal2] NUM[tok, newVal] group_elements ) | number | ^( MULT number primary[false] ) -> {$number.value == 0}? -> ^( MULT number primary ) | ^( MULT number eq ) -> {i == 0}? -> eq ); + * 146:1: primary[bool enableAlt] : ( ^( MINUS eq ) -> eq | ID -> {!enableAlt || i == 1}? ID -> ^( MULT[tok2, newVal2] NUM[tok, newVal] ID ) | group_elements -> {!enableAlt || i == 1}? group_elements -> ^( MULT[tok2, newVal2] NUM[tok, newVal] group_elements ) | number | ^( MULT number primary[false] ) -> {$number.value == 0}? -> ^( MULT number primary ) | ^( MULT number eq ) -> {i == 0}? -> eq ); */ -static const ANTLR3_INT32 dfa25_eot[10] = +static const ANTLR3_INT32 dfa27_eot[10] = { -1, -1, -1, -1, -1, -1, -1, -1, -1, -1 }; -static const ANTLR3_INT32 dfa25_eof[10] = +static const ANTLR3_INT32 dfa27_eof[10] = { -1, -1, -1, -1, -1, -1, -1, -1, -1, -1 }; -static const ANTLR3_INT32 dfa25_min[10] = +static const ANTLR3_INT32 dfa27_min[10] = { 9, 0, 0, -1, -1, 0, -1, -1, -1, -1 }; -static const ANTLR3_INT32 dfa25_max[10] = +static const ANTLR3_INT32 dfa27_max[10] = { 28, 0, 0, -1, -1, 0, -1, -1, -1, -1 }; -static const ANTLR3_INT32 dfa25_accept[10] = +static const ANTLR3_INT32 dfa27_accept[10] = { -1, -1, -1, 3, 4, -1, 1, 2, 5, 6 }; -static const ANTLR3_INT32 dfa25_special[10] = +static const ANTLR3_INT32 dfa27_special[10] = { -1, 0, 1, -1, -1, 2, -1, -1, -1, -1 }; /** Used when there is no transition table entry for a particular state */ -#define dfa25_T_empty NULL +#define dfa27_T_empty NULL -static const ANTLR3_INT32 dfa25_T0[] = +static const ANTLR3_INT32 dfa27_T0[] = { 2, -1, -1, -1, -1, -1, -1, -1, 5, -1, 3, -1, -1, -1, 4, -1, -1, -1, -1, 1 - };static const ANTLR3_INT32 dfa25_T1[] = + };static const ANTLR3_INT32 dfa27_T1[] = { -1 }; @@ -1047,13 +1059,13 @@ /* Transition tables are a table of sub tables, with some tables * reused for efficiency. */ -static const ANTLR3_INT32 * const dfa25_transitions[] = +static const ANTLR3_INT32 * const dfa27_transitions[] = { - dfa25_T0, dfa25_T1, dfa25_T1, dfa25_T_empty, dfa25_T_empty, dfa25_T1, - dfa25_T_empty, dfa25_T_empty, dfa25_T_empty, dfa25_T_empty + dfa27_T0, dfa27_T1, dfa27_T1, dfa27_T_empty, dfa27_T_empty, dfa27_T1, + dfa27_T_empty, dfa27_T_empty, dfa27_T_empty, dfa27_T_empty }; -static ANTLR3_INT32 dfa25_sst(ppncompactor ctx, pANTLR3_BASE_RECOGNIZER recognizer, pANTLR3_INT_STREAM is, pANTLR3_CYCLIC_DFA dfa, ANTLR3_INT32 s) +static ANTLR3_INT32 dfa27_sst(ppncompactor ctx, pANTLR3_BASE_RECOGNIZER recognizer, pANTLR3_INT_STREAM is, pANTLR3_CYCLIC_DFA dfa, ANTLR3_INT32 s) { ANTLR3_INT32 _s; @@ -1063,31 +1075,31 @@ case 0: { - ANTLR3_UINT32 LA25_1; + ANTLR3_UINT32 LA27_1... [truncated message content] |