diff --git a/Common/AdaptiveViews.cpp b/Common/AdaptiveViews.cpp new file mode 100644 index 0000000000000000000000000000000000000000..a878bcbcdb8fee2ef696d483c621343524c7b8dc --- /dev/null +++ b/Common/AdaptiveViews.cpp @@ -0,0 +1,252 @@ +// +// Copyright (C) 1997-2004 C. Geuzaine, J.-F. Remacle +// +// This program is free software; you can redistribute it and/or modify +// it under the terms of the GNU General Public License as published by +// the Free Software Foundation; either version 2 of the License, or +// (at your option) any later version. +// +// This program is distributed in the hope that it will be useful, +// but WITHOUT ANY WARRANTY; without even the implied warranty of +// MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +// GNU General Public License for more details. +// +// You should have received a copy of the GNU General Public License +// along with this program; if not, write to the Free Software +// Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA 02111-1307 +// USA. +// +// Please report all bugs and problems to <gmsh@geuz.org>. + +// Don't indent this file +// *INDENT-OFF* + +#include <stdio.h> +#include <math.h> +#include "Views.h" + +void PascalgetIndices(int iFct, int &n, int &i) +{ + int k = 0; + int l = 0; + while(k<=iFct) + { + l++; + k +=l; + }; + n = l - 1; + i = l - k + iFct; +} + + +void Post_Zoom::interpolate ( Double_Matrix *coeffs, double u, double v, double *sf) +{ + // 2 s = (p+1) (p+2) + // p^2 + 3p + 2 = 2s + // p = -3 + sqrt ( 1 + 8 s ) / 2 + int p = (int) ( (-3. + sqrt ( 1 + 8 * coeffs->size2())) / 2); + int nn,ii; + for (int i=0;i<coeffs->size1();++i) + { + sf[i] = 0.0; + for (int j=0;j<coeffs->size2();++j) + { + PascalgetIndices(j,nn,ii); + sf[i] += (*coeffs)(i,j) * pow(u,nn-ii) * pow(v,ii); + } + } +} + +Post_Zoom::Post_Zoom ( int level , Double_Matrix *coeffs) +{ + Points = new Double_Matrix ( (level+1)*(level+2)/2 , 2); + M = new Double_Matrix ( (level+1)*(level+2)/2 , coeffs->size2()); + MGeom = new Double_Matrix ( (level+1)*(level+2)/2 , 3); + int k=0; + double sf[256]; + + for(int i=0;i<=level;i++) + { + for(int j=0;j<=level-i;j++) + { + (*Points) ( k , 0 ) = (double)i / (level); + (*Points) ( k , 1 ) = (double)j / (level); + + // printf ("%d %g %g\n",k,(*Points) ( k , 0 ),(*Points) ( k , 1 )); + + interpolate ( coeffs, (*Points)(k,0),(*Points)(k,1),sf ); + for (int m=0;m<coeffs->size2();++m)(*M)(k,m)=sf[m]; + (*MGeom)(k,0) = 1- (*Points)(k,0)- (*Points)(k,1); + (*MGeom)(k,1) = (*Points)(k,0); + (*MGeom)(k,2) = (*Points)(k,1); + k++; + } + } + Simplices = new Int_Matrix ( level*level , 3 ); + k=0; + int s=0; + for(int i=0;i<=level;i++) + { + for(int j=0;j<=level-i;j++) + { + if (j!=level-i) + { + (*Simplices) ( s , 0 ) = k; + (*Simplices) ( s , 1 ) = k+1; + (*Simplices) ( s++ , 2 ) = k+level+1-i; + // printf ("A %d %d - %d ==> %d %d %d\n",i,j,s,k,k+1,k+level+1-i); + } + if (j+1<level-i) + { + (*Simplices) ( s , 0 ) = k+1; + (*Simplices) ( s , 2 ) = k+level+1-i; + (*Simplices) ( s++ , 1 ) = k+level-i+2; + // printf ("B %d %d - %d ==> %d %d %d\n",i,j,s,k+1,k+level+1-i,k+level-i+2); + } + k++; + } + } +} + +void Adaptive_Post_View:: initWithLowResolution (Post_View *view) +{ + + List_T *myList = view->ST; + int nbelm = view->NbST; + int nbnod = 3; + + int nb = List_Nbr(myList) / (nbelm); + // printf("nb = %d nbelem = %d size = %d\n ", + // nb,nbelm,List_Nbr(myList)); + + _STposX = new Double_Matrix ( nbelm , nbnod ); + _STposY = new Double_Matrix ( nbelm , nbnod ); + _STposZ = new Double_Matrix ( nbelm , nbnod ); + _STval = new Double_Matrix ( nbelm , nb-3*nbnod ); + + /// Store non interpolated data + int k=0; + for (int i=0;i<List_Nbr(myList);i+=nb) + { + double *x = (double*)List_Pointer_Fast (view->ST,i); + double *y = (double*)List_Pointer_Fast (view->ST,i+nbnod); + double *z = (double*)List_Pointer_Fast (view->ST,i+2*nbnod); + (*_STposX) ( k , 0) = x[0]; (*_STposX) ( k , 1) = x[1]; (*_STposX) ( k , 2) = x[2]; + (*_STposY) ( k , 0) = y[0]; (*_STposY) ( k , 1) = y[1]; (*_STposY) ( k , 2) = y[2]; + (*_STposZ) ( k , 0) = z[0]; (*_STposZ) ( k , 1) = z[1]; (*_STposZ) ( k , 2) = z[2]; + double *val = (double*)List_Pointer_Fast (view->ST,i+3*nbnod); + for (int j=0;j<nb-3*nbnod;j++)(*_STval)(k,j)=val[j]; + k++; + } + + setGlobalResolutionLevel(view,1); +} + +void Adaptive_Post_View:: zoomElement (Post_View * view , + int ielem , + Post_Zoom *zoom) +{ + static double valelem[1024]; + static double x[1024]; + static double y[1024]; + static double z[1024]; + + Double_Matrix *M = zoom->M; + Double_Matrix *MGeom = zoom->MGeom; + Int_Matrix *Simplices = zoom->Simplices; + for ( int j=0;j<M->size1();++j) + { + valelem[j] = 0.0; + x[j] = 0.0; + y[j] = 0.0; + z[j] = 0.0; + for ( int k=0;k<M->size2();++k) + { + valelem[j] += (*M)(j,k) * (*_STval )( ielem , k ); + if (view->Min > valelem[j]) view->Min = valelem[j]; + if (view->Max < valelem[j]) view->Max = valelem[j]; + } + for ( int k=0;k<3;++k) + { + x[j] += (*MGeom)(j,k) * (*_STposX) ( ielem , k ); + y[j] += (*MGeom)(j,k) * (*_STposY) ( ielem , k ); + z[j] += (*MGeom)(j,k) * (*_STposZ) ( ielem , k ); + } + } + + for (int i=0;i<Simplices->size1();++i) + { + int p1 = (*Simplices) (i,0); + int p2 = (*Simplices) (i,1); + int p3 = (*Simplices) (i,2); + List_Add ( view->ST , &x[p1] ); + List_Add ( view->ST , &x[p2] ); + List_Add ( view->ST , &x[p3] ); + List_Add ( view->ST , &y[p1] ); + List_Add ( view->ST , &y[p2] ); + List_Add ( view->ST , &y[p3] ); + List_Add ( view->ST , &z[p1] ); + List_Add ( view->ST , &z[p2] ); + List_Add ( view->ST , &z[p3] ); + List_Add ( view->ST , &valelem[p1] ); + List_Add ( view->ST , &valelem[p2] ); + List_Add ( view->ST , &valelem[p3] ); + view->NbST++; + } +} + +void Adaptive_Post_View:: setAdaptiveResolutionLevel (Post_View * view , int level) +{ +} + +void Adaptive_Post_View:: setGlobalResolutionLevel (Post_View * view , int level) +{ + + printf ("asking for resolution %d\n",level); + + if (!view->ST)return; + if (presentZoomLevel==level)return; + if (!ZOOMS[level]) + ZOOMS[level] = new Post_Zoom ( level , _coefs); + + + List_Delete(view->ST); view->ST = 0; + view->NbST = 0; + + int nbelm = _STposX->size1(); + + view->ST = List_Create ( nbelm * 12 * ZOOMS[level]->Simplices->size1(), 100, sizeof(double)); + + for ( int i=0;i<nbelm;++i) + { + zoomElement ( view , i , ZOOMS[level] ); + } + view->Changed = 1; + presentZoomLevel=level; +} + +Adaptive_Post_View:: Adaptive_Post_View (Post_View *view, List_T *_c) +{ + // printf ("the view is adaptive, yeah!\n"); + + for (int i=0;i<MAX_LEVEL_OF_ZOOM+1;i++) ZOOMS[i] = 0; + _coefs = new Double_Matrix ( List_Nbr (_c) , List_Nbr (_c) ); + + // printf ("we have a %d x %d interpolation matrix\n", List_Nbr (_c), List_Nbr (_c)); + + for (int i=0; i< List_Nbr ( _c ); ++i) + { + List_T **line = (List_T **) List_Pointer_Fast ( _c,i); + for (int j=0;j < List_Nbr ( *line ); ++j) + { + double val; + List_Read ( *line, j, &val); + (*_coefs) ( i , j ) = val; + // printf("%g ",val); + } + // printf("\n "); + } + // printf("\n "); + initWithLowResolution (view); +} + diff --git a/Common/GmshMatrix.h b/Common/GmshMatrix.h new file mode 100644 index 0000000000000000000000000000000000000000..d20a53fda3e0efd6a35a791bd78edd8ee2c42e9b --- /dev/null +++ b/Common/GmshMatrix.h @@ -0,0 +1,62 @@ +#ifndef _GMSH_BOOSTMATRIX_ +#define _GMSH_BOOSTMATRIX_ + +#ifndef HAVE_BOOST +template <class SCALAR> +class Gmsh_Matrix +{ +private: + int r,c; +public: + inline int size1() const {return r;} + inline int size2() const {return c;} + SCALAR *data; + ~Gmsh_Matrix() {delete [] data;} + Gmsh_Matrix(int R,int C) + : r(R),c(C) + { + data = new SCALAR [r*c]; + scal(0); + } + Gmsh_Matrix(const Gmsh_Matrix<SCALAR> &other) + : r(other.r),c(other.c) + { + data = new double [r*c]; + copy ( other.data ) ; + } + inline SCALAR operator () (int i, int j) const + { + return data[i+r*j]; + } + inline SCALAR & operator () (int i, int j) + { + return data[i+r*j]; + } + inline Gmsh_Matrix operator *(const Gmsh_Matrix<SCALAR> & other) + { + throw; + } + inline void scal ( const SCALAR s) + { + for (int i=0;i<r*c;++i)data[i]*=s; + } + inline void copy ( const SCALAR **other) + { + for (int i=0;i<r*c;++i)data[i]=other.data[i]; + } +}; + +typedef Gmsh_Matrix<double> Double_Matrix; +typedef Gmsh_Matrix<int> Int_Matrix; + +#else +#include <boost/numeric/ublas/vector.hpp> +#include <boost/numeric/ublas/matrix.hpp> +#include <boost/numeric/ublas/blas.hpp> +#include <boost/numeric/ublas/io.hpp> +typedef numerics::matrix<double, numerics::column_major> Double_Matrix; +typedef numerics::vector<double> Double_Vector; +typedef numerics::matrix<int, numerics::column_major> Int_Matrix; +typedef numerics::vector<int> Int_Vector; +#endif +#endif diff --git a/Common/Makefile b/Common/Makefile index f022874da47bf7d1e744530002224befdaf27b8b..1437cbd8530ff49ae4f80122c05823004655bdc7 100644 --- a/Common/Makefile +++ b/Common/Makefile @@ -1,4 +1,4 @@ -# $Id: Makefile,v 1.61 2004-09-25 06:16:12 geuzaine Exp $ +# $Id: Makefile,v 1.62 2004-10-20 14:38:56 remacle Exp $ # # Copyright (C) 1997-2004 C. Geuzaine, J.-F. Remacle # @@ -27,6 +27,7 @@ INCLUDE = -I../Common -I../DataStr -I../Geo -I../Graphics\ CFLAGS = ${OPTIM} ${FLAGS} ${INCLUDE} SRC = Context.cpp\ + AdaptiveViews.cpp\ Views.cpp\ Options.cpp\ CommandLine.cpp\ diff --git a/Common/Options.cpp b/Common/Options.cpp index a988edd6cf3b1a959ddc47aff931a329d32b5187..022e82ed38cae641aa6eaf52029af83cea9dff9b 100644 --- a/Common/Options.cpp +++ b/Common/Options.cpp @@ -1,4 +1,4 @@ -// $Id: Options.cpp,v 1.190 2004-10-16 22:15:16 geuzaine Exp $ +// $Id: Options.cpp,v 1.191 2004-10-20 14:38:56 remacle Exp $ // // Copyright (C) 1997-2004 C. Geuzaine, J.-F. Remacle // @@ -4554,6 +4554,27 @@ double opt_view_saturate_values(OPT_ARGS_NUM) return v->SaturateValues; } + +double opt_view_global_zoom(OPT_ARGS_NUM) +{ + GET_VIEW(0.); + if(action & GMSH_SET) { + if (v->adaptive) + v->adaptive->setGlobalResolutionLevel(v,(int)val); + } +#if defined(HAVE_FLTK) + if(_gui_action_valid(action, num)) { + if (v->adaptive){ + WID->view_value[33]->value(v->adaptive->getGlobalResolutionLevel()); + } + } +#endif + if (v->adaptive) + return v->adaptive->getGlobalResolutionLevel(); + return 1; +} + + double opt_view_type(OPT_ARGS_NUM) { GET_VIEW(0.); diff --git a/Common/Options.h b/Common/Options.h index 63a711c79de435f9ad7ee3806beeb1e92e609d38..dc3570b1f7b170b629e1b5da5ad601e856e3d729 100644 --- a/Common/Options.h +++ b/Common/Options.h @@ -459,6 +459,7 @@ double opt_view_explode(OPT_ARGS_NUM); double opt_view_visible(OPT_ARGS_NUM); double opt_view_intervals_type(OPT_ARGS_NUM); double opt_view_saturate_values(OPT_ARGS_NUM); +double opt_view_global_zoom(OPT_ARGS_NUM); double opt_view_alpha_channel(OPT_ARGS_NUM); double opt_view_raised_scalar_view(OPT_ARGS_NUM); double opt_view_type(OPT_ARGS_NUM); diff --git a/Common/Views.cpp b/Common/Views.cpp index 17fc69c8ddb305d0683d9265c41c6adbe137d6cf..8035afd975a51dd43b672c878ff3eb75b07818e7 100644 --- a/Common/Views.cpp +++ b/Common/Views.cpp @@ -1,4 +1,4 @@ -// $Id: Views.cpp,v 1.138 2004-10-20 05:46:47 geuzaine Exp $ +// $Id: Views.cpp,v 1.139 2004-10-20 14:38:57 remacle Exp $ // // Copyright (C) 1997-2004 C. Geuzaine, J.-F. Remacle // @@ -159,7 +159,7 @@ Post_View *BeginView(int allocate) // Copy all options from the reference view initialized in InitOptions() CopyViewOptions(Post_ViewReference, v); - + v->Changed = 1; v->Links = 0; v->DuplicateOf = 0; @@ -168,6 +168,7 @@ Post_View *BeginView(int allocate) v->normals = new smooth_normals; v->Min = VAL_INF; v->Max = -VAL_INF; + v->adaptive = 0; for(i = 0; i < 3; i++) { v->BBox[2 * i] = VAL_INF; v->BBox[2 * i + 1] = -VAL_INF; @@ -596,6 +597,8 @@ void FreeView(Post_View * v) v->TriVertexArray = NULL; } + if (v->adaptive) delete v->adaptive; + } void CopyViewOptions(Post_View * src, Post_View * dest) diff --git a/Common/Views.h b/Common/Views.h index 19dfeeab8d8c114276d1638a6e834edd4e26d3b3..81ba0e70e5fab8c63b4b37d37a225f66542a74e3 100644 --- a/Common/Views.h +++ b/Common/Views.h @@ -24,13 +24,95 @@ #include "List.h" #include "VertexArray.h" #include "SmoothNormals.h" +#include "GmshMatrix.h" #define VIEW_NB_ELEMENT_TYPES (8*3) #define VIEW_MAX_ELEMENT_NODES 8 #define VAL_INF 1.e200 +class Post_View; + +#define MAX_LEVEL_OF_ZOOM 40 + +// On a triangle, we suppose that there exists an +// interpolation scheme such that u = \sum_i u_i \phi_i +// phi_i being polynomials of order p, i goes from 1...(p+1)(p+2)/2 +// and phi_i = \sum_j coeffs_{ij} monomials_j and +// monomials are 1,x,y,x^2,xy,y^2,x^3,x^2y,xy^2,y^3... + +/// A zoom is a triangulation in reference coordinates +class Post_Zoom +{ +public: + Post_Zoom( int level , Double_Matrix *coeffs); + ~Post_Zoom() + { + delete M; + delete MGeom; + delete Points; + delete Simplices; + } + Double_Matrix *M; + Double_Matrix *MGeom; + Double_Matrix *Points; + Int_Matrix *Simplices; + void interpolate ( Double_Matrix *coefs , double u, double v, double *sf); +}; + +class Adaptive_Post_View +{ + Post_Zoom* ZOOMS [MAX_LEVEL_OF_ZOOM+1]; + double tol; + int presentZoomLevel; + Double_Matrix * _coefs; + Double_Matrix * _coefs_L2; + Double_Matrix * _STposX; + Double_Matrix * _STposY; + Double_Matrix * _STposZ; + Double_Matrix * _STval; +public: + Adaptive_Post_View (Post_View *view, List_T *_coeffs); + ~Adaptive_Post_View() + { + delete _coefs; + delete _STposX; + delete _STposY; + delete _STposZ; + delete _STval; + for (int i=0;i<MAX_LEVEL_OF_ZOOM+1;i++) + if (ZOOMS[i]) delete ZOOMS[i]; + } + int getGlobalResolutionLevel ( ) const {return presentZoomLevel;} + void setGlobalResolutionLevel ( Post_View * view , int level ); + void setAdaptiveResolutionLevel ( Post_View * view , int levelmax = MAX_LEVEL_OF_ZOOM ); + void initWithLowResolution (Post_View *view); + void setTolerance (const double eps) {tol=eps;} + void zoomElement (Post_View * view , + int ielem , + Post_Zoom *zoom); + +}; + class Post_View{ public : + // The view may be high order, coeffs are then interpreated as + // coefficients of a high order interpolation. So, a pre-pro + // is done at the end of the view that sets the view to the + // minimal resolution. Then, we can interactively modify the + // resolution. + + Adaptive_Post_View *adaptive; + void setGlobalResolutionLevel (int level) + { + if ( adaptive ) + adaptive->setGlobalResolutionLevel(this, level); + } + void setAdaptiveResolutionLevel (int level) + { + if ( adaptive ) + adaptive->setAdaptiveResolutionLevel(this, level); + } + // intrinsic to a view int Num, Index, Changed, DuplicateOf, Links, Dirty; char FileName[256], Name[256], AbscissaName[256]; @@ -107,6 +189,14 @@ class Post_View{ void get_raw_data(int type, List_T **list, int **nbe, int *nbc, int *nbn); }; + +// We have here a post processing map that is the solution of a high order +// interpolation. The principle is that we are able to produce adaptive +// visualizations i.e. we can Zoom on the picture and generate automatically +// levels of accuracy. + + + // Type #define DRAW_POST_3D 1 #define DRAW_POST_2D_SPACE 2 diff --git a/Fltk/Callbacks.cpp b/Fltk/Callbacks.cpp index 57961827beaaec898604e52294e3f78c7af67b5f..ca3a608e709a4d3fcb1b18fae01ccf5c01e87650 100644 --- a/Fltk/Callbacks.cpp +++ b/Fltk/Callbacks.cpp @@ -1,4 +1,4 @@ -// $Id: Callbacks.cpp,v 1.284 2004-10-17 01:53:49 geuzaine Exp $ +// $Id: Callbacks.cpp,v 1.285 2004-10-20 14:38:57 remacle Exp $ // // Copyright (C) 1997-2004 C. Geuzaine, J.-F. Remacle // @@ -3394,6 +3394,7 @@ void view_options_ok_cb(CALLBACK_ARGS) double type = opt_view_type(current, GMSH_GET, 0); double saturate_values = opt_view_saturate_values(current, GMSH_GET, 0); + double global_zoom = opt_view_global_zoom(current, GMSH_GET, 0); double show_element = opt_view_show_element(current, GMSH_GET, 0); double show_scale = opt_view_show_scale(current, GMSH_GET, 0); double auto_position = opt_view_auto_position(current, GMSH_GET, 0); @@ -3576,6 +3577,10 @@ void view_options_ok_cb(CALLBACK_ARGS) if(force || (val != saturate_values)) opt_view_saturate_values(i, GMSH_SET, val); + val = WID->view_value[33]->value(); + if(force || (val != global_zoom)) + opt_view_global_zoom(i, GMSH_SET, val); + val = WID->view_butt[10]->value(); if(force || (val != show_element)) opt_view_show_element(i, GMSH_SET, val); diff --git a/Fltk/GUI.cpp b/Fltk/GUI.cpp index 657adce90310931f248af95fc6b9fc7fdbdb8d4c..c6a91536463fcae75c0e39f6969a8a0612334896 100644 --- a/Fltk/GUI.cpp +++ b/Fltk/GUI.cpp @@ -1,4 +1,4 @@ -// $Id: GUI.cpp,v 1.364 2004-10-18 20:39:56 geuzaine Exp $ +// $Id: GUI.cpp,v 1.365 2004-10-20 14:38:57 remacle Exp $ // // Copyright (C) 1997-2004 C. Geuzaine, J.-F. Remacle // @@ -2388,6 +2388,9 @@ void GUI::create_option_window() view_value[23]->maximum(1024); view_value[23]->step(1); + + + o->end(); } { @@ -2537,6 +2540,13 @@ void GUI::create_option_window() view_butt[38]->down_box(TOGGLE_BOX); view_butt[38]->selection_color(TOGGLE_COLOR); + view_value[33] = new Fl_Value_Input(L + 2 * WB, 2 * WB + 8 * BH, IW, BH, "Global Resolution Level"); + view_value[33]->align(FL_ALIGN_RIGHT); + view_value[33]->minimum(1); + view_value[33]->maximum(MAX_LEVEL_OF_ZOOM); + view_value[33]->step(1); + view_value[33]->value(1); + view_range->end(); } { @@ -2714,6 +2724,10 @@ void GUI::update_view_window(int num) opt_view_show_scale(num, GMSH_GUI, 0); opt_view_draw_strings(num, GMSH_GUI, 0); opt_view_auto_position(num, GMSH_GUI, 0); + + if (!v->adaptive) + view_value[33]->deactivate(); + if(v->NbSP) { view_butt[2]->activate(); view_butt[3]->activate(); diff --git a/Parser/Gmsh.l b/Parser/Gmsh.l index d1be3477f593055261957a093f13c88cab485bf1..2be42ce93991748e784ccb25d028b018aeae6db7 100644 --- a/Parser/Gmsh.l +++ b/Parser/Gmsh.l @@ -1,5 +1,5 @@ %{ -// $Id: Gmsh.l,v 1.57 2004-07-02 20:48:42 geuzaine Exp $ +// $Id: Gmsh.l,v 1.58 2004-10-20 14:38:57 remacle Exp $ // // Copyright (C) 1997-2004 C. Geuzaine, J.-F. Remacle // @@ -248,6 +248,7 @@ VY return tVectorPyramid; TY return tTensorPyramid; T2 return tText2D; T3 return tText3D; +INTERPOLATION_MATRIX return tInterpolationMatrix; CARTESIAN_POINT return tCARTESIAN_POINT; diff --git a/Parser/Gmsh.tab.cpp b/Parser/Gmsh.tab.cpp index 9ff62462d35fcebc2bb6dcc904a0bb8a6fa9eed0..0ac2ef7aae04ba38bfe4090ff7e9808028917c98 100644 --- a/Parser/Gmsh.tab.cpp +++ b/Parser/Gmsh.tab.cpp @@ -1,198 +1,440 @@ +/* A Bison parser, made by GNU Bison 1.875b. */ -/* A Bison parser, made from Gmsh.y - by GNU Bison version 1.28 */ - -#define YYBISON 1 /* Identify Bison output. */ - -#define tDOUBLE 257 -#define tSTRING 258 -#define tBIGSTR 259 -#define tEND 260 -#define tAFFECT 261 -#define tDOTS 262 -#define tPi 263 -#define tMPI_Rank 264 -#define tMPI_Size 265 -#define tExp 266 -#define tLog 267 -#define tLog10 268 -#define tSqrt 269 -#define tSin 270 -#define tAsin 271 -#define tCos 272 -#define tAcos 273 -#define tTan 274 -#define tRand 275 -#define tAtan 276 -#define tAtan2 277 -#define tSinh 278 -#define tCosh 279 -#define tTanh 280 -#define tFabs 281 -#define tFloor 282 -#define tCeil 283 -#define tFmod 284 -#define tModulo 285 -#define tHypot 286 -#define tPrintf 287 -#define tSprintf 288 -#define tStrCat 289 -#define tStrPrefix 290 -#define tBoundingBox 291 -#define tDraw 292 -#define tPoint 293 -#define tCircle 294 -#define tEllipse 295 -#define tLine 296 -#define tSurface 297 -#define tSpline 298 -#define tVolume 299 -#define tCharacteristic 300 -#define tLength 301 -#define tParametric 302 -#define tElliptic 303 -#define tPlane 304 -#define tRuled 305 -#define tTriangulation 306 -#define tTransfinite 307 -#define tComplex 308 -#define tPhysical 309 -#define tUsing 310 -#define tBump 311 -#define tProgression 312 -#define tPlugin 313 -#define tRotate 314 -#define tTranslate 315 -#define tSymmetry 316 -#define tDilate 317 -#define tExtrude 318 -#define tDuplicata 319 -#define tLoop 320 -#define tRecombine 321 -#define tDelete 322 -#define tCoherence 323 -#define tIntersect 324 -#define tAttractor 325 -#define tLayers 326 -#define tScalarPoint 327 -#define tVectorPoint 328 -#define tTensorPoint 329 -#define tScalarLine 330 -#define tVectorLine 331 -#define tTensorLine 332 -#define tScalarTriangle 333 -#define tVectorTriangle 334 -#define tTensorTriangle 335 -#define tScalarQuadrangle 336 -#define tVectorQuadrangle 337 -#define tTensorQuadrangle 338 -#define tScalarTetrahedron 339 -#define tVectorTetrahedron 340 -#define tTensorTetrahedron 341 -#define tScalarHexahedron 342 -#define tVectorHexahedron 343 -#define tTensorHexahedron 344 -#define tScalarPrism 345 -#define tVectorPrism 346 -#define tTensorPrism 347 -#define tScalarPyramid 348 -#define tVectorPyramid 349 -#define tTensorPyramid 350 -#define tText2D 351 -#define tText3D 352 -#define tCombine 353 -#define tBSpline 354 -#define tBezier 355 -#define tNurbs 356 -#define tOrder 357 -#define tWith 358 -#define tBounds 359 -#define tKnots 360 -#define tColor 361 -#define tColorTable 362 -#define tFor 363 -#define tIn 364 -#define tEndFor 365 -#define tIf 366 -#define tEndIf 367 -#define tExit 368 -#define tReturn 369 -#define tCall 370 -#define tFunction 371 -#define tTrimmed 372 -#define tShow 373 -#define tHide 374 -#define tB_SPLINE_SURFACE_WITH_KNOTS 375 -#define tB_SPLINE_CURVE_WITH_KNOTS 376 -#define tCARTESIAN_POINT 377 -#define tTRUE 378 -#define tFALSE 379 -#define tUNSPECIFIED 380 -#define tU 381 -#define tV 382 -#define tEDGE_CURVE 383 -#define tVERTEX_POINT 384 -#define tORIENTED_EDGE 385 -#define tPLANE 386 -#define tFACE_OUTER_BOUND 387 -#define tEDGE_LOOP 388 -#define tADVANCED_FACE 389 -#define tVECTOR 390 -#define tDIRECTION 391 -#define tAXIS2_PLACEMENT_3D 392 -#define tISO 393 -#define tENDISO 394 -#define tENDSEC 395 -#define tDATA 396 -#define tHEADER 397 -#define tFILE_DESCRIPTION 398 -#define tFILE_SCHEMA 399 -#define tFILE_NAME 400 -#define tMANIFOLD_SOLID_BREP 401 -#define tCLOSED_SHELL 402 -#define tADVANCED_BREP_SHAPE_REPRESENTATION 403 -#define tFACE_BOUND 404 -#define tCYLINDRICAL_SURFACE 405 -#define tCONICAL_SURFACE 406 -#define tCIRCLE 407 -#define tTRIMMED_CURVE 408 -#define tGEOMETRIC_SET 409 -#define tCOMPOSITE_CURVE_SEGMENT 410 -#define tCONTINUOUS 411 -#define tCOMPOSITE_CURVE 412 -#define tTOROIDAL_SURFACE 413 -#define tPRODUCT_DEFINITION 414 -#define tPRODUCT_DEFINITION_SHAPE 415 -#define tSHAPE_DEFINITION_REPRESENTATION 416 -#define tELLIPSE 417 -#define tSolid 418 -#define tEndSolid 419 -#define tVertex 420 -#define tFacet 421 -#define tNormal 422 -#define tOuter 423 -#define tLoopSTL 424 -#define tEndLoop 425 -#define tEndFacet 426 -#define tAFFECTPLUS 427 -#define tAFFECTMINUS 428 -#define tAFFECTTIMES 429 -#define tAFFECTDIVIDE 430 -#define tOR 431 -#define tAND 432 -#define tEQUAL 433 -#define tNOTEQUAL 434 -#define tAPPROXEQUAL 435 -#define tLESSOREQUAL 436 -#define tGREATEROREQUAL 437 -#define tCROSSPRODUCT 438 -#define tPLUSPLUS 439 -#define tMINUSMINUS 440 -#define UNARYPREC 441 +/* Skeleton parser for Yacc-like parsing with Bison, + Copyright (C) 1984, 1989, 1990, 2000, 2001, 2002, 2003 Free Software Foundation, Inc. + This program is free software; you can redistribute it and/or modify + it under the terms of the GNU General Public License as published by + the Free Software Foundation; either version 2, or (at your option) + any later version. + + This program is distributed in the hope that it will be useful, + but WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the + GNU General Public License for more details. + + You should have received a copy of the GNU General Public License + along with this program; if not, write to the Free Software + Foundation, Inc., 59 Temple Place - Suite 330, + Boston, MA 02111-1307, USA. */ + +/* As a special exception, when this file is copied by Bison into a + Bison output file, you may use that output file without restriction. + This special exception was added by the Free Software Foundation + in version 1.24 of Bison. */ + +/* Written by Richard Stallman by simplifying the original so called + ``semantic'' parser. */ + +/* All symbols defined below should begin with yy or YY, to avoid + infringing on user name space. This should be done even for local + variables, as they might otherwise be expanded by user macros. + There are some unavoidable exceptions within include files to + define necessary library symbols; they are noted "INFRINGES ON + USER NAME SPACE" below. */ + +/* Identify Bison output. */ +#define YYBISON 1 + +/* Skeleton name. */ +#define YYSKELETON_NAME "yacc.c" + +/* Pure parsers. */ +#define YYPURE 0 + +/* Using locations. */ +#define YYLSP_NEEDED 0 + + + +/* Tokens. */ +#ifndef YYTOKENTYPE +# define YYTOKENTYPE + /* Put the tokens into the symbol table, so that GDB and other debuggers + know about them. */ + enum yytokentype { + tDOUBLE = 258, + tSTRING = 259, + tBIGSTR = 260, + tEND = 261, + tAFFECT = 262, + tDOTS = 263, + tPi = 264, + tMPI_Rank = 265, + tMPI_Size = 266, + tExp = 267, + tLog = 268, + tLog10 = 269, + tSqrt = 270, + tSin = 271, + tAsin = 272, + tCos = 273, + tAcos = 274, + tTan = 275, + tRand = 276, + tAtan = 277, + tAtan2 = 278, + tSinh = 279, + tCosh = 280, + tTanh = 281, + tFabs = 282, + tFloor = 283, + tCeil = 284, + tFmod = 285, + tModulo = 286, + tHypot = 287, + tPrintf = 288, + tSprintf = 289, + tStrCat = 290, + tStrPrefix = 291, + tBoundingBox = 292, + tDraw = 293, + tPoint = 294, + tCircle = 295, + tEllipse = 296, + tLine = 297, + tSurface = 298, + tSpline = 299, + tVolume = 300, + tCharacteristic = 301, + tLength = 302, + tParametric = 303, + tElliptic = 304, + tPlane = 305, + tRuled = 306, + tTriangulation = 307, + tTransfinite = 308, + tComplex = 309, + tPhysical = 310, + tUsing = 311, + tBump = 312, + tProgression = 313, + tPlugin = 314, + tRotate = 315, + tTranslate = 316, + tSymmetry = 317, + tDilate = 318, + tExtrude = 319, + tDuplicata = 320, + tLoop = 321, + tRecombine = 322, + tDelete = 323, + tCoherence = 324, + tIntersect = 325, + tAttractor = 326, + tLayers = 327, + tScalarPoint = 328, + tVectorPoint = 329, + tTensorPoint = 330, + tScalarLine = 331, + tVectorLine = 332, + tTensorLine = 333, + tScalarTriangle = 334, + tVectorTriangle = 335, + tTensorTriangle = 336, + tScalarQuadrangle = 337, + tVectorQuadrangle = 338, + tTensorQuadrangle = 339, + tScalarTetrahedron = 340, + tVectorTetrahedron = 341, + tTensorTetrahedron = 342, + tScalarHexahedron = 343, + tVectorHexahedron = 344, + tTensorHexahedron = 345, + tScalarPrism = 346, + tVectorPrism = 347, + tTensorPrism = 348, + tScalarPyramid = 349, + tVectorPyramid = 350, + tTensorPyramid = 351, + tText2D = 352, + tText3D = 353, + tInterpolationMatrix = 354, + tCombine = 355, + tBSpline = 356, + tBezier = 357, + tNurbs = 358, + tOrder = 359, + tWith = 360, + tBounds = 361, + tKnots = 362, + tColor = 363, + tColorTable = 364, + tFor = 365, + tIn = 366, + tEndFor = 367, + tIf = 368, + tEndIf = 369, + tExit = 370, + tReturn = 371, + tCall = 372, + tFunction = 373, + tTrimmed = 374, + tShow = 375, + tHide = 376, + tB_SPLINE_SURFACE_WITH_KNOTS = 377, + tB_SPLINE_CURVE_WITH_KNOTS = 378, + tCARTESIAN_POINT = 379, + tTRUE = 380, + tFALSE = 381, + tUNSPECIFIED = 382, + tU = 383, + tV = 384, + tEDGE_CURVE = 385, + tVERTEX_POINT = 386, + tORIENTED_EDGE = 387, + tPLANE = 388, + tFACE_OUTER_BOUND = 389, + tEDGE_LOOP = 390, + tADVANCED_FACE = 391, + tVECTOR = 392, + tDIRECTION = 393, + tAXIS2_PLACEMENT_3D = 394, + tISO = 395, + tENDISO = 396, + tENDSEC = 397, + tDATA = 398, + tHEADER = 399, + tFILE_DESCRIPTION = 400, + tFILE_SCHEMA = 401, + tFILE_NAME = 402, + tMANIFOLD_SOLID_BREP = 403, + tCLOSED_SHELL = 404, + tADVANCED_BREP_SHAPE_REPRESENTATION = 405, + tFACE_BOUND = 406, + tCYLINDRICAL_SURFACE = 407, + tCONICAL_SURFACE = 408, + tCIRCLE = 409, + tTRIMMED_CURVE = 410, + tGEOMETRIC_SET = 411, + tCOMPOSITE_CURVE_SEGMENT = 412, + tCONTINUOUS = 413, + tCOMPOSITE_CURVE = 414, + tTOROIDAL_SURFACE = 415, + tPRODUCT_DEFINITION = 416, + tPRODUCT_DEFINITION_SHAPE = 417, + tSHAPE_DEFINITION_REPRESENTATION = 418, + tELLIPSE = 419, + tSolid = 420, + tEndSolid = 421, + tVertex = 422, + tFacet = 423, + tNormal = 424, + tOuter = 425, + tLoopSTL = 426, + tEndLoop = 427, + tEndFacet = 428, + tAFFECTDIVIDE = 429, + tAFFECTTIMES = 430, + tAFFECTMINUS = 431, + tAFFECTPLUS = 432, + tOR = 433, + tAND = 434, + tAPPROXEQUAL = 435, + tNOTEQUAL = 436, + tEQUAL = 437, + tGREATEROREQUAL = 438, + tLESSOREQUAL = 439, + tCROSSPRODUCT = 440, + UNARYPREC = 441, + tMINUSMINUS = 442, + tPLUSPLUS = 443 + }; +#endif +#define tDOUBLE 258 +#define tSTRING 259 +#define tBIGSTR 260 +#define tEND 261 +#define tAFFECT 262 +#define tDOTS 263 +#define tPi 264 +#define tMPI_Rank 265 +#define tMPI_Size 266 +#define tExp 267 +#define tLog 268 +#define tLog10 269 +#define tSqrt 270 +#define tSin 271 +#define tAsin 272 +#define tCos 273 +#define tAcos 274 +#define tTan 275 +#define tRand 276 +#define tAtan 277 +#define tAtan2 278 +#define tSinh 279 +#define tCosh 280 +#define tTanh 281 +#define tFabs 282 +#define tFloor 283 +#define tCeil 284 +#define tFmod 285 +#define tModulo 286 +#define tHypot 287 +#define tPrintf 288 +#define tSprintf 289 +#define tStrCat 290 +#define tStrPrefix 291 +#define tBoundingBox 292 +#define tDraw 293 +#define tPoint 294 +#define tCircle 295 +#define tEllipse 296 +#define tLine 297 +#define tSurface 298 +#define tSpline 299 +#define tVolume 300 +#define tCharacteristic 301 +#define tLength 302 +#define tParametric 303 +#define tElliptic 304 +#define tPlane 305 +#define tRuled 306 +#define tTriangulation 307 +#define tTransfinite 308 +#define tComplex 309 +#define tPhysical 310 +#define tUsing 311 +#define tBump 312 +#define tProgression 313 +#define tPlugin 314 +#define tRotate 315 +#define tTranslate 316 +#define tSymmetry 317 +#define tDilate 318 +#define tExtrude 319 +#define tDuplicata 320 +#define tLoop 321 +#define tRecombine 322 +#define tDelete 323 +#define tCoherence 324 +#define tIntersect 325 +#define tAttractor 326 +#define tLayers 327 +#define tScalarPoint 328 +#define tVectorPoint 329 +#define tTensorPoint 330 +#define tScalarLine 331 +#define tVectorLine 332 +#define tTensorLine 333 +#define tScalarTriangle 334 +#define tVectorTriangle 335 +#define tTensorTriangle 336 +#define tScalarQuadrangle 337 +#define tVectorQuadrangle 338 +#define tTensorQuadrangle 339 +#define tScalarTetrahedron 340 +#define tVectorTetrahedron 341 +#define tTensorTetrahedron 342 +#define tScalarHexahedron 343 +#define tVectorHexahedron 344 +#define tTensorHexahedron 345 +#define tScalarPrism 346 +#define tVectorPrism 347 +#define tTensorPrism 348 +#define tScalarPyramid 349 +#define tVectorPyramid 350 +#define tTensorPyramid 351 +#define tText2D 352 +#define tText3D 353 +#define tInterpolationMatrix 354 +#define tCombine 355 +#define tBSpline 356 +#define tBezier 357 +#define tNurbs 358 +#define tOrder 359 +#define tWith 360 +#define tBounds 361 +#define tKnots 362 +#define tColor 363 +#define tColorTable 364 +#define tFor 365 +#define tIn 366 +#define tEndFor 367 +#define tIf 368 +#define tEndIf 369 +#define tExit 370 +#define tReturn 371 +#define tCall 372 +#define tFunction 373 +#define tTrimmed 374 +#define tShow 375 +#define tHide 376 +#define tB_SPLINE_SURFACE_WITH_KNOTS 377 +#define tB_SPLINE_CURVE_WITH_KNOTS 378 +#define tCARTESIAN_POINT 379 +#define tTRUE 380 +#define tFALSE 381 +#define tUNSPECIFIED 382 +#define tU 383 +#define tV 384 +#define tEDGE_CURVE 385 +#define tVERTEX_POINT 386 +#define tORIENTED_EDGE 387 +#define tPLANE 388 +#define tFACE_OUTER_BOUND 389 +#define tEDGE_LOOP 390 +#define tADVANCED_FACE 391 +#define tVECTOR 392 +#define tDIRECTION 393 +#define tAXIS2_PLACEMENT_3D 394 +#define tISO 395 +#define tENDISO 396 +#define tENDSEC 397 +#define tDATA 398 +#define tHEADER 399 +#define tFILE_DESCRIPTION 400 +#define tFILE_SCHEMA 401 +#define tFILE_NAME 402 +#define tMANIFOLD_SOLID_BREP 403 +#define tCLOSED_SHELL 404 +#define tADVANCED_BREP_SHAPE_REPRESENTATION 405 +#define tFACE_BOUND 406 +#define tCYLINDRICAL_SURFACE 407 +#define tCONICAL_SURFACE 408 +#define tCIRCLE 409 +#define tTRIMMED_CURVE 410 +#define tGEOMETRIC_SET 411 +#define tCOMPOSITE_CURVE_SEGMENT 412 +#define tCONTINUOUS 413 +#define tCOMPOSITE_CURVE 414 +#define tTOROIDAL_SURFACE 415 +#define tPRODUCT_DEFINITION 416 +#define tPRODUCT_DEFINITION_SHAPE 417 +#define tSHAPE_DEFINITION_REPRESENTATION 418 +#define tELLIPSE 419 +#define tSolid 420 +#define tEndSolid 421 +#define tVertex 422 +#define tFacet 423 +#define tNormal 424 +#define tOuter 425 +#define tLoopSTL 426 +#define tEndLoop 427 +#define tEndFacet 428 +#define tAFFECTDIVIDE 429 +#define tAFFECTTIMES 430 +#define tAFFECTMINUS 431 +#define tAFFECTPLUS 432 +#define tOR 433 +#define tAND 434 +#define tAPPROXEQUAL 435 +#define tNOTEQUAL 436 +#define tEQUAL 437 +#define tGREATEROREQUAL 438 +#define tLESSOREQUAL 439 +#define tCROSSPRODUCT 440 +#define UNARYPREC 441 +#define tMINUSMINUS 442 +#define tPLUSPLUS 443 + + + + +/* Copy the first part of user declarations. */ #line 1 "Gmsh.y" -// $Id: Gmsh.tab.cpp,v 1.204 2004-10-16 22:14:51 geuzaine Exp $ +// $Id: Gmsh.tab.cpp,v 1.205 2004-10-20 14:38:57 remacle Exp $ // // Copyright (C) 1997-2004 C. Geuzaine, J.-F. Remacle // @@ -268,8 +510,23 @@ void yymsg (int type, char *fmt, ...); void skip_until (char *skip, char *until); int PrintListOfDouble (char *format, List_T *list, char *buffer); + +/* Enabling traces. */ +#ifndef YYDEBUG +# define YYDEBUG 0 +#endif + +/* Enabling verbose error messages. */ +#ifdef YYERROR_VERBOSE +# undef YYERROR_VERBOSE +# define YYERROR_VERBOSE 1 +#else +# define YYERROR_VERBOSE 0 +#endif + +#if ! defined (YYSTYPE) && ! defined (YYSTYPE_IS_DECLARED) #line 79 "Gmsh.y" -typedef union { +typedef union YYSTYPE { char *c; int i; unsigned int u; @@ -278,4168 +535,4832 @@ typedef union { Shape s; List_T *l; } YYSTYPE; -#include <stdio.h> - -#ifndef __cplusplus -#ifndef __STDC__ -#define const -#endif +/* Line 191 of yacc.c. */ +#line 540 "Gmsh.tab.cpp" +# define yystype YYSTYPE /* obsolescent; will be withdrawn */ +# define YYSTYPE_IS_DECLARED 1 +# define YYSTYPE_IS_TRIVIAL 1 #endif -#define YYFINAL 2355 -#define YYFLAG -32768 -#define YYNTBASE 207 - -#define YYTRANSLATE(x) ((unsigned)(x) <= 441 ? yytranslate[x] : 342) - -static const short yytranslate[] = { 0, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 193, 2, 203, 2, 191, 2, 2, 198, - 199, 189, 187, 204, 188, 202, 190, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 183, - 2, 185, 177, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 200, 2, 201, 197, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 205, 2, 206, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 1, 3, 4, 5, 6, - 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, - 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, - 27, 28, 29, 30, 31, 32, 33, 34, 35, 36, - 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, - 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, - 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, - 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, - 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, - 87, 88, 89, 90, 91, 92, 93, 94, 95, 96, - 97, 98, 99, 100, 101, 102, 103, 104, 105, 106, - 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, - 117, 118, 119, 120, 121, 122, 123, 124, 125, 126, - 127, 128, 129, 130, 131, 132, 133, 134, 135, 136, - 137, 138, 139, 140, 141, 142, 143, 144, 145, 146, - 147, 148, 149, 150, 151, 152, 153, 154, 155, 156, - 157, 158, 159, 160, 161, 162, 163, 164, 165, 166, - 167, 168, 169, 170, 171, 172, 173, 174, 175, 176, - 178, 179, 180, 181, 182, 184, 186, 192, 194, 195, - 196 -}; +/* Copy the second part of user declarations. */ + + +/* Line 214 of yacc.c. */ +#line 552 "Gmsh.tab.cpp" + +#if ! defined (yyoverflow) || YYERROR_VERBOSE + +/* The parser invokes alloca or malloc; define the necessary symbols. */ + +# if YYSTACK_USE_ALLOCA +# define YYSTACK_ALLOC alloca +# else +# ifndef YYSTACK_USE_ALLOCA +# if defined (alloca) || defined (_ALLOCA_H) +# define YYSTACK_ALLOC alloca +# else +# ifdef __GNUC__ +# define YYSTACK_ALLOC __builtin_alloca +# endif +# endif +# endif +# endif + +# ifdef YYSTACK_ALLOC + /* Pacify GCC's `empty if-body' warning. */ +# define YYSTACK_FREE(Ptr) do { /* empty */; } while (0) +# else +# if defined (__STDC__) || defined (__cplusplus) +# include <stdlib.h> /* INFRINGES ON USER NAME SPACE */ +# define YYSIZE_T size_t +# endif +# define YYSTACK_ALLOC malloc +# define YYSTACK_FREE free +# endif +#endif /* ! defined (yyoverflow) || YYERROR_VERBOSE */ + + +#if (! defined (yyoverflow) \ + && (! defined (__cplusplus) \ + || (YYSTYPE_IS_TRIVIAL))) + +/* A type that is properly aligned for any stack member. */ +union yyalloc +{ + short yyss; + YYSTYPE yyvs; + }; + +/* The size of the maximum gap between one aligned stack and the next. */ +# define YYSTACK_GAP_MAXIMUM (sizeof (union yyalloc) - 1) + +/* The size of an array large to enough to hold all stacks, each with + N elements. */ +# define YYSTACK_BYTES(N) \ + ((N) * (sizeof (short) + sizeof (YYSTYPE)) \ + + YYSTACK_GAP_MAXIMUM) + +/* Copy COUNT objects from FROM to TO. The source and destination do + not overlap. */ +# ifndef YYCOPY +# if 1 < __GNUC__ +# define YYCOPY(To, From, Count) \ + __builtin_memcpy (To, From, (Count) * sizeof (*(From))) +# else +# define YYCOPY(To, From, Count) \ + do \ + { \ + register YYSIZE_T yyi; \ + for (yyi = 0; yyi < (Count); yyi++) \ + (To)[yyi] = (From)[yyi]; \ + } \ + while (0) +# endif +# endif + +/* Relocate STACK from its old location to the new one. The + local variables YYSIZE and YYSTACKSIZE give the old and new number of + elements in the stack, and YYPTR gives the new location of the + stack. Advance YYPTR to a properly aligned location for the next + stack. */ +# define YYSTACK_RELOCATE(Stack) \ + do \ + { \ + YYSIZE_T yynewbytes; \ + YYCOPY (&yyptr->Stack, Stack, yysize); \ + Stack = &yyptr->Stack; \ + yynewbytes = yystacksize * sizeof (*Stack) + YYSTACK_GAP_MAXIMUM; \ + yyptr += yynewbytes / sizeof (*yyptr); \ + } \ + while (0) + +#endif -#if YYDEBUG != 0 -static const short yyprhs[] = { 0, - 0, 2, 4, 6, 9, 11, 14, 15, 18, 20, - 42, 44, 45, 48, 50, 52, 54, 57, 60, 63, - 66, 69, 77, 83, 101, 111, 135, 167, 183, 195, - 207, 223, 233, 247, 257, 269, 283, 293, 303, 315, - 325, 337, 347, 359, 373, 387, 399, 413, 431, 441, - 453, 465, 479, 491, 501, 502, 505, 507, 509, 511, - 513, 515, 517, 519, 521, 523, 525, 527, 529, 531, - 533, 539, 547, 554, 563, 564, 567, 570, 573, 576, - 579, 582, 585, 588, 591, 594, 597, 600, 603, 606, - 609, 612, 615, 618, 621, 624, 627, 630, 633, 636, - 639, 642, 644, 648, 649, 663, 665, 669, 670, 684, - 686, 690, 691, 705, 707, 711, 712, 732, 734, 738, - 739, 759, 761, 765, 766, 786, 788, 792, 793, 819, - 821, 825, 826, 852, 854, 858, 859, 885, 887, 891, - 892, 924, 926, 930, 931, 963, 965, 969, 970, 1002, - 1004, 1008, 1009, 1041, 1043, 1047, 1048, 1080, 1082, 1086, - 1087, 1119, 1121, 1125, 1126, 1182, 1184, 1188, 1189, 1245, - 1247, 1251, 1252, 1308, 1310, 1314, 1315, 1359, 1361, 1365, - 1366, 1410, 1412, 1416, 1417, 1461, 1463, 1467, 1468, 1506, - 1508, 1512, 1513, 1551, 1553, 1557, 1558, 1596, 1598, 1602, - 1603, 1617, 1619, 1623, 1624, 1640, 1642, 1644, 1646, 1648, - 1650, 1652, 1654, 1659, 1667, 1677, 1684, 1688, 1695, 1702, - 1712, 1719, 1729, 1735, 1744, 1753, 1765, 1772, 1782, 1792, - 1802, 1810, 1819, 1832, 1839, 1847, 1855, 1863, 1873, 1881, - 1891, 1909, 1917, 1925, 1937, 1946, 1959, 1968, 1977, 1986, - 1999, 2014, 2029, 2052, 2073, 2082, 2091, 2100, 2108, 2117, - 2123, 2135, 2141, 2151, 2153, 2155, 2157, 2158, 2161, 2168, - 2175, 2182, 2189, 2194, 2201, 2206, 2213, 2217, 2223, 2227, - 2231, 2236, 2241, 2245, 2253, 2257, 2265, 2269, 2272, 2275, - 2291, 2294, 2301, 2310, 2319, 2330, 2332, 2335, 2337, 2341, - 2346, 2348, 2357, 2370, 2385, 2386, 2399, 2400, 2417, 2418, - 2437, 2446, 2459, 2474, 2475, 2488, 2489, 2506, 2507, 2526, - 2535, 2548, 2563, 2564, 2577, 2578, 2595, 2596, 2615, 2617, - 2620, 2630, 2638, 2641, 2648, 2658, 2668, 2677, 2686, 2695, - 2702, 2707, 2710, 2713, 2715, 2717, 2719, 2721, 2723, 2725, - 2729, 2732, 2735, 2738, 2742, 2746, 2750, 2754, 2758, 2762, - 2766, 2770, 2774, 2778, 2782, 2786, 2790, 2794, 2800, 2805, - 2810, 2815, 2820, 2825, 2830, 2835, 2840, 2845, 2850, 2857, - 2862, 2867, 2872, 2877, 2882, 2887, 2894, 2901, 2908, 2913, - 2918, 2923, 2928, 2933, 2938, 2943, 2948, 2953, 2958, 2963, - 2970, 2975, 2980, 2985, 2990, 2995, 3000, 3007, 3014, 3021, - 3026, 3028, 3030, 3032, 3034, 3036, 3041, 3046, 3049, 3055, - 3059, 3066, 3071, 3079, 3081, 3084, 3087, 3091, 3095, 3107, - 3117, 3125, 3133, 3134, 3138, 3140, 3144, 3145, 3149, 3153, - 3155, 3159, 3161, 3163, 3167, 3172, 3176, 3182, 3187, 3189, - 3191, 3193, 3197, 3202, 3209, 3217, 3219, 3221, 3225, 3229, - 3239, 3247, 3249, 3255, 3259, 3266, 3268, 3272, 3274, 3281, - 3286, 3291, 3298, 3305 +#if defined (__STDC__) || defined (__cplusplus) + typedef signed char yysigned_char; +#else + typedef short yysigned_char; +#endif + +/* YYFINAL -- State number of the termination state. */ +#define YYFINAL 7 +/* YYLAST -- Last index in YYTABLE. */ +#define YYLAST 13966 + +/* YYNTOKENS -- Number of terminals. */ +#define YYNTOKENS 208 +/* YYNNTS -- Number of nonterminals. */ +#define YYNNTS 137 +/* YYNRULES -- Number of rules. */ +#define YYNRULES 477 +/* YYNRULES -- Number of states. */ +#define YYNSTATES 2359 + +/* YYTRANSLATE(YYLEX) -- Bison symbol number corresponding to YYLEX. */ +#define YYUNDEFTOK 2 +#define YYMAXUTOK 443 + +#define YYTRANSLATE(YYX) \ + ((unsigned int) (YYX) <= YYMAXUTOK ? yytranslate[YYX] : YYUNDEFTOK) + +/* YYTRANSLATE[YYLEX] -- Bison symbol number corresponding to YYLEX. */ +static const unsigned char yytranslate[] = +{ + 0, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 194, 2, 204, 2, 192, 2, 2, + 199, 200, 190, 188, 205, 189, 203, 191, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 184, 2, 185, 178, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 201, 2, 202, 198, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 206, 2, 207, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 1, 2, 3, 4, + 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, + 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, + 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, + 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, + 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, + 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, + 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, + 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, + 85, 86, 87, 88, 89, 90, 91, 92, 93, 94, + 95, 96, 97, 98, 99, 100, 101, 102, 103, 104, + 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, + 115, 116, 117, 118, 119, 120, 121, 122, 123, 124, + 125, 126, 127, 128, 129, 130, 131, 132, 133, 134, + 135, 136, 137, 138, 139, 140, 141, 142, 143, 144, + 145, 146, 147, 148, 149, 150, 151, 152, 153, 154, + 155, 156, 157, 158, 159, 160, 161, 162, 163, 164, + 165, 166, 167, 168, 169, 170, 171, 172, 173, 174, + 175, 176, 177, 179, 180, 181, 182, 183, 186, 187, + 193, 195, 196, 197 }; -static const short yyrhs[] = { 211, - 0, 209, 0, 216, 0, 1, 6, 0, 3, 0, - 188, 3, 0, 0, 209, 210, 0, 164, 0, 167, - 168, 208, 208, 208, 169, 170, 166, 208, 208, 208, - 166, 208, 208, 208, 166, 208, 208, 208, 171, 172, - 0, 165, 0, 0, 211, 212, 0, 213, 0, 215, - 0, 214, 0, 139, 6, 0, 140, 6, 0, 142, - 6, 0, 141, 6, 0, 143, 6, 0, 144, 198, - 331, 204, 5, 199, 6, 0, 145, 198, 331, 199, - 6, 0, 146, 198, 5, 204, 5, 204, 331, 204, - 331, 204, 5, 204, 5, 204, 5, 199, 6, 0, - 3, 7, 123, 198, 5, 204, 329, 199, 6, 0, - 3, 7, 122, 198, 5, 204, 327, 204, 335, 204, - 326, 204, 326, 204, 326, 204, 335, 204, 335, 204, - 326, 199, 6, 0, 3, 7, 121, 198, 5, 204, - 327, 204, 327, 204, 333, 204, 326, 204, 326, 204, - 326, 204, 326, 204, 335, 204, 335, 204, 335, 204, - 335, 204, 326, 199, 6, 0, 3, 7, 129, 198, - 5, 204, 3, 204, 3, 204, 3, 204, 326, 199, - 6, 0, 3, 7, 133, 198, 5, 204, 3, 204, - 326, 199, 6, 0, 3, 7, 150, 198, 5, 204, - 3, 204, 326, 199, 6, 0, 3, 7, 131, 198, - 5, 204, 189, 204, 189, 204, 327, 204, 326, 199, - 6, 0, 3, 7, 134, 198, 5, 204, 335, 199, - 6, 0, 3, 7, 135, 198, 5, 204, 335, 204, - 3, 204, 326, 199, 6, 0, 3, 7, 130, 198, - 5, 204, 3, 199, 6, 0, 3, 7, 136, 198, - 5, 204, 3, 204, 327, 199, 6, 0, 3, 7, - 138, 198, 5, 204, 3, 204, 3, 204, 3, 199, - 6, 0, 3, 7, 137, 198, 5, 204, 329, 199, - 6, 0, 3, 7, 132, 198, 5, 204, 3, 199, - 6, 0, 3, 7, 42, 198, 5, 204, 3, 204, - 3, 199, 6, 0, 3, 7, 148, 198, 5, 204, - 335, 199, 6, 0, 3, 7, 149, 198, 5, 204, - 335, 204, 3, 199, 6, 0, 3, 7, 147, 198, - 5, 204, 3, 199, 6, 0, 3, 7, 151, 198, - 5, 204, 3, 204, 327, 199, 6, 0, 3, 7, - 152, 198, 5, 204, 3, 204, 327, 204, 327, 199, - 6, 0, 3, 7, 159, 198, 5, 204, 3, 204, - 327, 204, 327, 199, 6, 0, 3, 7, 153, 198, - 5, 204, 3, 204, 327, 199, 6, 0, 3, 7, - 163, 198, 5, 204, 3, 204, 327, 204, 327, 199, - 6, 0, 3, 7, 154, 198, 5, 204, 3, 204, - 335, 204, 335, 204, 326, 204, 326, 199, 6, 0, - 3, 7, 155, 198, 5, 204, 335, 199, 6, 0, - 3, 7, 156, 198, 157, 204, 326, 204, 3, 199, - 6, 0, 3, 7, 158, 198, 5, 204, 335, 204, - 326, 199, 6, 0, 3, 7, 160, 198, 5, 204, - 5, 204, 3, 204, 3, 199, 6, 0, 3, 7, - 161, 198, 5, 204, 5, 204, 3, 199, 6, 0, - 3, 7, 162, 198, 3, 204, 3, 199, 6, 0, - 0, 216, 217, 0, 219, 0, 218, 0, 301, 0, - 302, 0, 303, 0, 306, 0, 307, 0, 308, 0, - 309, 0, 312, 0, 324, 0, 325, 0, 311, 0, - 310, 0, 33, 198, 5, 199, 6, 0, 33, 198, - 5, 204, 337, 199, 6, 0, 4, 5, 205, 220, - 206, 6, 0, 4, 5, 4, 329, 205, 220, 206, - 6, 0, 0, 220, 222, 0, 220, 225, 0, 220, - 228, 0, 220, 231, 0, 220, 234, 0, 220, 237, - 0, 220, 240, 0, 220, 243, 0, 220, 246, 0, - 220, 249, 0, 220, 252, 0, 220, 255, 0, 220, - 258, 0, 220, 261, 0, 220, 264, 0, 220, 267, - 0, 220, 270, 0, 220, 273, 0, 220, 276, 0, - 220, 279, 0, 220, 282, 0, 220, 285, 0, 220, - 288, 0, 220, 291, 0, 220, 294, 0, 220, 297, - 0, 327, 0, 221, 204, 327, 0, 0, 73, 198, - 327, 204, 327, 204, 327, 199, 223, 205, 221, 206, - 6, 0, 327, 0, 224, 204, 327, 0, 0, 74, - 198, 327, 204, 327, 204, 327, 199, 226, 205, 224, - 206, 6, 0, 327, 0, 227, 204, 327, 0, 0, - 75, 198, 327, 204, 327, 204, 327, 199, 229, 205, - 227, 206, 6, 0, 327, 0, 230, 204, 327, 0, - 0, 76, 198, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 199, 232, 205, 230, 206, 6, - 0, 327, 0, 233, 204, 327, 0, 0, 77, 198, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 199, 235, 205, 233, 206, 6, 0, 327, 0, - 236, 204, 327, 0, 0, 78, 198, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 199, 238, - 205, 236, 206, 6, 0, 327, 0, 239, 204, 327, - 0, 0, 79, 198, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 199, 241, 205, 239, 206, 6, 0, 327, 0, - 242, 204, 327, 0, 0, 80, 198, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 199, 244, 205, 242, 206, 6, - 0, 327, 0, 245, 204, 327, 0, 0, 81, 198, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 199, 247, 205, - 245, 206, 6, 0, 327, 0, 248, 204, 327, 0, - 0, 82, 198, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 199, 250, 205, 248, - 206, 6, 0, 327, 0, 251, 204, 327, 0, 0, - 83, 198, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 204, 327, 199, 253, 205, 251, 206, - 6, 0, 327, 0, 254, 204, 327, 0, 0, 84, - 198, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 199, 256, 205, 254, 206, 6, - 0, 327, 0, 257, 204, 327, 0, 0, 85, 198, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 199, 259, 205, 257, 206, 6, 0, - 327, 0, 260, 204, 327, 0, 0, 86, 198, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 199, 262, 205, 260, 206, 6, 0, 327, - 0, 263, 204, 327, 0, 0, 87, 198, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 199, 265, 205, 263, 206, 6, 0, 327, 0, - 266, 204, 327, 0, 0, 88, 198, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 199, 268, 205, 266, 206, 6, - 0, 327, 0, 269, 204, 327, 0, 0, 89, 198, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 199, 271, 205, - 269, 206, 6, 0, 327, 0, 272, 204, 327, 0, - 0, 90, 198, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 199, 274, 205, 272, 206, 6, 0, 327, 0, 275, - 204, 327, 0, 0, 91, 198, 327, 204, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 199, 277, 205, 275, 206, 6, 0, 327, 0, - 278, 204, 327, 0, 0, 92, 198, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 199, 280, 205, 278, 206, 6, 0, 327, - 0, 281, 204, 327, 0, 0, 93, 198, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 199, 283, 205, 281, 206, 6, 0, - 327, 0, 284, 204, 327, 0, 0, 94, 198, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 199, 286, - 205, 284, 206, 6, 0, 327, 0, 287, 204, 327, - 0, 0, 95, 198, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 204, 327, 204, - 327, 204, 327, 199, 289, 205, 287, 206, 6, 0, - 327, 0, 290, 204, 327, 0, 0, 96, 198, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 204, 327, 204, 327, 199, 292, - 205, 290, 206, 6, 0, 341, 0, 293, 204, 341, - 0, 0, 97, 198, 327, 204, 327, 204, 327, 199, - 295, 205, 293, 206, 6, 0, 341, 0, 296, 204, - 341, 0, 0, 98, 198, 327, 204, 327, 204, 327, - 204, 327, 199, 298, 205, 296, 206, 6, 0, 7, - 0, 173, 0, 174, 0, 175, 0, 176, 0, 194, - 0, 195, 0, 4, 299, 327, 6, 0, 4, 200, - 327, 201, 299, 327, 6, 0, 4, 200, 205, 337, - 206, 201, 299, 335, 6, 0, 4, 200, 201, 7, - 335, 6, 0, 4, 300, 6, 0, 4, 200, 327, - 201, 300, 6, 0, 4, 202, 4, 7, 341, 6, - 0, 4, 200, 327, 201, 202, 4, 7, 341, 6, - 0, 4, 202, 4, 299, 327, 6, 0, 4, 200, - 327, 201, 202, 4, 299, 327, 6, 0, 4, 202, - 4, 300, 6, 0, 4, 200, 327, 201, 202, 4, - 300, 6, 0, 4, 202, 107, 202, 4, 7, 338, - 6, 0, 4, 200, 327, 201, 202, 107, 202, 4, - 7, 338, 6, 0, 4, 202, 108, 7, 339, 6, - 0, 4, 200, 327, 201, 202, 108, 7, 339, 6, - 0, 59, 198, 4, 199, 202, 4, 7, 327, 6, - 0, 59, 198, 4, 199, 202, 4, 7, 341, 6, - 0, 39, 198, 327, 199, 7, 329, 6, 0, 55, - 39, 198, 327, 199, 7, 335, 6, 0, 71, 39, - 335, 7, 205, 327, 204, 327, 204, 327, 206, 6, - 0, 46, 47, 335, 7, 327, 6, 0, 42, 198, - 327, 199, 7, 335, 6, 0, 44, 198, 327, 199, - 7, 335, 6, 0, 40, 198, 327, 199, 7, 335, - 6, 0, 40, 198, 327, 199, 7, 335, 50, 329, - 6, 0, 41, 198, 327, 199, 7, 335, 6, 0, - 41, 198, 327, 199, 7, 335, 50, 329, 6, 0, - 48, 198, 327, 199, 7, 205, 327, 204, 327, 204, - 5, 204, 5, 204, 5, 206, 6, 0, 100, 198, - 327, 199, 7, 335, 6, 0, 101, 198, 327, 199, - 7, 335, 6, 0, 102, 198, 327, 199, 7, 335, - 106, 335, 103, 327, 6, 0, 42, 66, 198, 327, - 199, 7, 335, 6, 0, 71, 42, 335, 7, 205, - 327, 204, 327, 204, 327, 206, 6, 0, 55, 42, - 198, 327, 199, 7, 335, 6, 0, 50, 43, 198, - 327, 199, 7, 335, 6, 0, 51, 43, 198, 327, - 199, 7, 335, 6, 0, 118, 43, 198, 327, 199, - 7, 205, 327, 204, 335, 206, 6, 0, 52, 43, - 205, 327, 206, 7, 198, 327, 204, 327, 199, 335, - 335, 6, 0, 52, 43, 198, 327, 199, 7, 198, - 327, 204, 327, 199, 335, 335, 6, 0, 102, 43, - 104, 105, 198, 327, 199, 7, 333, 106, 205, 335, - 204, 335, 206, 103, 205, 327, 204, 327, 206, 6, - 0, 102, 43, 198, 327, 199, 7, 333, 106, 205, - 335, 204, 335, 206, 103, 205, 327, 204, 327, 206, - 6, 0, 43, 66, 198, 327, 199, 7, 335, 6, - 0, 55, 43, 198, 327, 199, 7, 335, 6, 0, - 54, 45, 198, 327, 199, 7, 335, 6, 0, 45, - 198, 327, 199, 7, 335, 6, 0, 55, 45, 198, - 327, 199, 7, 335, 6, 0, 61, 329, 205, 304, - 206, 0, 60, 205, 329, 204, 329, 204, 327, 206, - 205, 304, 206, 0, 62, 329, 205, 304, 206, 0, - 63, 205, 329, 204, 327, 206, 205, 304, 206, 0, - 306, 0, 305, 0, 303, 0, 0, 305, 302, 0, - 305, 39, 205, 337, 206, 6, 0, 305, 42, 205, - 337, 206, 6, 0, 305, 43, 205, 337, 206, 6, - 0, 305, 45, 205, 337, 206, 6, 0, 65, 205, - 305, 206, 0, 65, 4, 200, 327, 201, 6, 0, - 68, 205, 305, 206, 0, 68, 4, 200, 327, 201, - 6, 0, 68, 4, 6, 0, 107, 338, 205, 305, - 206, 0, 119, 341, 6, 0, 120, 341, 6, 0, - 119, 205, 305, 206, 0, 120, 205, 305, 206, 0, - 4, 341, 6, 0, 4, 4, 200, 327, 201, 341, - 6, 0, 4, 327, 6, 0, 59, 198, 4, 199, - 202, 4, 6, 0, 99, 4, 6, 0, 114, 6, - 0, 37, 6, 0, 37, 205, 327, 204, 327, 204, - 327, 204, 327, 204, 327, 204, 327, 206, 6, 0, - 38, 6, 0, 109, 198, 327, 8, 327, 199, 0, - 109, 198, 327, 8, 327, 8, 327, 199, 0, 109, - 4, 110, 205, 327, 8, 327, 206, 0, 109, 4, - 110, 205, 327, 8, 327, 8, 327, 206, 0, 111, - 0, 117, 4, 0, 115, 0, 116, 4, 6, 0, - 112, 198, 327, 199, 0, 113, 0, 64, 39, 205, - 327, 204, 329, 206, 6, 0, 64, 39, 205, 327, - 204, 329, 204, 329, 204, 327, 206, 6, 0, 64, - 39, 205, 327, 204, 329, 204, 329, 204, 329, 204, - 327, 206, 6, 0, 0, 64, 39, 205, 327, 204, - 329, 206, 313, 205, 322, 206, 6, 0, 0, 64, - 39, 205, 327, 204, 329, 204, 329, 204, 327, 206, - 314, 205, 322, 206, 6, 0, 0, 64, 39, 205, - 327, 204, 329, 204, 329, 204, 329, 204, 327, 206, - 315, 205, 322, 206, 6, 0, 64, 42, 205, 327, - 204, 329, 206, 6, 0, 64, 42, 205, 327, 204, - 329, 204, 329, 204, 327, 206, 6, 0, 64, 42, - 205, 327, 204, 329, 204, 329, 204, 329, 204, 327, - 206, 6, 0, 0, 64, 42, 205, 327, 204, 329, - 206, 316, 205, 322, 206, 6, 0, 0, 64, 42, - 205, 327, 204, 329, 204, 329, 204, 327, 206, 317, - 205, 322, 206, 6, 0, 0, 64, 42, 205, 327, - 204, 329, 204, 329, 204, 329, 204, 327, 206, 318, - 205, 322, 206, 6, 0, 64, 43, 205, 327, 204, - 329, 206, 6, 0, 64, 43, 205, 327, 204, 329, - 204, 329, 204, 327, 206, 6, 0, 64, 43, 205, - 327, 204, 329, 204, 329, 204, 329, 204, 327, 206, - 6, 0, 0, 64, 43, 205, 327, 204, 329, 206, - 319, 205, 322, 206, 6, 0, 0, 64, 43, 205, - 327, 204, 329, 204, 329, 204, 327, 206, 320, 205, - 322, 206, 6, 0, 0, 64, 43, 205, 327, 204, - 329, 204, 329, 204, 329, 204, 327, 206, 321, 205, - 322, 206, 6, 0, 323, 0, 322, 323, 0, 72, - 205, 335, 204, 335, 204, 335, 206, 6, 0, 72, - 205, 335, 204, 335, 206, 6, 0, 67, 6, 0, - 53, 42, 335, 7, 327, 6, 0, 53, 42, 335, - 7, 327, 56, 58, 327, 6, 0, 53, 42, 335, - 7, 327, 56, 57, 327, 6, 0, 53, 43, 205, - 327, 206, 7, 335, 6, 0, 49, 43, 205, 327, - 206, 7, 335, 6, 0, 53, 45, 205, 327, 206, - 7, 335, 6, 0, 67, 43, 335, 7, 327, 6, - 0, 67, 43, 335, 6, 0, 69, 6, 0, 70, - 6, 0, 124, 0, 125, 0, 126, 0, 127, 0, - 128, 0, 328, 0, 198, 327, 199, 0, 188, 327, - 0, 187, 327, 0, 193, 327, 0, 327, 188, 327, - 0, 327, 187, 327, 0, 327, 189, 327, 0, 327, - 190, 327, 0, 327, 191, 327, 0, 327, 197, 327, - 0, 327, 183, 327, 0, 327, 185, 327, 0, 327, - 184, 327, 0, 327, 186, 327, 0, 327, 180, 327, - 0, 327, 181, 327, 0, 327, 179, 327, 0, 327, - 178, 327, 0, 327, 177, 327, 8, 327, 0, 12, - 198, 327, 199, 0, 13, 198, 327, 199, 0, 14, - 198, 327, 199, 0, 15, 198, 327, 199, 0, 16, - 198, 327, 199, 0, 17, 198, 327, 199, 0, 18, - 198, 327, 199, 0, 19, 198, 327, 199, 0, 20, - 198, 327, 199, 0, 22, 198, 327, 199, 0, 23, - 198, 327, 204, 327, 199, 0, 24, 198, 327, 199, - 0, 25, 198, 327, 199, 0, 26, 198, 327, 199, - 0, 27, 198, 327, 199, 0, 28, 198, 327, 199, - 0, 29, 198, 327, 199, 0, 30, 198, 327, 204, - 327, 199, 0, 31, 198, 327, 204, 327, 199, 0, - 32, 198, 327, 204, 327, 199, 0, 21, 198, 327, - 199, 0, 12, 200, 327, 201, 0, 13, 200, 327, - 201, 0, 14, 200, 327, 201, 0, 15, 200, 327, - 201, 0, 16, 200, 327, 201, 0, 17, 200, 327, - 201, 0, 18, 200, 327, 201, 0, 19, 200, 327, - 201, 0, 20, 200, 327, 201, 0, 22, 200, 327, - 201, 0, 23, 200, 327, 204, 327, 201, 0, 24, - 200, 327, 201, 0, 25, 200, 327, 201, 0, 26, - 200, 327, 201, 0, 27, 200, 327, 201, 0, 28, - 200, 327, 201, 0, 29, 200, 327, 201, 0, 30, - 200, 327, 204, 327, 201, 0, 31, 200, 327, 204, - 327, 201, 0, 32, 200, 327, 204, 327, 201, 0, - 21, 200, 327, 201, 0, 3, 0, 9, 0, 10, - 0, 11, 0, 4, 0, 4, 200, 327, 201, 0, - 203, 4, 200, 201, 0, 4, 300, 0, 4, 200, - 327, 201, 300, 0, 4, 202, 4, 0, 4, 200, - 327, 201, 202, 4, 0, 4, 202, 4, 300, 0, - 4, 200, 327, 201, 202, 4, 300, 0, 330, 0, - 188, 329, 0, 187, 329, 0, 329, 188, 329, 0, - 329, 187, 329, 0, 205, 327, 204, 327, 204, 327, - 204, 327, 204, 327, 206, 0, 205, 327, 204, 327, - 204, 327, 204, 327, 206, 0, 205, 327, 204, 327, - 204, 327, 206, 0, 198, 327, 204, 327, 204, 327, - 199, 0, 0, 198, 332, 199, 0, 5, 0, 332, - 204, 5, 0, 0, 205, 334, 206, 0, 198, 334, - 199, 0, 335, 0, 334, 204, 335, 0, 327, 0, - 336, 0, 205, 337, 206, 0, 188, 205, 337, 206, - 0, 327, 8, 327, 0, 327, 8, 327, 8, 327, - 0, 39, 205, 327, 206, 0, 303, 0, 306, 0, - 312, 0, 4, 200, 201, 0, 188, 4, 200, 201, - 0, 4, 200, 205, 337, 206, 201, 0, 188, 4, - 200, 205, 337, 206, 201, 0, 327, 0, 336, 0, - 337, 204, 327, 0, 337, 204, 336, 0, 205, 327, - 204, 327, 204, 327, 204, 327, 206, 0, 205, 327, - 204, 327, 204, 327, 206, 0, 4, 0, 4, 202, - 107, 202, 4, 0, 205, 340, 206, 0, 4, 200, - 327, 201, 202, 108, 0, 338, 0, 340, 204, 338, - 0, 5, 0, 35, 198, 341, 204, 341, 199, 0, - 36, 198, 341, 199, 0, 34, 198, 341, 199, 0, - 34, 198, 341, 204, 337, 199, 0, 34, 198, 4, - 202, 4, 199, 0, 34, 198, 4, 200, 327, 201, - 202, 4, 199, 0 +#if YYDEBUG +/* YYPRHS[YYN] -- Index of the first RHS symbol of rule number YYN in + YYRHS. */ +static const unsigned short yyprhs[] = +{ + 0, 0, 3, 5, 7, 9, 12, 14, 17, 18, + 21, 23, 45, 47, 48, 51, 53, 55, 57, 60, + 63, 66, 69, 72, 80, 86, 104, 114, 138, 170, + 186, 198, 210, 226, 236, 250, 260, 272, 286, 296, + 306, 318, 328, 340, 350, 362, 376, 390, 402, 416, + 434, 444, 456, 468, 482, 494, 504, 505, 508, 510, + 512, 514, 516, 518, 520, 522, 524, 526, 528, 530, + 532, 534, 536, 542, 550, 557, 566, 567, 570, 573, + 576, 579, 582, 585, 588, 591, 594, 597, 600, 603, + 606, 609, 612, 615, 618, 621, 624, 627, 630, 633, + 636, 639, 642, 645, 648, 650, 654, 655, 669, 671, + 675, 676, 690, 692, 696, 697, 711, 713, 717, 718, + 738, 740, 744, 745, 765, 767, 771, 772, 792, 794, + 798, 799, 825, 827, 831, 832, 858, 860, 864, 865, + 891, 893, 897, 898, 930, 932, 936, 937, 969, 971, + 975, 976, 1008, 1010, 1014, 1015, 1047, 1049, 1053, 1054, + 1086, 1088, 1092, 1093, 1125, 1127, 1131, 1132, 1188, 1190, + 1194, 1195, 1251, 1253, 1257, 1258, 1314, 1316, 1320, 1321, + 1365, 1367, 1371, 1372, 1416, 1418, 1422, 1423, 1467, 1469, + 1473, 1474, 1512, 1514, 1518, 1519, 1557, 1559, 1563, 1564, + 1602, 1604, 1608, 1609, 1623, 1625, 1629, 1630, 1646, 1650, + 1652, 1654, 1656, 1658, 1660, 1662, 1664, 1669, 1677, 1687, + 1694, 1698, 1705, 1712, 1722, 1729, 1739, 1745, 1754, 1763, + 1775, 1782, 1792, 1802, 1812, 1820, 1829, 1842, 1849, 1857, + 1865, 1873, 1883, 1891, 1901, 1919, 1927, 1935, 1947, 1956, + 1969, 1978, 1987, 1996, 2009, 2024, 2039, 2062, 2083, 2092, + 2101, 2110, 2118, 2127, 2133, 2145, 2151, 2161, 2163, 2165, + 2167, 2168, 2171, 2178, 2185, 2192, 2199, 2204, 2211, 2216, + 2223, 2227, 2233, 2237, 2241, 2246, 2251, 2255, 2263, 2267, + 2275, 2279, 2282, 2285, 2301, 2304, 2311, 2320, 2329, 2340, + 2342, 2345, 2347, 2351, 2356, 2358, 2367, 2380, 2395, 2396, + 2409, 2410, 2427, 2428, 2447, 2456, 2469, 2484, 2485, 2498, + 2499, 2516, 2517, 2536, 2545, 2558, 2573, 2574, 2587, 2588, + 2605, 2606, 2625, 2627, 2630, 2640, 2648, 2651, 2658, 2668, + 2678, 2687, 2696, 2705, 2712, 2717, 2720, 2723, 2725, 2727, + 2729, 2731, 2733, 2735, 2739, 2742, 2745, 2748, 2752, 2756, + 2760, 2764, 2768, 2772, 2776, 2780, 2784, 2788, 2792, 2796, + 2800, 2804, 2810, 2815, 2820, 2825, 2830, 2835, 2840, 2845, + 2850, 2855, 2860, 2867, 2872, 2877, 2882, 2887, 2892, 2897, + 2904, 2911, 2918, 2923, 2928, 2933, 2938, 2943, 2948, 2953, + 2958, 2963, 2968, 2973, 2980, 2985, 2990, 2995, 3000, 3005, + 3010, 3017, 3024, 3031, 3036, 3038, 3040, 3042, 3044, 3046, + 3051, 3056, 3059, 3065, 3069, 3076, 3081, 3089, 3091, 3094, + 3097, 3101, 3105, 3117, 3127, 3135, 3143, 3144, 3148, 3150, + 3154, 3155, 3159, 3163, 3165, 3169, 3171, 3173, 3177, 3182, + 3186, 3192, 3197, 3199, 3201, 3203, 3207, 3212, 3219, 3227, + 3229, 3231, 3235, 3239, 3249, 3257, 3259, 3265, 3269, 3276, + 3278, 3282, 3284, 3291, 3296, 3301, 3308, 3315 }; -#endif +/* YYRHS -- A `-1'-separated list of the rules' RHS. */ +static const short yyrhs[] = +{ + 209, 0, -1, 213, -1, 211, -1, 218, -1, 1, + 6, -1, 3, -1, 189, 3, -1, -1, 211, 212, + -1, 165, -1, 168, 169, 210, 210, 210, 170, 171, + 167, 210, 210, 210, 167, 210, 210, 210, 167, 210, + 210, 210, 172, 173, -1, 166, -1, -1, 213, 214, + -1, 215, -1, 217, -1, 216, -1, 140, 6, -1, + 141, 6, -1, 143, 6, -1, 142, 6, -1, 144, + 6, -1, 145, 199, 334, 205, 5, 200, 6, -1, + 146, 199, 334, 200, 6, -1, 147, 199, 5, 205, + 5, 205, 334, 205, 334, 205, 5, 205, 5, 205, + 5, 200, 6, -1, 3, 7, 124, 199, 5, 205, + 332, 200, 6, -1, 3, 7, 123, 199, 5, 205, + 330, 205, 338, 205, 329, 205, 329, 205, 329, 205, + 338, 205, 338, 205, 329, 200, 6, -1, 3, 7, + 122, 199, 5, 205, 330, 205, 330, 205, 336, 205, + 329, 205, 329, 205, 329, 205, 329, 205, 338, 205, + 338, 205, 338, 205, 338, 205, 329, 200, 6, -1, + 3, 7, 130, 199, 5, 205, 3, 205, 3, 205, + 3, 205, 329, 200, 6, -1, 3, 7, 134, 199, + 5, 205, 3, 205, 329, 200, 6, -1, 3, 7, + 151, 199, 5, 205, 3, 205, 329, 200, 6, -1, + 3, 7, 132, 199, 5, 205, 190, 205, 190, 205, + 330, 205, 329, 200, 6, -1, 3, 7, 135, 199, + 5, 205, 338, 200, 6, -1, 3, 7, 136, 199, + 5, 205, 338, 205, 3, 205, 329, 200, 6, -1, + 3, 7, 131, 199, 5, 205, 3, 200, 6, -1, + 3, 7, 137, 199, 5, 205, 3, 205, 330, 200, + 6, -1, 3, 7, 139, 199, 5, 205, 3, 205, + 3, 205, 3, 200, 6, -1, 3, 7, 138, 199, + 5, 205, 332, 200, 6, -1, 3, 7, 133, 199, + 5, 205, 3, 200, 6, -1, 3, 7, 42, 199, + 5, 205, 3, 205, 3, 200, 6, -1, 3, 7, + 149, 199, 5, 205, 338, 200, 6, -1, 3, 7, + 150, 199, 5, 205, 338, 205, 3, 200, 6, -1, + 3, 7, 148, 199, 5, 205, 3, 200, 6, -1, + 3, 7, 152, 199, 5, 205, 3, 205, 330, 200, + 6, -1, 3, 7, 153, 199, 5, 205, 3, 205, + 330, 205, 330, 200, 6, -1, 3, 7, 160, 199, + 5, 205, 3, 205, 330, 205, 330, 200, 6, -1, + 3, 7, 154, 199, 5, 205, 3, 205, 330, 200, + 6, -1, 3, 7, 164, 199, 5, 205, 3, 205, + 330, 205, 330, 200, 6, -1, 3, 7, 155, 199, + 5, 205, 3, 205, 338, 205, 338, 205, 329, 205, + 329, 200, 6, -1, 3, 7, 156, 199, 5, 205, + 338, 200, 6, -1, 3, 7, 157, 199, 158, 205, + 329, 205, 3, 200, 6, -1, 3, 7, 159, 199, + 5, 205, 338, 205, 329, 200, 6, -1, 3, 7, + 161, 199, 5, 205, 5, 205, 3, 205, 3, 200, + 6, -1, 3, 7, 162, 199, 5, 205, 5, 205, + 3, 200, 6, -1, 3, 7, 163, 199, 3, 205, + 3, 200, 6, -1, -1, 218, 219, -1, 221, -1, + 220, -1, 304, -1, 305, -1, 306, -1, 309, -1, + 310, -1, 311, -1, 312, -1, 315, -1, 327, -1, + 328, -1, 314, -1, 313, -1, 33, 199, 5, 200, + 6, -1, 33, 199, 5, 205, 340, 200, 6, -1, + 4, 5, 206, 222, 207, 6, -1, 4, 5, 4, + 332, 206, 222, 207, 6, -1, -1, 222, 224, -1, + 222, 227, -1, 222, 230, -1, 222, 233, -1, 222, + 236, -1, 222, 239, -1, 222, 242, -1, 222, 245, + -1, 222, 248, -1, 222, 251, -1, 222, 254, -1, + 222, 257, -1, 222, 260, -1, 222, 263, -1, 222, + 266, -1, 222, 269, -1, 222, 272, -1, 222, 275, + -1, 222, 278, -1, 222, 281, -1, 222, 284, -1, + 222, 287, -1, 222, 290, -1, 222, 293, -1, 222, + 296, -1, 222, 299, -1, 222, 301, -1, 330, -1, + 223, 205, 330, -1, -1, 73, 199, 330, 205, 330, + 205, 330, 200, 225, 206, 223, 207, 6, -1, 330, + -1, 226, 205, 330, -1, -1, 74, 199, 330, 205, + 330, 205, 330, 200, 228, 206, 226, 207, 6, -1, + 330, -1, 229, 205, 330, -1, -1, 75, 199, 330, + 205, 330, 205, 330, 200, 231, 206, 229, 207, 6, + -1, 330, -1, 232, 205, 330, -1, -1, 76, 199, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 200, 234, 206, 232, 207, 6, -1, 330, -1, + 235, 205, 330, -1, -1, 77, 199, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 200, 237, + 206, 235, 207, 6, -1, 330, -1, 238, 205, 330, + -1, -1, 78, 199, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 200, 240, 206, 238, 207, + 6, -1, 330, -1, 241, 205, 330, -1, -1, 79, + 199, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 200, 243, + 206, 241, 207, 6, -1, 330, -1, 244, 205, 330, + -1, -1, 80, 199, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 200, 246, 206, 244, 207, 6, -1, 330, -1, + 247, 205, 330, -1, -1, 81, 199, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 205, 330, 205, 330, 200, 249, 206, 247, 207, 6, + -1, 330, -1, 250, 205, 330, -1, -1, 82, 199, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 200, 252, 206, 250, 207, 6, -1, + 330, -1, 253, 205, 330, -1, -1, 83, 199, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 205, 330, 200, 255, 206, 253, 207, 6, -1, 330, + -1, 256, 205, 330, -1, -1, 84, 199, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 200, 258, 206, 256, 207, 6, -1, 330, -1, + 259, 205, 330, -1, -1, 85, 199, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 200, 261, 206, 259, 207, 6, -1, 330, -1, 262, + 205, 330, -1, -1, 86, 199, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 200, + 264, 206, 262, 207, 6, -1, 330, -1, 265, 205, + 330, -1, -1, 87, 199, 330, 205, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 200, 267, + 206, 265, 207, 6, -1, 330, -1, 268, 205, 330, + -1, -1, 88, 199, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 200, 270, 206, 268, 207, 6, -1, 330, -1, + 271, 205, 330, -1, -1, 89, 199, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 205, 330, 205, 330, 200, 273, 206, 271, 207, 6, + -1, 330, -1, 274, 205, 330, -1, -1, 90, 199, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 200, 276, 206, + 274, 207, 6, -1, 330, -1, 277, 205, 330, -1, + -1, 91, 199, 330, 205, 330, 205, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 200, 279, + 206, 277, 207, 6, -1, 330, -1, 280, 205, 330, + -1, -1, 92, 199, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 200, + 282, 206, 280, 207, 6, -1, 330, -1, 283, 205, + 330, -1, -1, 93, 199, 330, 205, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 200, 285, 206, 283, 207, 6, -1, 330, -1, 286, + 205, 330, -1, -1, 94, 199, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 200, 288, 206, 286, 207, + 6, -1, 330, -1, 289, 205, 330, -1, -1, 95, + 199, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 205, 330, + 200, 291, 206, 289, 207, 6, -1, 330, -1, 292, + 205, 330, -1, -1, 96, 199, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 205, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 200, 294, 206, 292, 207, + 6, -1, 344, -1, 295, 205, 344, -1, -1, 97, + 199, 330, 205, 330, 205, 330, 200, 297, 206, 295, + 207, 6, -1, 344, -1, 298, 205, 344, -1, -1, + 98, 199, 330, 205, 330, 205, 330, 205, 330, 200, + 300, 206, 298, 207, 6, -1, 99, 336, 6, -1, + 7, -1, 177, -1, 176, -1, 175, -1, 174, -1, + 197, -1, 196, -1, 4, 302, 330, 6, -1, 4, + 201, 330, 202, 302, 330, 6, -1, 4, 201, 206, + 340, 207, 202, 302, 338, 6, -1, 4, 201, 202, + 7, 338, 6, -1, 4, 303, 6, -1, 4, 201, + 330, 202, 303, 6, -1, 4, 203, 4, 7, 344, + 6, -1, 4, 201, 330, 202, 203, 4, 7, 344, + 6, -1, 4, 203, 4, 302, 330, 6, -1, 4, + 201, 330, 202, 203, 4, 302, 330, 6, -1, 4, + 203, 4, 303, 6, -1, 4, 201, 330, 202, 203, + 4, 303, 6, -1, 4, 203, 108, 203, 4, 7, + 341, 6, -1, 4, 201, 330, 202, 203, 108, 203, + 4, 7, 341, 6, -1, 4, 203, 109, 7, 342, + 6, -1, 4, 201, 330, 202, 203, 109, 7, 342, + 6, -1, 59, 199, 4, 200, 203, 4, 7, 330, + 6, -1, 59, 199, 4, 200, 203, 4, 7, 344, + 6, -1, 39, 199, 330, 200, 7, 332, 6, -1, + 55, 39, 199, 330, 200, 7, 338, 6, -1, 71, + 39, 338, 7, 206, 330, 205, 330, 205, 330, 207, + 6, -1, 46, 47, 338, 7, 330, 6, -1, 42, + 199, 330, 200, 7, 338, 6, -1, 44, 199, 330, + 200, 7, 338, 6, -1, 40, 199, 330, 200, 7, + 338, 6, -1, 40, 199, 330, 200, 7, 338, 50, + 332, 6, -1, 41, 199, 330, 200, 7, 338, 6, + -1, 41, 199, 330, 200, 7, 338, 50, 332, 6, + -1, 48, 199, 330, 200, 7, 206, 330, 205, 330, + 205, 5, 205, 5, 205, 5, 207, 6, -1, 101, + 199, 330, 200, 7, 338, 6, -1, 102, 199, 330, + 200, 7, 338, 6, -1, 103, 199, 330, 200, 7, + 338, 107, 338, 104, 330, 6, -1, 42, 66, 199, + 330, 200, 7, 338, 6, -1, 71, 42, 338, 7, + 206, 330, 205, 330, 205, 330, 207, 6, -1, 55, + 42, 199, 330, 200, 7, 338, 6, -1, 50, 43, + 199, 330, 200, 7, 338, 6, -1, 51, 43, 199, + 330, 200, 7, 338, 6, -1, 119, 43, 199, 330, + 200, 7, 206, 330, 205, 338, 207, 6, -1, 52, + 43, 206, 330, 207, 7, 199, 330, 205, 330, 200, + 338, 338, 6, -1, 52, 43, 199, 330, 200, 7, + 199, 330, 205, 330, 200, 338, 338, 6, -1, 103, + 43, 105, 106, 199, 330, 200, 7, 336, 107, 206, + 338, 205, 338, 207, 104, 206, 330, 205, 330, 207, + 6, -1, 103, 43, 199, 330, 200, 7, 336, 107, + 206, 338, 205, 338, 207, 104, 206, 330, 205, 330, + 207, 6, -1, 43, 66, 199, 330, 200, 7, 338, + 6, -1, 55, 43, 199, 330, 200, 7, 338, 6, + -1, 54, 45, 199, 330, 200, 7, 338, 6, -1, + 45, 199, 330, 200, 7, 338, 6, -1, 55, 45, + 199, 330, 200, 7, 338, 6, -1, 61, 332, 206, + 307, 207, -1, 60, 206, 332, 205, 332, 205, 330, + 207, 206, 307, 207, -1, 62, 332, 206, 307, 207, + -1, 63, 206, 332, 205, 330, 207, 206, 307, 207, + -1, 309, -1, 308, -1, 306, -1, -1, 308, 305, + -1, 308, 39, 206, 340, 207, 6, -1, 308, 42, + 206, 340, 207, 6, -1, 308, 43, 206, 340, 207, + 6, -1, 308, 45, 206, 340, 207, 6, -1, 65, + 206, 308, 207, -1, 65, 4, 201, 330, 202, 6, + -1, 68, 206, 308, 207, -1, 68, 4, 201, 330, + 202, 6, -1, 68, 4, 6, -1, 108, 341, 206, + 308, 207, -1, 120, 344, 6, -1, 121, 344, 6, + -1, 120, 206, 308, 207, -1, 121, 206, 308, 207, + -1, 4, 344, 6, -1, 4, 4, 201, 330, 202, + 344, 6, -1, 4, 330, 6, -1, 59, 199, 4, + 200, 203, 4, 6, -1, 100, 4, 6, -1, 115, + 6, -1, 37, 6, -1, 37, 206, 330, 205, 330, + 205, 330, 205, 330, 205, 330, 205, 330, 207, 6, + -1, 38, 6, -1, 110, 199, 330, 8, 330, 200, + -1, 110, 199, 330, 8, 330, 8, 330, 200, -1, + 110, 4, 111, 206, 330, 8, 330, 207, -1, 110, + 4, 111, 206, 330, 8, 330, 8, 330, 207, -1, + 112, -1, 118, 4, -1, 116, -1, 117, 4, 6, + -1, 113, 199, 330, 200, -1, 114, -1, 64, 39, + 206, 330, 205, 332, 207, 6, -1, 64, 39, 206, + 330, 205, 332, 205, 332, 205, 330, 207, 6, -1, + 64, 39, 206, 330, 205, 332, 205, 332, 205, 332, + 205, 330, 207, 6, -1, -1, 64, 39, 206, 330, + 205, 332, 207, 316, 206, 325, 207, 6, -1, -1, + 64, 39, 206, 330, 205, 332, 205, 332, 205, 330, + 207, 317, 206, 325, 207, 6, -1, -1, 64, 39, + 206, 330, 205, 332, 205, 332, 205, 332, 205, 330, + 207, 318, 206, 325, 207, 6, -1, 64, 42, 206, + 330, 205, 332, 207, 6, -1, 64, 42, 206, 330, + 205, 332, 205, 332, 205, 330, 207, 6, -1, 64, + 42, 206, 330, 205, 332, 205, 332, 205, 332, 205, + 330, 207, 6, -1, -1, 64, 42, 206, 330, 205, + 332, 207, 319, 206, 325, 207, 6, -1, -1, 64, + 42, 206, 330, 205, 332, 205, 332, 205, 330, 207, + 320, 206, 325, 207, 6, -1, -1, 64, 42, 206, + 330, 205, 332, 205, 332, 205, 332, 205, 330, 207, + 321, 206, 325, 207, 6, -1, 64, 43, 206, 330, + 205, 332, 207, 6, -1, 64, 43, 206, 330, 205, + 332, 205, 332, 205, 330, 207, 6, -1, 64, 43, + 206, 330, 205, 332, 205, 332, 205, 332, 205, 330, + 207, 6, -1, -1, 64, 43, 206, 330, 205, 332, + 207, 322, 206, 325, 207, 6, -1, -1, 64, 43, + 206, 330, 205, 332, 205, 332, 205, 330, 207, 323, + 206, 325, 207, 6, -1, -1, 64, 43, 206, 330, + 205, 332, 205, 332, 205, 332, 205, 330, 207, 324, + 206, 325, 207, 6, -1, 326, -1, 325, 326, -1, + 72, 206, 338, 205, 338, 205, 338, 207, 6, -1, + 72, 206, 338, 205, 338, 207, 6, -1, 67, 6, + -1, 53, 42, 338, 7, 330, 6, -1, 53, 42, + 338, 7, 330, 56, 58, 330, 6, -1, 53, 42, + 338, 7, 330, 56, 57, 330, 6, -1, 53, 43, + 206, 330, 207, 7, 338, 6, -1, 49, 43, 206, + 330, 207, 7, 338, 6, -1, 53, 45, 206, 330, + 207, 7, 338, 6, -1, 67, 43, 338, 7, 330, + 6, -1, 67, 43, 338, 6, -1, 69, 6, -1, + 70, 6, -1, 125, -1, 126, -1, 127, -1, 128, + -1, 129, -1, 331, -1, 199, 330, 200, -1, 189, + 330, -1, 188, 330, -1, 194, 330, -1, 330, 189, + 330, -1, 330, 188, 330, -1, 330, 190, 330, -1, + 330, 191, 330, -1, 330, 192, 330, -1, 330, 198, + 330, -1, 330, 184, 330, -1, 330, 185, 330, -1, + 330, 187, 330, -1, 330, 186, 330, -1, 330, 183, + 330, -1, 330, 182, 330, -1, 330, 180, 330, -1, + 330, 179, 330, -1, 330, 178, 330, 8, 330, -1, + 12, 199, 330, 200, -1, 13, 199, 330, 200, -1, + 14, 199, 330, 200, -1, 15, 199, 330, 200, -1, + 16, 199, 330, 200, -1, 17, 199, 330, 200, -1, + 18, 199, 330, 200, -1, 19, 199, 330, 200, -1, + 20, 199, 330, 200, -1, 22, 199, 330, 200, -1, + 23, 199, 330, 205, 330, 200, -1, 24, 199, 330, + 200, -1, 25, 199, 330, 200, -1, 26, 199, 330, + 200, -1, 27, 199, 330, 200, -1, 28, 199, 330, + 200, -1, 29, 199, 330, 200, -1, 30, 199, 330, + 205, 330, 200, -1, 31, 199, 330, 205, 330, 200, + -1, 32, 199, 330, 205, 330, 200, -1, 21, 199, + 330, 200, -1, 12, 201, 330, 202, -1, 13, 201, + 330, 202, -1, 14, 201, 330, 202, -1, 15, 201, + 330, 202, -1, 16, 201, 330, 202, -1, 17, 201, + 330, 202, -1, 18, 201, 330, 202, -1, 19, 201, + 330, 202, -1, 20, 201, 330, 202, -1, 22, 201, + 330, 202, -1, 23, 201, 330, 205, 330, 202, -1, + 24, 201, 330, 202, -1, 25, 201, 330, 202, -1, + 26, 201, 330, 202, -1, 27, 201, 330, 202, -1, + 28, 201, 330, 202, -1, 29, 201, 330, 202, -1, + 30, 201, 330, 205, 330, 202, -1, 31, 201, 330, + 205, 330, 202, -1, 32, 201, 330, 205, 330, 202, + -1, 21, 201, 330, 202, -1, 3, -1, 9, -1, + 10, -1, 11, -1, 4, -1, 4, 201, 330, 202, + -1, 204, 4, 201, 202, -1, 4, 303, -1, 4, + 201, 330, 202, 303, -1, 4, 203, 4, -1, 4, + 201, 330, 202, 203, 4, -1, 4, 203, 4, 303, + -1, 4, 201, 330, 202, 203, 4, 303, -1, 333, + -1, 189, 332, -1, 188, 332, -1, 332, 189, 332, + -1, 332, 188, 332, -1, 206, 330, 205, 330, 205, + 330, 205, 330, 205, 330, 207, -1, 206, 330, 205, + 330, 205, 330, 205, 330, 207, -1, 206, 330, 205, + 330, 205, 330, 207, -1, 199, 330, 205, 330, 205, + 330, 200, -1, -1, 199, 335, 200, -1, 5, -1, + 335, 205, 5, -1, -1, 206, 337, 207, -1, 199, + 337, 200, -1, 338, -1, 337, 205, 338, -1, 330, + -1, 339, -1, 206, 340, 207, -1, 189, 206, 340, + 207, -1, 330, 8, 330, -1, 330, 8, 330, 8, + 330, -1, 39, 206, 330, 207, -1, 306, -1, 309, + -1, 315, -1, 4, 201, 202, -1, 189, 4, 201, + 202, -1, 4, 201, 206, 340, 207, 202, -1, 189, + 4, 201, 206, 340, 207, 202, -1, 330, -1, 339, + -1, 340, 205, 330, -1, 340, 205, 339, -1, 206, + 330, 205, 330, 205, 330, 205, 330, 207, -1, 206, + 330, 205, 330, 205, 330, 207, -1, 4, -1, 4, + 203, 108, 203, 4, -1, 206, 343, 207, -1, 4, + 201, 330, 202, 203, 109, -1, 341, -1, 343, 205, + 341, -1, 5, -1, 35, 199, 344, 205, 344, 200, + -1, 36, 199, 344, 200, -1, 34, 199, 344, 200, + -1, 34, 199, 344, 205, 340, 200, -1, 34, 199, + 4, 203, 4, 200, -1, 34, 199, 4, 201, 330, + 202, 203, 4, 200, -1 +}; -#if YYDEBUG != 0 -static const short yyrline[] = { 0, - 165, 167, 168, 169, 174, 176, 179, 181, 184, 192, - 206, 223, 225, 228, 230, 231, 234, 240, 245, 246, - 247, 250, 254, 257, 263, 268, 274, 282, 287, 291, - 297, 302, 306, 311, 315, 318, 323, 327, 331, 335, - 340, 344, 347, 351, 355, 359, 363, 367, 371, 374, - 378, 381, 385, 388, 395, 397, 400, 402, 403, 404, - 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, - 417, 422, 438, 443, 449, 454, 455, 456, 457, 458, - 459, 460, 461, 462, 463, 464, 465, 466, 467, 468, - 469, 470, 471, 472, 473, 474, 475, 476, 477, 478, - 479, 482, 485, 489, 495, 501, 504, 508, 515, 524, - 527, 531, 538, 547, 550, 554, 563, 572, 575, 579, - 588, 597, 600, 604, 613, 622, 625, 629, 642, 651, - 654, 658, 671, 680, 683, 687, 700, 709, 712, 716, - 730, 739, 742, 746, 760, 769, 772, 776, 790, 799, - 802, 806, 820, 829, 832, 836, 850, 859, 862, 866, - 880, 889, 892, 896, 920, 929, 932, 936, 960, 969, - 972, 976, 1000, 1009, 1012, 1016, 1035, 1044, 1047, 1051, - 1070, 1079, 1082, 1086, 1105, 1114, 1117, 1121, 1139, 1148, - 1151, 1155, 1173, 1182, 1185, 1189, 1207, 1216, 1222, 1229, - 1237, 1243, 1249, 1256, 1264, 1273, 1275, 1276, 1277, 1278, - 1281, 1283, 1286, 1318, 1354, 1403, 1419, 1429, 1447, 1460, - 1476, 1501, 1527, 1540, 1556, 1569, 1585, 1604, 1626, 1635, - 1649, 1669, 1685, 1704, 1723, 1741, 1759, 1777, 1803, 1821, - 1847, 1866, 1890, 1914, 1940, 1957, 1975, 1994, 2013, 2052, - 2077, 2099, 2115, 2134, 2153, 2169, 2188, 2205, 2222, 2242, - 2248, 2253, 2258, 2265, 2267, 2268, 2271, 2276, 2280, 2296, - 2312, 2328, 2348, 2362, 2372, 2382, 2392, 2401, 2415, 2423, - 2428, 2439, 2452, 2496, 2510, 2525, 2534, 2544, 2548, 2552, - 2556, 2567, 2583, 2597, 2622, 2647, 2674, 2680, 2685, 2690, - 2694, 2702, 2721, 2737, 2753, 2758, 2774, 2779, 2795, 2800, - 2818, 2841, 2864, 2887, 2892, 2915, 2920, 2943, 2948, 2974, - 2997, 3020, 3043, 3048, 3071, 3077, 3100, 3106, 3131, 3135, - 3140, 3167, 3191, 3199, 3218, 3236, 3254, 3281, 3307, 3333, - 3347, 3365, 3370, 3379, 3381, 3382, 3383, 3384, 3387, 3389, - 3390, 3391, 3392, 3393, 3394, 3395, 3396, 3403, 3404, 3405, - 3406, 3407, 3408, 3409, 3410, 3411, 3412, 3413, 3414, 3415, - 3416, 3417, 3418, 3419, 3420, 3421, 3422, 3423, 3424, 3425, - 3426, 3427, 3428, 3429, 3430, 3431, 3432, 3433, 3434, 3436, - 3437, 3438, 3439, 3440, 3441, 3442, 3443, 3444, 3445, 3446, - 3447, 3448, 3449, 3450, 3451, 3452, 3453, 3454, 3455, 3456, - 3461, 3466, 3467, 3468, 3472, 3484, 3503, 3516, 3528, 3550, - 3567, 3584, 3601, 3620, 3625, 3629, 3633, 3637, 3643, 3648, - 3652, 3656, 3662, 3666, 3671, 3675, 3680, 3684, 3688, 3694, - 3700, 3707, 3713, 3717, 3721, 3732, 3739, 3750, 3770, 3780, - 3790, 3802, 3818, 3836, 3859, 3886, 3892, 3896, 3900, 3912, - 3917, 3929, 3935, 3955, 3960, 3973, 3979, 3985, 3990, 3998, - 4012, 4016, 4035, 4051 +/* YYRLINE[YYN] -- source line where rule number YYN was defined. */ +static const unsigned short yyrline[] = +{ + 0, 166, 166, 167, 168, 169, 175, 176, 179, 181, + 185, 192, 206, 223, 225, 229, 230, 231, 235, 240, + 245, 246, 247, 251, 254, 257, 264, 268, 274, 282, + 287, 291, 297, 302, 306, 311, 315, 318, 323, 327, + 331, 335, 340, 344, 347, 351, 355, 359, 363, 367, + 371, 374, 378, 381, 385, 388, 395, 397, 401, 402, + 403, 404, 405, 406, 407, 408, 409, 410, 411, 412, + 413, 414, 418, 422, 439, 443, 451, 454, 455, 456, + 457, 458, 459, 460, 461, 462, 463, 464, 465, 466, + 467, 468, 469, 470, 471, 472, 473, 474, 475, 476, + 477, 478, 479, 480, 484, 486, 492, 491, 503, 505, + 511, 510, 526, 528, 534, 533, 549, 551, 558, 556, + 574, 576, 583, 581, 599, 601, 608, 606, 624, 626, + 634, 631, 653, 655, 663, 660, 682, 684, 692, 689, + 711, 713, 722, 718, 741, 743, 752, 748, 771, 773, + 782, 778, 801, 803, 812, 808, 831, 833, 842, 838, + 861, 863, 872, 868, 891, 893, 906, 898, 931, 933, + 946, 938, 971, 973, 986, 978, 1011, 1013, 1024, 1018, + 1046, 1048, 1059, 1053, 1081, 1083, 1094, 1088, 1116, 1118, + 1128, 1123, 1150, 1152, 1162, 1157, 1184, 1186, 1196, 1191, + 1218, 1223, 1232, 1231, 1245, 1250, 1259, 1258, 1272, 1281, + 1282, 1283, 1284, 1285, 1289, 1290, 1297, 1325, 1361, 1410, + 1426, 1436, 1454, 1467, 1483, 1508, 1534, 1547, 1563, 1576, + 1592, 1611, 1633, 1642, 1660, 1676, 1692, 1711, 1730, 1748, + 1766, 1784, 1810, 1828, 1854, 1873, 1897, 1921, 1947, 1964, + 1982, 2001, 2020, 2059, 2084, 2106, 2122, 2141, 2160, 2176, + 2195, 2212, 2229, 2250, 2255, 2260, 2265, 2273, 2274, 2275, + 2280, 2283, 2287, 2303, 2319, 2335, 2356, 2369, 2380, 2389, + 2399, 2409, 2423, 2430, 2435, 2446, 2460, 2503, 2517, 2532, + 2541, 2551, 2555, 2559, 2563, 2576, 2590, 2604, 2629, 2654, + 2681, 2687, 2692, 2697, 2701, 2712, 2728, 2744, 2761, 2760, + 2782, 2781, 2803, 2802, 2825, 2848, 2871, 2895, 2894, 2923, + 2922, 2951, 2950, 2981, 3004, 3027, 3051, 3050, 3079, 3078, + 3108, 3107, 3139, 3142, 3148, 3174, 3198, 3207, 3225, 3243, + 3261, 3288, 3314, 3340, 3354, 3373, 3377, 3387, 3388, 3389, + 3390, 3391, 3395, 3396, 3397, 3398, 3399, 3400, 3401, 3402, + 3403, 3410, 3411, 3412, 3413, 3414, 3415, 3416, 3417, 3418, + 3419, 3420, 3421, 3422, 3423, 3424, 3425, 3426, 3427, 3428, + 3429, 3430, 3431, 3432, 3433, 3434, 3435, 3436, 3437, 3438, + 3439, 3440, 3441, 3443, 3444, 3445, 3446, 3447, 3448, 3449, + 3450, 3451, 3452, 3453, 3454, 3455, 3456, 3457, 3458, 3459, + 3460, 3461, 3462, 3463, 3472, 3473, 3474, 3475, 3479, 3491, + 3510, 3523, 3535, 3557, 3574, 3591, 3608, 3628, 3632, 3636, + 3640, 3644, 3651, 3655, 3659, 3663, 3671, 3673, 3679, 3682, + 3689, 3691, 3695, 3702, 3707, 3715, 3720, 3724, 3728, 3740, + 3746, 3757, 3777, 3787, 3797, 3809, 3825, 3843, 3866, 3894, + 3899, 3903, 3907, 3920, 3924, 3936, 3942, 3963, 3967, 3981, + 3986, 3993, 3997, 4005, 4019, 4023, 4042, 4058 }; #endif - -#if YYDEBUG != 0 || defined (YYERROR_VERBOSE) - -static const char * const yytname[] = { "$","error","$undefined.","tDOUBLE", -"tSTRING","tBIGSTR","tEND","tAFFECT","tDOTS","tPi","tMPI_Rank","tMPI_Size","tExp", -"tLog","tLog10","tSqrt","tSin","tAsin","tCos","tAcos","tTan","tRand","tAtan", -"tAtan2","tSinh","tCosh","tTanh","tFabs","tFloor","tCeil","tFmod","tModulo", -"tHypot","tPrintf","tSprintf","tStrCat","tStrPrefix","tBoundingBox","tDraw", -"tPoint","tCircle","tEllipse","tLine","tSurface","tSpline","tVolume","tCharacteristic", -"tLength","tParametric","tElliptic","tPlane","tRuled","tTriangulation","tTransfinite", -"tComplex","tPhysical","tUsing","tBump","tProgression","tPlugin","tRotate","tTranslate", -"tSymmetry","tDilate","tExtrude","tDuplicata","tLoop","tRecombine","tDelete", -"tCoherence","tIntersect","tAttractor","tLayers","tScalarPoint","tVectorPoint", -"tTensorPoint","tScalarLine","tVectorLine","tTensorLine","tScalarTriangle","tVectorTriangle", -"tTensorTriangle","tScalarQuadrangle","tVectorQuadrangle","tTensorQuadrangle", -"tScalarTetrahedron","tVectorTetrahedron","tTensorTetrahedron","tScalarHexahedron", -"tVectorHexahedron","tTensorHexahedron","tScalarPrism","tVectorPrism","tTensorPrism", -"tScalarPyramid","tVectorPyramid","tTensorPyramid","tText2D","tText3D","tCombine", -"tBSpline","tBezier","tNurbs","tOrder","tWith","tBounds","tKnots","tColor","tColorTable", -"tFor","tIn","tEndFor","tIf","tEndIf","tExit","tReturn","tCall","tFunction", -"tTrimmed","tShow","tHide","tB_SPLINE_SURFACE_WITH_KNOTS","tB_SPLINE_CURVE_WITH_KNOTS", -"tCARTESIAN_POINT","tTRUE","tFALSE","tUNSPECIFIED","tU","tV","tEDGE_CURVE","tVERTEX_POINT", -"tORIENTED_EDGE","tPLANE","tFACE_OUTER_BOUND","tEDGE_LOOP","tADVANCED_FACE", -"tVECTOR","tDIRECTION","tAXIS2_PLACEMENT_3D","tISO","tENDISO","tENDSEC","tDATA", -"tHEADER","tFILE_DESCRIPTION","tFILE_SCHEMA","tFILE_NAME","tMANIFOLD_SOLID_BREP", -"tCLOSED_SHELL","tADVANCED_BREP_SHAPE_REPRESENTATION","tFACE_BOUND","tCYLINDRICAL_SURFACE", -"tCONICAL_SURFACE","tCIRCLE","tTRIMMED_CURVE","tGEOMETRIC_SET","tCOMPOSITE_CURVE_SEGMENT", -"tCONTINUOUS","tCOMPOSITE_CURVE","tTOROIDAL_SURFACE","tPRODUCT_DEFINITION","tPRODUCT_DEFINITION_SHAPE", -"tSHAPE_DEFINITION_REPRESENTATION","tELLIPSE","tSolid","tEndSolid","tVertex", -"tFacet","tNormal","tOuter","tLoopSTL","tEndLoop","tEndFacet","tAFFECTPLUS", -"tAFFECTMINUS","tAFFECTTIMES","tAFFECTDIVIDE","'?'","tOR","tAND","tEQUAL","tNOTEQUAL", -"tAPPROXEQUAL","'<'","tLESSOREQUAL","'>'","tGREATEROREQUAL","'+'","'-'","'*'", -"'/'","'%'","tCROSSPRODUCT","'!'","tPLUSPLUS","tMINUSMINUS","UNARYPREC","'^'", -"'('","')'","'['","']'","'.'","'#'","','","'{'","'}'","All","SignedDouble","StlFormatItems", -"StlFormatItem","StepFormatItems","StepFormatItem","StepSpecial","StepHeaderItem", -"StepDataItem","GeoFormatItems","GeoFormatItem","Printf","View","Views","ScalarPointValues", -"ScalarPoint","@1","VectorPointValues","VectorPoint","@2","TensorPointValues", -"TensorPoint","@3","ScalarLineValues","ScalarLine","@4","VectorLineValues","VectorLine", -"@5","TensorLineValues","TensorLine","@6","ScalarTriangleValues","ScalarTriangle", -"@7","VectorTriangleValues","VectorTriangle","@8","TensorTriangleValues","TensorTriangle", -"@9","ScalarQuadrangleValues","ScalarQuadrangle","@10","VectorQuadrangleValues", -"VectorQuadrangle","@11","TensorQuadrangleValues","TensorQuadrangle","@12","ScalarTetrahedronValues", -"ScalarTetrahedron","@13","VectorTetrahedronValues","VectorTetrahedron","@14", -"TensorTetrahedronValues","TensorTetrahedron","@15","ScalarHexahedronValues", -"ScalarHexahedron","@16","VectorHexahedronValues","VectorHexahedron","@17","TensorHexahedronValues", -"TensorHexahedron","@18","ScalarPrismValues","ScalarPrism","@19","VectorPrismValues", -"VectorPrism","@20","TensorPrismValues","TensorPrism","@21","ScalarPyramidValues", -"ScalarPyramid","@22","VectorPyramidValues","VectorPyramid","@23","TensorPyramidValues", -"TensorPyramid","@24","Text2DValues","Text2D","@25","Text3DValues","Text3D", -"@26","NumericAffectation","NumericIncrement","Affectation","Shape","Transform", -"MultipleShape","ListOfShapes","Duplicata","Delete","Colorify","Visibility", -"Command","Loop","Extrude","@27","@28","@29","@30","@31","@32","@33","@34","@35", -"ExtrudeParameters","ExtrudeParameter","Transfinite","Coherence","BoolExpr", -"FExpr","FExpr_Single","VExpr","VExpr_Single","ListOfStrings","RecursiveListOfStrings", -"ListOfListOfDouble","RecursiveListOfListOfDouble","ListOfDouble","FExpr_Multi", -"RecursiveListOfDouble","ColorExpr","ListOfColor","RecursiveListOfColor","StringExpr", NULL +#if YYDEBUG || YYERROR_VERBOSE +/* YYTNME[SYMBOL-NUM] -- String name of the symbol SYMBOL-NUM. + First, the terminals, then, starting at YYNTOKENS, nonterminals. */ +static const char *const yytname[] = +{ + "$end", "error", "$undefined", "tDOUBLE", "tSTRING", "tBIGSTR", "tEND", + "tAFFECT", "tDOTS", "tPi", "tMPI_Rank", "tMPI_Size", "tExp", "tLog", + "tLog10", "tSqrt", "tSin", "tAsin", "tCos", "tAcos", "tTan", "tRand", + "tAtan", "tAtan2", "tSinh", "tCosh", "tTanh", "tFabs", "tFloor", + "tCeil", "tFmod", "tModulo", "tHypot", "tPrintf", "tSprintf", "tStrCat", + "tStrPrefix", "tBoundingBox", "tDraw", "tPoint", "tCircle", "tEllipse", + "tLine", "tSurface", "tSpline", "tVolume", "tCharacteristic", "tLength", + "tParametric", "tElliptic", "tPlane", "tRuled", "tTriangulation", + "tTransfinite", "tComplex", "tPhysical", "tUsing", "tBump", + "tProgression", "tPlugin", "tRotate", "tTranslate", "tSymmetry", + "tDilate", "tExtrude", "tDuplicata", "tLoop", "tRecombine", "tDelete", + "tCoherence", "tIntersect", "tAttractor", "tLayers", "tScalarPoint", + "tVectorPoint", "tTensorPoint", "tScalarLine", "tVectorLine", + "tTensorLine", "tScalarTriangle", "tVectorTriangle", "tTensorTriangle", + "tScalarQuadrangle", "tVectorQuadrangle", "tTensorQuadrangle", + "tScalarTetrahedron", "tVectorTetrahedron", "tTensorTetrahedron", + "tScalarHexahedron", "tVectorHexahedron", "tTensorHexahedron", + "tScalarPrism", "tVectorPrism", "tTensorPrism", "tScalarPyramid", + "tVectorPyramid", "tTensorPyramid", "tText2D", "tText3D", + "tInterpolationMatrix", "tCombine", "tBSpline", "tBezier", "tNurbs", + "tOrder", "tWith", "tBounds", "tKnots", "tColor", "tColorTable", "tFor", + "tIn", "tEndFor", "tIf", "tEndIf", "tExit", "tReturn", "tCall", + "tFunction", "tTrimmed", "tShow", "tHide", + "tB_SPLINE_SURFACE_WITH_KNOTS", "tB_SPLINE_CURVE_WITH_KNOTS", + "tCARTESIAN_POINT", "tTRUE", "tFALSE", "tUNSPECIFIED", "tU", "tV", + "tEDGE_CURVE", "tVERTEX_POINT", "tORIENTED_EDGE", "tPLANE", + "tFACE_OUTER_BOUND", "tEDGE_LOOP", "tADVANCED_FACE", "tVECTOR", + "tDIRECTION", "tAXIS2_PLACEMENT_3D", "tISO", "tENDISO", "tENDSEC", + "tDATA", "tHEADER", "tFILE_DESCRIPTION", "tFILE_SCHEMA", "tFILE_NAME", + "tMANIFOLD_SOLID_BREP", "tCLOSED_SHELL", + "tADVANCED_BREP_SHAPE_REPRESENTATION", "tFACE_BOUND", + "tCYLINDRICAL_SURFACE", "tCONICAL_SURFACE", "tCIRCLE", "tTRIMMED_CURVE", + "tGEOMETRIC_SET", "tCOMPOSITE_CURVE_SEGMENT", "tCONTINUOUS", + "tCOMPOSITE_CURVE", "tTOROIDAL_SURFACE", "tPRODUCT_DEFINITION", + "tPRODUCT_DEFINITION_SHAPE", "tSHAPE_DEFINITION_REPRESENTATION", + "tELLIPSE", "tSolid", "tEndSolid", "tVertex", "tFacet", "tNormal", + "tOuter", "tLoopSTL", "tEndLoop", "tEndFacet", "tAFFECTDIVIDE", + "tAFFECTTIMES", "tAFFECTMINUS", "tAFFECTPLUS", "'?'", "tOR", "tAND", + "tAPPROXEQUAL", "tNOTEQUAL", "tEQUAL", "'<'", "'>'", "tGREATEROREQUAL", + "tLESSOREQUAL", "'+'", "'-'", "'*'", "'/'", "'%'", "tCROSSPRODUCT", + "'!'", "UNARYPREC", "tMINUSMINUS", "tPLUSPLUS", "'^'", "'('", "')'", + "'['", "']'", "'.'", "'#'", "','", "'{'", "'}'", "$accept", "All", + "SignedDouble", "StlFormatItems", "StlFormatItem", "StepFormatItems", + "StepFormatItem", "StepSpecial", "StepHeaderItem", "StepDataItem", + "GeoFormatItems", "GeoFormatItem", "Printf", "View", "Views", + "ScalarPointValues", "ScalarPoint", "@1", "VectorPointValues", + "VectorPoint", "@2", "TensorPointValues", "TensorPoint", "@3", + "ScalarLineValues", "ScalarLine", "@4", "VectorLineValues", + "VectorLine", "@5", "TensorLineValues", "TensorLine", "@6", + "ScalarTriangleValues", "ScalarTriangle", "@7", "VectorTriangleValues", + "VectorTriangle", "@8", "TensorTriangleValues", "TensorTriangle", "@9", + "ScalarQuadrangleValues", "ScalarQuadrangle", "@10", + "VectorQuadrangleValues", "VectorQuadrangle", "@11", + "TensorQuadrangleValues", "TensorQuadrangle", "@12", + "ScalarTetrahedronValues", "ScalarTetrahedron", "@13", + "VectorTetrahedronValues", "VectorTetrahedron", "@14", + "TensorTetrahedronValues", "TensorTetrahedron", "@15", + "ScalarHexahedronValues", "ScalarHexahedron", "@16", + "VectorHexahedronValues", "VectorHexahedron", "@17", + "TensorHexahedronValues", "TensorHexahedron", "@18", + "ScalarPrismValues", "ScalarPrism", "@19", "VectorPrismValues", + "VectorPrism", "@20", "TensorPrismValues", "TensorPrism", "@21", + "ScalarPyramidValues", "ScalarPyramid", "@22", "VectorPyramidValues", + "VectorPyramid", "@23", "TensorPyramidValues", "TensorPyramid", "@24", + "Text2DValues", "Text2D", "@25", "Text3DValues", "Text3D", "@26", + "InterpolationMatrix", "NumericAffectation", "NumericIncrement", + "Affectation", "Shape", "Transform", "MultipleShape", "ListOfShapes", + "Duplicata", "Delete", "Colorify", "Visibility", "Command", "Loop", + "Extrude", "@27", "@28", "@29", "@30", "@31", "@32", "@33", "@34", + "@35", "ExtrudeParameters", "ExtrudeParameter", "Transfinite", + "Coherence", "BoolExpr", "FExpr", "FExpr_Single", "VExpr", + "VExpr_Single", "ListOfStrings", "RecursiveListOfStrings", + "ListOfListOfDouble", "RecursiveListOfListOfDouble", "ListOfDouble", + "FExpr_Multi", "RecursiveListOfDouble", "ColorExpr", "ListOfColor", + "RecursiveListOfColor", "StringExpr", 0 }; #endif -static const short yyr1[] = { 0, - 207, 207, 207, 207, 208, 208, 209, 209, 210, 210, - 210, 211, 211, 212, 212, 212, 213, 213, 213, 213, - 213, 214, 214, 214, 215, 215, 215, 215, 215, 215, - 215, 215, 215, 215, 215, 215, 215, 215, 215, 215, - 215, 215, 215, 215, 215, 215, 215, 215, 215, 215, - 215, 215, 215, 215, 216, 216, 217, 217, 217, 217, - 217, 217, 217, 217, 217, 217, 217, 217, 217, 217, - 218, 218, 219, 219, 220, 220, 220, 220, 220, 220, - 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, - 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, - 220, 221, 221, 223, 222, 224, 224, 226, 225, 227, - 227, 229, 228, 230, 230, 232, 231, 233, 233, 235, - 234, 236, 236, 238, 237, 239, 239, 241, 240, 242, - 242, 244, 243, 245, 245, 247, 246, 248, 248, 250, - 249, 251, 251, 253, 252, 254, 254, 256, 255, 257, - 257, 259, 258, 260, 260, 262, 261, 263, 263, 265, - 264, 266, 266, 268, 267, 269, 269, 271, 270, 272, - 272, 274, 273, 275, 275, 277, 276, 278, 278, 280, - 279, 281, 281, 283, 282, 284, 284, 286, 285, 287, - 287, 289, 288, 290, 290, 292, 291, 293, 293, 295, - 294, 296, 296, 298, 297, 299, 299, 299, 299, 299, - 300, 300, 301, 301, 301, 301, 301, 301, 301, 301, - 301, 301, 301, 301, 301, 301, 301, 301, 301, 301, - 302, 302, 302, 302, 302, 302, 302, 302, 302, 302, - 302, 302, 302, 302, 302, 302, 302, 302, 302, 302, - 302, 302, 302, 302, 302, 302, 302, 302, 302, 303, - 303, 303, 303, 304, 304, 304, 305, 305, 305, 305, - 305, 305, 306, 306, 307, 307, 307, 308, 309, 309, - 309, 309, 310, 310, 310, 310, 310, 310, 310, 310, - 310, 311, 311, 311, 311, 311, 311, 311, 311, 311, - 311, 312, 312, 312, 313, 312, 314, 312, 315, 312, - 312, 312, 312, 316, 312, 317, 312, 318, 312, 312, - 312, 312, 319, 312, 320, 312, 321, 312, 322, 322, - 323, 323, 323, 324, 324, 324, 324, 324, 324, 324, - 324, 325, 325, 326, 326, 326, 326, 326, 327, 327, - 327, 327, 327, 327, 327, 327, 327, 327, 327, 327, - 327, 327, 327, 327, 327, 327, 327, 327, 327, 327, - 327, 327, 327, 327, 327, 327, 327, 327, 327, 327, - 327, 327, 327, 327, 327, 327, 327, 327, 327, 327, - 327, 327, 327, 327, 327, 327, 327, 327, 327, 327, - 327, 327, 327, 327, 327, 327, 327, 327, 327, 327, - 328, 328, 328, 328, 328, 328, 328, 328, 328, 328, - 328, 328, 328, 329, 329, 329, 329, 329, 330, 330, - 330, 330, 331, 331, 332, 332, 333, 333, 333, 334, - 334, 335, 335, 335, 335, 336, 336, 336, 336, 336, - 336, 336, 336, 336, 336, 337, 337, 337, 337, 338, - 338, 338, 338, 339, 339, 340, 340, 341, 341, 341, - 341, 341, 341, 341 +# ifdef YYPRINT +/* YYTOKNUM[YYLEX-NUM] -- Internal token number corresponding to + token YYLEX-NUM. */ +static const unsigned short yytoknum[] = +{ + 0, 256, 257, 258, 259, 260, 261, 262, 263, 264, + 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, + 275, 276, 277, 278, 279, 280, 281, 282, 283, 284, + 285, 286, 287, 288, 289, 290, 291, 292, 293, 294, + 295, 296, 297, 298, 299, 300, 301, 302, 303, 304, + 305, 306, 307, 308, 309, 310, 311, 312, 313, 314, + 315, 316, 317, 318, 319, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 331, 332, 333, 334, + 335, 336, 337, 338, 339, 340, 341, 342, 343, 344, + 345, 346, 347, 348, 349, 350, 351, 352, 353, 354, + 355, 356, 357, 358, 359, 360, 361, 362, 363, 364, + 365, 366, 367, 368, 369, 370, 371, 372, 373, 374, + 375, 376, 377, 378, 379, 380, 381, 382, 383, 384, + 385, 386, 387, 388, 389, 390, 391, 392, 393, 394, + 395, 396, 397, 398, 399, 400, 401, 402, 403, 404, + 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, + 415, 416, 417, 418, 419, 420, 421, 422, 423, 424, + 425, 426, 427, 428, 429, 430, 431, 432, 63, 433, + 434, 435, 436, 437, 60, 62, 438, 439, 43, 45, + 42, 47, 37, 440, 33, 441, 442, 443, 94, 40, + 41, 91, 93, 46, 35, 44, 123, 125 }; - -static const short yyr2[] = { 0, - 1, 1, 1, 2, 1, 2, 0, 2, 1, 21, - 1, 0, 2, 1, 1, 1, 2, 2, 2, 2, - 2, 7, 5, 17, 9, 23, 31, 15, 11, 11, - 15, 9, 13, 9, 11, 13, 9, 9, 11, 9, - 11, 9, 11, 13, 13, 11, 13, 17, 9, 11, - 11, 13, 11, 9, 0, 2, 1, 1, 1, 1, - 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, - 5, 7, 6, 8, 0, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, - 2, 1, 3, 0, 13, 1, 3, 0, 13, 1, - 3, 0, 13, 1, 3, 0, 19, 1, 3, 0, - 19, 1, 3, 0, 19, 1, 3, 0, 25, 1, - 3, 0, 25, 1, 3, 0, 25, 1, 3, 0, - 31, 1, 3, 0, 31, 1, 3, 0, 31, 1, - 3, 0, 31, 1, 3, 0, 31, 1, 3, 0, - 31, 1, 3, 0, 55, 1, 3, 0, 55, 1, - 3, 0, 55, 1, 3, 0, 43, 1, 3, 0, - 43, 1, 3, 0, 43, 1, 3, 0, 37, 1, - 3, 0, 37, 1, 3, 0, 37, 1, 3, 0, - 13, 1, 3, 0, 15, 1, 1, 1, 1, 1, - 1, 1, 4, 7, 9, 6, 3, 6, 6, 9, - 6, 9, 5, 8, 8, 11, 6, 9, 9, 9, - 7, 8, 12, 6, 7, 7, 7, 9, 7, 9, - 17, 7, 7, 11, 8, 12, 8, 8, 8, 12, - 14, 14, 22, 20, 8, 8, 8, 7, 8, 5, - 11, 5, 9, 1, 1, 1, 0, 2, 6, 6, - 6, 6, 4, 6, 4, 6, 3, 5, 3, 3, - 4, 4, 3, 7, 3, 7, 3, 2, 2, 15, - 2, 6, 8, 8, 10, 1, 2, 1, 3, 4, - 1, 8, 12, 14, 0, 12, 0, 16, 0, 18, - 8, 12, 14, 0, 12, 0, 16, 0, 18, 8, - 12, 14, 0, 12, 0, 16, 0, 18, 1, 2, - 9, 7, 2, 6, 9, 9, 8, 8, 8, 6, - 4, 2, 2, 1, 1, 1, 1, 1, 1, 3, - 2, 2, 2, 3, 3, 3, 3, 3, 3, 3, - 3, 3, 3, 3, 3, 3, 3, 5, 4, 4, - 4, 4, 4, 4, 4, 4, 4, 4, 6, 4, - 4, 4, 4, 4, 4, 6, 6, 6, 4, 4, - 4, 4, 4, 4, 4, 4, 4, 4, 4, 6, - 4, 4, 4, 4, 4, 4, 6, 6, 6, 4, - 1, 1, 1, 1, 1, 4, 4, 2, 5, 3, - 6, 4, 7, 1, 2, 2, 3, 3, 11, 9, - 7, 7, 0, 3, 1, 3, 0, 3, 3, 1, - 3, 1, 1, 3, 4, 3, 5, 4, 1, 1, - 1, 3, 4, 6, 7, 1, 1, 3, 3, 9, - 7, 1, 5, 3, 6, 1, 3, 1, 6, 4, - 4, 6, 6, 9 +# endif + +/* YYR1[YYN] -- Symbol number of symbol that rule YYN derives. */ +static const unsigned short yyr1[] = +{ + 0, 208, 209, 209, 209, 209, 210, 210, 211, 211, + 212, 212, 212, 213, 213, 214, 214, 214, 215, 215, + 215, 215, 215, 216, 216, 216, 217, 217, 217, 217, + 217, 217, 217, 217, 217, 217, 217, 217, 217, 217, + 217, 217, 217, 217, 217, 217, 217, 217, 217, 217, + 217, 217, 217, 217, 217, 217, 218, 218, 219, 219, + 219, 219, 219, 219, 219, 219, 219, 219, 219, 219, + 219, 219, 220, 220, 221, 221, 222, 222, 222, 222, + 222, 222, 222, 222, 222, 222, 222, 222, 222, 222, + 222, 222, 222, 222, 222, 222, 222, 222, 222, 222, + 222, 222, 222, 222, 223, 223, 225, 224, 226, 226, + 228, 227, 229, 229, 231, 230, 232, 232, 234, 233, + 235, 235, 237, 236, 238, 238, 240, 239, 241, 241, + 243, 242, 244, 244, 246, 245, 247, 247, 249, 248, + 250, 250, 252, 251, 253, 253, 255, 254, 256, 256, + 258, 257, 259, 259, 261, 260, 262, 262, 264, 263, + 265, 265, 267, 266, 268, 268, 270, 269, 271, 271, + 273, 272, 274, 274, 276, 275, 277, 277, 279, 278, + 280, 280, 282, 281, 283, 283, 285, 284, 286, 286, + 288, 287, 289, 289, 291, 290, 292, 292, 294, 293, + 295, 295, 297, 296, 298, 298, 300, 299, 301, 302, + 302, 302, 302, 302, 303, 303, 304, 304, 304, 304, + 304, 304, 304, 304, 304, 304, 304, 304, 304, 304, + 304, 304, 304, 304, 305, 305, 305, 305, 305, 305, + 305, 305, 305, 305, 305, 305, 305, 305, 305, 305, + 305, 305, 305, 305, 305, 305, 305, 305, 305, 305, + 305, 305, 305, 306, 306, 306, 306, 307, 307, 307, + 308, 308, 308, 308, 308, 308, 309, 309, 310, 310, + 310, 311, 312, 312, 312, 312, 313, 313, 313, 313, + 313, 313, 313, 313, 313, 314, 314, 314, 314, 314, + 314, 314, 314, 314, 314, 315, 315, 315, 316, 315, + 317, 315, 318, 315, 315, 315, 315, 319, 315, 320, + 315, 321, 315, 315, 315, 315, 322, 315, 323, 315, + 324, 315, 325, 325, 326, 326, 326, 327, 327, 327, + 327, 327, 327, 327, 327, 328, 328, 329, 329, 329, + 329, 329, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 331, 331, 331, 331, 331, 331, + 331, 331, 331, 331, 331, 331, 331, 332, 332, 332, + 332, 332, 333, 333, 333, 333, 334, 334, 335, 335, + 336, 336, 336, 337, 337, 338, 338, 338, 338, 339, + 339, 339, 339, 339, 339, 339, 339, 339, 339, 340, + 340, 340, 340, 341, 341, 341, 341, 342, 342, 343, + 343, 344, 344, 344, 344, 344, 344, 344 }; -static const short yydefact[] = { 0, - 0, 2, 1, 3, 4, 9, 11, 0, 8, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 13, 14, - 16, 15, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 296, 0, 301, 0, 298, 0, 0, 0, 0, 0, - 56, 58, 57, 59, 60, 61, 62, 63, 64, 65, - 70, 69, 66, 67, 68, 0, 0, 17, 18, 20, - 19, 21, 433, 433, 0, 411, 415, 468, 206, 412, - 413, 414, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 207, 208, 209, 210, - 0, 0, 0, 211, 212, 0, 0, 0, 0, 0, - 0, 0, 349, 0, 0, 289, 0, 291, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 424, 0, 0, - 0, 0, 0, 0, 267, 0, 0, 267, 342, 343, - 0, 0, 0, 0, 0, 0, 0, 462, 0, 0, - 0, 0, 0, 288, 0, 297, 0, 468, 267, 0, - 267, 0, 5, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 418, 0, 75, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 415, - 352, 351, 353, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 217, 285, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 283, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 415, 0, 0, 0, 449, 450, 451, 442, 0, 443, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 426, 425, 0, 0, - 0, 0, 267, 267, 0, 0, 0, 0, 0, 0, - 0, 277, 0, 0, 0, 0, 287, 0, 0, 0, - 0, 0, 0, 0, 267, 0, 0, 0, 299, 0, - 0, 279, 0, 280, 6, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 435, 0, 0, 0, - 0, 0, 420, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 350, 0, 0, 456, 457, 0, 0, 206, - 0, 0, 0, 0, 0, 213, 0, 367, 366, 364, - 365, 360, 362, 361, 363, 355, 354, 356, 357, 358, - 359, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 415, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 428, 427, 266, - 0, 265, 264, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 273, 268, 341, 0, 0, 275, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 300, 0, 281, 282, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 434, 0, 0, 23, - 0, 416, 422, 75, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 76, 77, 78, 79, 80, 81, 82, 83, 84, - 85, 86, 87, 88, 89, 90, 91, 92, 93, 94, - 95, 96, 97, 98, 99, 100, 101, 369, 390, 370, - 391, 371, 392, 372, 393, 373, 394, 374, 395, 375, - 396, 376, 397, 377, 398, 389, 410, 378, 399, 0, - 0, 380, 401, 381, 402, 382, 403, 383, 404, 384, - 405, 385, 406, 0, 0, 0, 0, 0, 0, 0, - 0, 471, 0, 0, 470, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 223, 0, 0, 0, 0, 417, - 0, 71, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 452, 0, 0, 0, 0, 444, 446, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 260, 262, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 278, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 436, 0, 433, 0, 419, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 73, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 416, 216, 458, 459, 0, 0, 0, 0, 0, - 218, 219, 221, 0, 0, 466, 0, 227, 368, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 448, 453, 0, 445, 0, 234, 0, 0, 0, 0, - 0, 0, 334, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 274, - 0, 0, 0, 0, 340, 276, 0, 0, 0, 0, - 0, 437, 0, 463, 0, 0, 0, 292, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 344, 345, 346, 347, 348, 0, 0, - 0, 0, 0, 0, 0, 22, 0, 421, 284, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 379, 400, 386, 407, - 387, 408, 388, 409, 0, 473, 472, 469, 0, 206, - 0, 0, 0, 0, 214, 0, 0, 0, 464, 72, - 0, 231, 237, 0, 239, 0, 0, 235, 0, 236, - 258, 0, 0, 447, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 286, - 0, 0, 0, 0, 267, 0, 305, 0, 314, 0, - 323, 0, 0, 0, 0, 0, 0, 242, 243, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 433, - 423, 74, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 224, 0, 0, 225, 0, 467, 0, 0, - 0, 245, 255, 454, 0, 0, 338, 248, 249, 0, - 0, 0, 0, 337, 339, 257, 232, 247, 256, 259, - 0, 0, 0, 432, 0, 431, 0, 0, 302, 0, - 0, 311, 0, 0, 320, 0, 269, 270, 271, 272, - 0, 0, 437, 0, 440, 0, 0, 0, 0, 461, - 0, 294, 293, 0, 0, 0, 0, 0, 25, 0, - 34, 0, 38, 0, 32, 0, 0, 37, 0, 42, - 40, 0, 0, 0, 0, 0, 0, 49, 0, 0, - 0, 0, 0, 54, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 215, 220, 222, 0, 228, 0, 0, - 238, 240, 455, 0, 0, 0, 336, 335, 229, 230, - 267, 0, 263, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 439, 0, 438, 0, 0, 0, 0, 0, - 0, 0, 437, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 474, - 0, 465, 0, 0, 0, 0, 0, 0, 430, 0, - 0, 0, 0, 0, 0, 0, 0, 329, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 441, 0, 0, - 460, 295, 0, 0, 39, 0, 0, 0, 0, 29, - 0, 35, 0, 41, 30, 43, 0, 46, 0, 50, - 51, 0, 0, 53, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 226, 0, 0, 0, 0, 261, 0, 0, - 307, 0, 333, 0, 0, 330, 316, 0, 0, 325, - 0, 0, 0, 0, 0, 0, 244, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 104, 108, 112, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 200, 0, 0, 0, 0, - 0, 429, 303, 0, 0, 0, 306, 312, 0, 0, - 315, 321, 0, 0, 324, 233, 246, 0, 0, 250, - 0, 0, 0, 0, 0, 33, 36, 44, 0, 45, - 52, 47, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 309, 0, 0, 318, 0, 327, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 204, 0, 0, 252, 251, 0, - 304, 0, 0, 0, 313, 0, 0, 322, 0, 0, - 0, 0, 0, 0, 28, 31, 0, 0, 0, 102, - 0, 106, 0, 110, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 198, 0, 290, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 308, 0, 0, 332, - 317, 0, 326, 0, 0, 0, 0, 0, 0, 48, - 24, 103, 105, 107, 109, 111, 113, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 199, 201, - 0, 202, 241, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 116, 120, 124, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 310, 331, 319, 328, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 203, 205, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 254, 10, 0, 0, 0, 114, - 0, 118, 0, 122, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 253, - 0, 26, 115, 117, 119, 121, 123, 125, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 128, 132, 136, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 126, 0, 130, 0, 134, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 127, 129, - 131, 133, 135, 137, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 140, 144, 148, 152, 156, 160, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 27, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 138, 0, 142, - 0, 146, 0, 150, 0, 154, 0, 158, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 139, 141, - 143, 145, 147, 149, 151, 153, 155, 157, 159, 161, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 188, 192, 196, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 186, 0, 190, 0, 194, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 187, 189, 191, 193, - 195, 197, 0, 0, 0, 176, 180, 184, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 174, 0, 178, 0, 182, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 175, 177, 179, 181, 183, 185, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 164, 168, 172, 0, 0, - 0, 0, 0, 0, 0, 162, 0, 166, 0, 170, - 0, 0, 0, 0, 0, 0, 163, 165, 167, 169, - 171, 173, 0, 0, 0 +/* YYR2[YYN] -- Number of symbols composing right hand side of rule YYN. */ +static const unsigned char yyr2[] = +{ + 0, 2, 1, 1, 1, 2, 1, 2, 0, 2, + 1, 21, 1, 0, 2, 1, 1, 1, 2, 2, + 2, 2, 2, 7, 5, 17, 9, 23, 31, 15, + 11, 11, 15, 9, 13, 9, 11, 13, 9, 9, + 11, 9, 11, 9, 11, 13, 13, 11, 13, 17, + 9, 11, 11, 13, 11, 9, 0, 2, 1, 1, + 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, + 1, 1, 5, 7, 6, 8, 0, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 1, 3, 0, 13, 1, 3, + 0, 13, 1, 3, 0, 13, 1, 3, 0, 19, + 1, 3, 0, 19, 1, 3, 0, 19, 1, 3, + 0, 25, 1, 3, 0, 25, 1, 3, 0, 25, + 1, 3, 0, 31, 1, 3, 0, 31, 1, 3, + 0, 31, 1, 3, 0, 31, 1, 3, 0, 31, + 1, 3, 0, 31, 1, 3, 0, 55, 1, 3, + 0, 55, 1, 3, 0, 55, 1, 3, 0, 43, + 1, 3, 0, 43, 1, 3, 0, 43, 1, 3, + 0, 37, 1, 3, 0, 37, 1, 3, 0, 37, + 1, 3, 0, 13, 1, 3, 0, 15, 3, 1, + 1, 1, 1, 1, 1, 1, 4, 7, 9, 6, + 3, 6, 6, 9, 6, 9, 5, 8, 8, 11, + 6, 9, 9, 9, 7, 8, 12, 6, 7, 7, + 7, 9, 7, 9, 17, 7, 7, 11, 8, 12, + 8, 8, 8, 12, 14, 14, 22, 20, 8, 8, + 8, 7, 8, 5, 11, 5, 9, 1, 1, 1, + 0, 2, 6, 6, 6, 6, 4, 6, 4, 6, + 3, 5, 3, 3, 4, 4, 3, 7, 3, 7, + 3, 2, 2, 15, 2, 6, 8, 8, 10, 1, + 2, 1, 3, 4, 1, 8, 12, 14, 0, 12, + 0, 16, 0, 18, 8, 12, 14, 0, 12, 0, + 16, 0, 18, 8, 12, 14, 0, 12, 0, 16, + 0, 18, 1, 2, 9, 7, 2, 6, 9, 9, + 8, 8, 8, 6, 4, 2, 2, 1, 1, 1, + 1, 1, 1, 3, 2, 2, 2, 3, 3, 3, + 3, 3, 3, 3, 3, 3, 3, 3, 3, 3, + 3, 5, 4, 4, 4, 4, 4, 4, 4, 4, + 4, 4, 6, 4, 4, 4, 4, 4, 4, 6, + 6, 6, 4, 4, 4, 4, 4, 4, 4, 4, + 4, 4, 4, 6, 4, 4, 4, 4, 4, 4, + 6, 6, 6, 4, 1, 1, 1, 1, 1, 4, + 4, 2, 5, 3, 6, 4, 7, 1, 2, 2, + 3, 3, 11, 9, 7, 7, 0, 3, 1, 3, + 0, 3, 3, 1, 3, 1, 1, 3, 4, 3, + 5, 4, 1, 1, 1, 3, 4, 6, 7, 1, + 1, 3, 3, 9, 7, 1, 5, 3, 6, 1, + 3, 1, 6, 4, 4, 6, 6, 9 }; -static const short yydefgoto[] = { 2353, - 215, 2, 9, 3, 19, 20, 21, 22, 4, 71, - 72, 73, 445, 1669, 662, 1574, 1671, 663, 1575, 1673, - 664, 1576, 1889, 665, 1835, 1891, 666, 1836, 1893, 667, - 1837, 2025, 668, 1987, 2027, 669, 1988, 2029, 670, 1989, - 2137, 671, 2107, 2139, 672, 2108, 2141, 673, 2109, 2143, - 674, 2110, 2145, 675, 2111, 2147, 676, 2112, 2335, 677, - 2329, 2337, 678, 2330, 2339, 679, 2331, 2284, 680, 2272, - 2286, 681, 2273, 2288, 682, 2274, 2233, 683, 2215, 2235, - 684, 2216, 2237, 685, 2217, 1696, 686, 1598, 1791, 687, - 1698, 140, 252, 74, 575, 345, 561, 562, 346, 78, - 79, 80, 81, 82, 347, 1220, 1544, 1652, 1223, 1549, - 1656, 1226, 1553, 1659, 1407, 1408, 84, 85, 999, 348, - 143, 367, 178, 247, 438, 1113, 1234, 1235, 350, 498, - 200, 749, 907, 144 +/* YYDEFACT[STATE-NAME] -- Default rule to reduce with in state + STATE-NUM when YYTABLE doesn't specify something else to do. Zero + means the default is an error. */ +static const unsigned short yydefact[] = +{ + 0, 0, 0, 3, 2, 4, 5, 1, 10, 12, + 0, 9, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 14, 15, 17, 16, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 299, 0, 304, 0, 301, 0, 0, + 0, 0, 0, 57, 59, 58, 60, 61, 62, 63, + 64, 65, 66, 71, 70, 67, 68, 69, 0, 0, + 18, 19, 21, 20, 22, 436, 436, 0, 414, 418, + 471, 209, 415, 416, 417, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 213, + 212, 211, 210, 0, 0, 0, 215, 214, 0, 0, + 0, 0, 0, 0, 0, 352, 0, 0, 292, 0, + 294, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 427, 0, 0, 0, 0, 0, 0, 270, 0, 0, + 270, 345, 346, 0, 0, 0, 0, 0, 0, 0, + 465, 0, 0, 0, 0, 0, 291, 0, 300, 0, + 471, 270, 0, 270, 0, 6, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 421, 0, 76, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 418, 355, 354, 356, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 220, 288, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 286, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 418, 0, 0, 0, 452, 453, 454, + 445, 0, 446, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 429, + 428, 0, 0, 0, 0, 270, 270, 0, 0, 0, + 0, 0, 0, 0, 280, 0, 0, 0, 0, 290, + 0, 0, 0, 0, 0, 0, 0, 270, 0, 0, + 0, 302, 0, 0, 282, 0, 283, 7, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 438, + 0, 0, 0, 0, 0, 423, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 353, 0, 0, 459, 460, + 0, 0, 209, 0, 0, 0, 0, 0, 216, 0, + 370, 369, 368, 367, 363, 364, 366, 365, 358, 357, + 359, 360, 361, 362, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 418, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 431, 430, 269, 0, 268, 267, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 276, 271, 344, 0, + 0, 278, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 303, 0, 284, 285, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 437, + 0, 0, 24, 0, 419, 425, 76, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 440, 0, 77, 78, 79, 80, 81, + 82, 83, 84, 85, 86, 87, 88, 89, 90, 91, + 92, 93, 94, 95, 96, 97, 98, 99, 100, 101, + 102, 103, 372, 393, 373, 394, 374, 395, 375, 396, + 376, 397, 377, 398, 378, 399, 379, 400, 380, 401, + 392, 413, 381, 402, 0, 0, 383, 404, 384, 405, + 385, 406, 386, 407, 387, 408, 388, 409, 0, 0, + 0, 0, 0, 0, 0, 0, 474, 0, 0, 473, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 226, + 0, 0, 0, 0, 420, 0, 72, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 455, 0, 0, + 0, 0, 447, 449, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 263, 265, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 281, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 439, 0, 436, 0, 422, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 74, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 419, + 219, 461, 462, 0, 0, 0, 0, 0, 221, 222, + 224, 0, 0, 469, 0, 230, 371, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 451, 456, + 0, 448, 0, 237, 0, 0, 0, 0, 0, 0, + 337, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 277, 0, 0, + 0, 0, 343, 279, 0, 0, 0, 0, 0, 440, + 0, 466, 0, 0, 0, 295, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 347, 348, 349, 350, 351, 0, 0, 0, 0, + 0, 0, 0, 23, 0, 424, 287, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 443, 0, 208, 382, 403, + 389, 410, 390, 411, 391, 412, 0, 476, 475, 472, + 0, 209, 0, 0, 0, 0, 217, 0, 0, 0, + 467, 73, 0, 234, 240, 0, 242, 0, 0, 238, + 0, 239, 261, 0, 0, 450, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 289, 0, 0, 0, 0, 270, 0, 308, 0, + 317, 0, 326, 0, 0, 0, 0, 0, 0, 245, + 246, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 436, + 426, 75, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 442, 0, + 441, 0, 0, 0, 0, 227, 0, 0, 228, 0, + 470, 0, 0, 0, 248, 258, 457, 0, 0, 341, + 251, 252, 0, 0, 0, 0, 340, 342, 260, 235, + 250, 259, 262, 0, 0, 0, 435, 0, 434, 0, + 0, 305, 0, 0, 314, 0, 0, 323, 0, 272, + 273, 274, 275, 0, 0, 440, 0, 0, 0, 464, + 0, 297, 296, 0, 0, 0, 0, 0, 26, 0, + 35, 0, 39, 0, 33, 0, 0, 38, 0, 43, + 41, 0, 0, 0, 0, 0, 0, 50, 0, 0, + 0, 0, 0, 55, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 444, 0, 218, 223, 225, 0, 231, 0, + 0, 241, 243, 458, 0, 0, 0, 339, 338, 232, + 233, 270, 0, 266, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 440, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 477, 0, 468, + 0, 0, 0, 0, 0, 0, 433, 0, 0, 0, + 0, 0, 0, 0, 0, 332, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 463, 298, 0, + 0, 40, 0, 0, 0, 0, 30, 0, 36, 0, + 42, 31, 44, 0, 47, 0, 51, 52, 0, 0, + 54, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 229, + 0, 0, 0, 0, 264, 0, 0, 310, 0, 336, + 0, 0, 333, 319, 0, 0, 328, 0, 0, 0, + 0, 0, 0, 247, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 106, 110, + 114, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 202, 0, 0, 0, 0, 0, 432, 306, + 0, 0, 0, 309, 315, 0, 0, 318, 324, 0, + 0, 327, 236, 249, 0, 0, 253, 0, 0, 0, + 0, 0, 34, 37, 45, 0, 46, 53, 48, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 312, 0, 0, 321, 0, 330, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 206, 0, 0, 255, 254, 0, 307, 0, 0, + 0, 316, 0, 0, 325, 0, 0, 0, 0, 0, + 0, 29, 32, 0, 0, 0, 104, 0, 108, 0, + 112, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 200, 0, 293, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 311, 0, 0, 335, 320, 0, 329, + 0, 0, 0, 0, 0, 0, 49, 25, 105, 107, + 109, 111, 113, 115, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 201, 203, 0, 204, 244, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 118, + 122, 126, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 313, 334, 322, 331, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 205, 207, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 257, 11, 0, 0, 0, 116, 0, 120, 0, + 124, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 256, 0, 27, 117, + 119, 121, 123, 125, 127, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 130, 134, 138, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 128, 0, 132, 0, 136, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 129, 131, 133, 135, 137, + 139, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 142, 146, 150, + 154, 158, 162, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 28, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 140, 0, 144, 0, 148, 0, + 152, 0, 156, 0, 160, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 141, 143, 145, 147, 149, + 151, 153, 155, 157, 159, 161, 163, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 190, 194, 198, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 188, 0, 192, 0, 196, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 189, 191, 193, 195, 197, 199, 0, + 0, 0, 178, 182, 186, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 176, 0, 180, 0, 184, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 177, 179, + 181, 183, 185, 187, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 166, 170, 174, 0, 0, 0, 0, 0, + 0, 0, 164, 0, 168, 0, 172, 0, 0, 0, + 0, 0, 0, 165, 167, 169, 171, 173, 175 }; -static const short yypact[] = { 2727, - 53, 59, 348, 3264,-32768,-32768,-32768, -121,-32768, 72, - 77, 109, 134, 138, 149, -33, -25, -13,-32768,-32768, --32768,-32768, 2417, -2, 11, 195, 88, 91, 113, -38, - 139, 163, 166, 260, 186, 165, 233, 347, 350, 397, - 289, 367, 203, 175, -131, -131, 211, 460, 4, 386, - 7, 445, 455, 144, 467, 282, 297, -20, 9, 20, --32768, 308,-32768, 503,-32768, 513, 532, 496, 14, 17, --32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768, --32768,-32768,-32768,-32768,-32768, 18, 3097,-32768,-32768,-32768, --32768,-32768, 342, 342, 542,-32768, 279, 10,-32768,-32768, --32768,-32768, -130, -101, 314, 337, 343, 346, 353, 390, - 393, 416, 425, 436, 486, 499, 500, 519, 522, 523, - 526, 527, 531, 352, 357, 365,-32768,-32768,-32768,-32768, - 2619, 2619, 2619,-32768,-32768, 2619, 1235, 31, 562, 2619, - 563, 421,-32768, 564, 572,-32768, 2619,-32768, 2619, 2619, - 2619, 399, 2619, 405, 2619, 2619, 983, 2619, 408, 419, - 426, -102, 983, 430, 434, 476, 510, 511, 518, 544, - 654, -131, -131, -131, 2619, 2619, -93,-32768, -83, -131, - 458, 463, 485, 540,-32768, 983, 21,-32768,-32768,-32768, - 983, 983, 738, 2619, 2619, -64, 2619, 555, 2619, 567, - 671, 2619, 2619,-32768, 772,-32768, 588,-32768,-32768, 787, --32768, 796,-32768, 821, 18, 663, 691, 700, 712, 725, - 729, 755, 756, 759, 760, 780, 786, 791, 818, 819, - 820, 822, 823, 826, 827, 828, 829, 831, 832, 833, - 834, 835, 836, 837, 838, 873, 735, 733, 781, 2619, - 1015,-32768, -131,-32768, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 50, 41, 41, 438, - 840, 840, 840, 1640, 1031, 2466, 1266, 310, 839, 1032, - 842, 464,-32768,-32768, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619,-32768, - -112, 1339, 2885, 11384, 11407, 2619, 11430, 2619, 11453, 11476, - 462, 844, 2320, 2466,-32768,-32768,-32768, 1545, 1033,-32768, - 11499, 2619, 2619, 2619, 2619, 2619, 1043, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 852, -86,-32768,-32768, 1825, 3782, - -131, -131, 497, 497, -46, 2619, 2619, 2619, 2619, 2835, - 321,-32768, 2619, 2872, 1045, 1046,-32768, 11522, 11545, 949, - 2619, 11568, 948, 3804,-32768, 856, 1560, 11591,-32768, 2619, - 2937,-32768, 2959,-32768,-32768, 18, 1057, 1058, 1059, 1060, - 1061, 1064, 1065, 1066, 1067, 1068, 1069, 1070, 1071, 1072, - 1073, 1074, 1075, 1076, 1077, 1080, 1081, 1082, 1083, 932, - 1085, 1086, 1087, 1088, 1096, 1095,-32768, -88, 1097, 1098, - 1100, 1937, 250, -39, 2624, 11614, 10734, 11637, 10759, 11660, - 10784, 11683, 10809, 11706, 10834, 11729, 10859, 11752, 10884, 11775, - 10909, 11798, 10934, 11821, 10959, 11844, 10984, 3826, 3848, 11867, - 11009, 11890, 11034, 11913, 11059, 11936, 11084, 11959, 11109, 11982, - 11134, 3870, 3892, 3914, 3936, 3958, 3980, 536, 172, 897, - 904, 2619,-32768, 983, 2662, 1545,-32768, 533, 150, 41, - 2619, 1101, 1102, 12, 908,-32768, 1581, 580, 234, 565, - 565, 440, 440, 440, 440, 205, 205, 840, 840, 840, - 840, 1104, 2466, 2619, 1105, 1106, 1107, 12005, 1111, 12028, - 1112, 1113, 1377, 2619, 465, 2466, 541, 2619, 2619, 1114, - 3243, 12051, 12074, 12097, 3267, 2619, 3298, 3322, 12120, 12143, - 12166, 12189, 12212, 909, -131, 2619, 2619,-32768,-32768,-32768, - 917, 3240,-32768, 918, 2619, 4002, 4024, 4046, 11159, -44, - -36, -35, -21,-32768,-32768,-32768, 2619, 11184,-32768, 920, - 922, 1121, 1122, 958, 12235, 1150, 956, 2619, 3048, 2619, - 2619,-32768, 12258,-32768,-32768, 990, 957, 960, 961, 963, - 964, 965, 968, 970, 971, 973, 974, 975, 976, 978, - 979, 980, 981, 985, 986, 987, 989, 991, 992, 993, - 994, 995, 997, 999, 1000, 1001,-32768, 1155, 988,-32768, - 1002, 85,-32768,-32768, 996, 1009, 1010, 1011, 1012, 1013, - 1014, 1016, 1017, 1019, 1021, 1022, 1023, 1024, 1025, 1026, - 1027, 1028, 1029, 1030, 1035, 1037, 1039, 1042, 1044, 1089, - 1156,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768, --32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768, --32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768, --32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768, --32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768, 2619, - 2619,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768, --32768,-32768,-32768, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 1209,-32768, 2466, 41,-32768, 11209, 1223, 2466, 1040, 39, - 2619, 1224, 1225, 492,-32768, 1236, 1084, 9, 1267,-32768, - 2619,-32768, 201, 4068, -131, 983, 983, 1276, 983, 1278, - 983, 983,-32768, 2466, 3346, 1858, 578,-32768, 1625, 620, - 1090, 1279, 1282, 1283, 1284, 1287, 341, 1289, 1290, 1293, - 1295, 1297, 1299, 1302, 1306, 0, 4090, 4112,-32768,-32768, - 3370, -131, -131, -131, 1305, 2466, 2466, 2466, 2466, 679, - 1307, 2619, 2619, 983, 983, 2619, 1308, 983, 1312, 4134, --32768, 1744, 395, 1310, 1129, 1309, 2619, 2619, -131, 1315, - 1316, 1135, 1322, 1323, 983, 983, 1324, -131, 1325, 1326, - 983, 983, 1327, 1329, 1330, 1331, 1332, 983, 568, 983, - 1334, 1333, 1335, 1365, 1366,-32768, 1367, 342, 1368,-32768, - 1370, 3116, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619,-32768, 12281, - 11234, 12304, 11259, 12327, 11284, 12350, 11309, 11334, 1172, 229, - 1175, 148,-32768, 1545,-32768, 19, 538, 1180, 1378, 728, --32768,-32768,-32768, 9, 2619,-32768, 581,-32768, 2277, 1404, - 2619, 23, 30, 38, 983, 1405, 983, 1406, 1407, 585, --32768,-32768, 2466,-32768, 2619,-32768, 2619, 983, 983, 983, - 1186, 1216,-32768, 410, 983, 983, 983, 983, 983, 983, - 983, 470, 2619, 2619, 2619, 1210, -115, -106, -81,-32768, - 586, 608, 609, 612,-32768,-32768, 4156, 4178, 1410, 1411, - 12373, 15, 1313,-32768, 2619, 2619, 2619,-32768, 1213, 1254, - 1217, 4200, 4222, -24, 1220, 1226, 1222, 1228, 1227, 1230, - 1233, 1237, 179, 1238, 1231, 1240, 1244, 1257, 1262, 1280, - 1281, 1286, 1259,-32768,-32768,-32768,-32768,-32768, 1317, 1328, - 1350, 1351, 1352, 1288, 1353,-32768, 1355, 250,-32768, 1426, - 4244, 4266, 4288, 4310, 4332, 4354, 4376, 4398, 4420, 4442, - 4464, 4486, 4508, 4530, 4552, 4574, 4596, 4618, 4640, 4662, - 4684, 4706, 4728, 4750, 4772, 4794,-32768,-32768,-32768,-32768, --32768,-32768,-32768,-32768, 1232,-32768,-32768,-32768, 983, 41, - 2619, 1480, 1484, 12,-32768, 1485, 11359, 9,-32768,-32768, - 4816,-32768,-32768, -131,-32768, -131, 1507,-32768, 1525,-32768, --32768, 1359, 615, 2277, 4838, 1528, 1529, 1555, 2619, 2619, - 2619, 2619, 1556, 1557, 1561, 1563, 1565, 1566, 1567,-32768, - 2547, 3394, 12396, 1979, 497, -131, 1568, -131, 1571, -131, - 1575, 1577, 1578, 1579, 1580, 2619, 2619,-32768,-32768, 1559, - 983, 983, 1481, 983, 2927, 269, 12419, 2619, 18, 1585, - 2619, 983, 1584, 1588, 1586, 1432, 1587, 568, 1589, 1591, - 2619, 1590, 1620, 1618, 1619, 1623, 568, 2619, 2619, 2619, - 983, 1621, 1626, 568, 2619, 1627, 1628, 1622, 2619, 342, --32768,-32768, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 1630, 1629, - 1631, 782,-32768, 1632, 1634,-32768, 1434,-32768, 2619, 87, - 131,-32768,-32768,-32768, 1440, 2619,-32768,-32768,-32768, 4860, - 4882, 1091, 1292,-32768,-32768,-32768,-32768,-32768,-32768,-32768, - 1361, 1636, 1438,-32768, 2619,-32768, 1444, 3,-32768, 1439, - 161,-32768, 1455, 182,-32768, 1457,-32768,-32768,-32768,-32768, - 4904, 4926, 15, 239,-32768, 616, 1458, 1569, 2619,-32768, - 2619,-32768,-32768, 4948, 18, 1465, 4970, 1464,-32768, 1466, --32768, 1467,-32768, 1470,-32768, 1469, 12442,-32768, 1472,-32768, --32768, 1479, 1482, 12465, 4992, 12488, 1476,-32768, 1483, 1486, - 5014, 1487, 1489,-32768, 5036, 1488, 5058, 5080, 5102, 5124, - 5146, 5168, 5190, 5212, 5234, 5256, 5278, 5300, 5322, 5344, - 5366, 5388, 5410, 5432, 5454, 5476, 5498, 5520, 5542, 5564, - 5586, 5608, 1490,-32768,-32768,-32768, 9,-32768, 1576, 5630, --32768,-32768,-32768, 5652, 2619, 2619,-32768,-32768,-32768,-32768, - 497, 3213,-32768, 2350, 64, 2350, 64, 2350, 64, 2619, - 2619, 1573,-32768, 983,-32768, 983, 2619, 3418, 3442, 983, - 18, 1668, 15, 568, 1680, 2619, 1684, 568, 1688, 1683, - 1690, 1692, 1714, 2619, 1715, 983, 1721, 1747, 2619, 1751, - 1749, 2619, 1758, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619,-32768, - 1767,-32768, 2619, 1769, 12511, 12534, 1574, 2619,-32768, 2350, - 2350, 2619, 3466, 194, 1771, 1596, -47,-32768, 3490, 200, - -9, 3514, 204, -7, 3538, 3562, 1602,-32768, 1659, 1468, --32768,-32768, 1658, 1613,-32768, 1661, 1662, 1687, 5674,-32768, - 1582,-32768, 1583,-32768,-32768,-32768, 12557,-32768, 1694,-32768, --32768, 12580, 1633,-32768, 12603, 1713, 12626, 12649, 12672, 5696, - 5718, 5740, 5762, 5784, 5806, 5828, 5850, 5872, 5894, 5916, - 5938, 5960, 5982, 6004, 6026, 6048, 6070, 6092, 6114, 6136, - 12695, 6158,-32768, 6180, 1716, 983, 983,-32768, 3586, 3754, - 1827, 2619,-32768, 983, 1828,-32768, 1830, 2619, 1832, 1886, - 2619, 1888, 1890, 1912, 983, 983,-32768, 1913, 18, 568, - 568, 568, 568, 1920, 1930, 1931, 568, 1932, 1933, 1934, - 1938,-32768,-32768,-32768, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619,-32768, 2619, 2619, 1939, 983, - 983,-32768,-32768, 1737, 3610, 1741,-32768,-32768, 1742, 3634, --32768,-32768, 1759, 3658,-32768,-32768,-32768, 1761, 1740,-32768, - 18, 1762, 1763, 1764, 1772,-32768,-32768,-32768, 1766,-32768, --32768,-32768, 1768, 1770, 1773, 1774, 6202, 6224, 6246, 6268, - 6290, 6312, 6334, 6356, 6378, 6400, 6422, 6444, 6466, 6488, - 6510, 6532, 6554, 6576, 6598, 6620, 6642, 1775, 12718, 3682, - 1777, 1962, 1967, 64, 1968, 983, 64, 1970, 64, 1971, - 983, 1879, 18, 568, 568, 1995, 2001, 568, 2012, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 41,-32768, 2013, 2015,-32768,-32768, -6, --32768, 1813, 619, -3,-32768, 1816, 78,-32768, 1818, 1819, - 1822, 1881, 1844, 1845,-32768,-32768, 1851, 1853, 622, 2277, - 623, 2277, 667, 2277, 6664, 6686, 6708, 6730, 6752, 6774, - 6796, 6818, 6840, 6862, 6884, 6906, 6928, 6950, 6972, 6994, - 7016, 7038, 7060, 7082, 7104, 668,-32768, 1848,-32768, 1849, - 2048, 64, 983, 2051, 2052, 64, 2054, 64, 1959, 2619, - 18, 568, 983, 2058, 2059, 2619, 2060, 2619, 2061, 2619, - 2062, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 41, 2063, 41, 2064,-32768, 84, 1865,-32768, --32768, 290,-32768, 291, 1867, 7126, 18, 1869, 1880,-32768, --32768, 2277,-32768, 2277,-32768, 2277,-32768, 12741, 12764, 12787, - 7148, 7170, 7192, 7214, 7236, 7258, 7280, 7302, 7324, 7346, - 7368, 7390, 7412, 7434, 7456, 7478, 7500, 7522,-32768,-32768, - 673,-32768,-32768, 2077, 2079, 2080, 2081, 2619, 2619, 18, - 568, 983,-32768,-32768,-32768, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 41, 2082,-32768,-32768,-32768,-32768, 7544, - 3706, 1918, 1887, 1889, 1885, 1891, 1892, 7566, 7588, 7610, - 7632, 7654, 7676, 7698, 7720, 7742, 7764, 7786, 7808, 7830, - 7852, 7874, 7896, 7918, 7940,-32768,-32768, 2619, 2086, 1922, - 983, 568, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 3730,-32768,-32768, 1894, 1896, 677, 2277, - 680, 2277, 681, 2277, 7962, 7984, 8006, 8028, 8050, 8072, - 8094, 8116, 8138, 8160, 8182, 8204, 8226, 8248, 8270, 8292, - 8314, 8336, 2113, 983, 2123, 2619, 2124, 2619, 2125, 2619, - 2126, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619,-32768, - 1929,-32768, 2277,-32768, 2277,-32768, 2277,-32768, 12810, 12833, - 12856, 8358, 8380, 8402, 8424, 8446, 8468, 8490, 8512, 8534, - 8556, 8578, 8600, 8622, 8644, 8666, 983,-32768,-32768,-32768, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 1936, 1941, 1956, 1966, 8688, - 8710, 8732, 8754, 8776, 8798, 8820, 8842, 8864, 8886, 8908, - 8930, 8952, 8974, 8996, 983, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 1940, 686, 2277, 689, 2277, 690, 2277, - 9018, 9040, 9062, 9084, 9106, 9128, 9150, 9172, 9194, 9216, - 9238, 9260, 9282, 9304, 9326, 568, 2619, 2130, 2619, 2136, - 2619, 2166, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 1974, 2277,-32768, - 2277,-32768, 2277,-32768, 12879, 12902, 12925, 12948, 12971, 12994, - 9348, 9370, 9392, 9414, 9436, 9458, 9480, 9502, 9524, 2168, --32768,-32768,-32768,-32768,-32768,-32768, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619,-32768, 1981, 1982, 1983, 1984, - 1985, 1986, 9546, 9568, 9590, 9612, 9634, 9656, 9678, 9700, - 9722, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 693, 2277, 697, 2277, - 720, 2277, 727, 2277, 730, 2277, 731, 2277, 9744, 9766, - 9788, 9810, 9832, 9854, 9876, 9898, 9920, 2619, 2169, 2619, - 2178, 2619, 2186, 2619, 2187, 2619, 2188, 2619, 2198, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2619, 2277,-32768, - 2277,-32768, 2277,-32768, 2277,-32768, 2277,-32768, 2277,-32768, - 9942, 9964, 9986, 10008, 10030, 10052, 13017, 13040, 13063, 2619, - 2619, 2619, 2619, 2619, 2619,-32768,-32768,-32768, 10074, 10096, - 10118, 10140, 10162, 10184, 2000, 2002, 2003, 2619, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2619, 10206, 10228, 10250, 10272, - 10294, 10316, 734, 2277, 741, 2277, 742, 2277, 2619, 2619, - 2619, 2619, 2619, 2619, 2619, 2200, 2619, 2203, 2619, 2204, - 10338, 10360, 10382, 13086, 13109, 13132, 2277,-32768, 2277,-32768, - 2277,-32768, 2619, 2619, 2619,-32768,-32768,-32768, 10404, 10426, - 10448, 2006, 2007, 2008, 2619, 2619, 2619, 2619, 2619, 2619, - 10470, 10492, 10514, 745, 2277, 746, 2277, 770, 2277, 2619, - 2619, 2619, 2619, 2208, 2619, 2209, 2619, 2217, 10536, 10558, - 10580, 2277,-32768, 2277,-32768, 2277,-32768, 2619, 2619, 2619, - 10602, 10624, 10646, 2619, 2619, 2619, 10668, 10690, 10712, 2619, - 2619, 2619, 13155, 13178, 13201,-32768,-32768,-32768, 2020, 2022, - 2023, 2619, 2619, 2619, 771, 2277, 777, 2277, 784, 2277, - 2619, 2223, 2619, 2224, 2619, 2227, 2277,-32768, 2277,-32768, - 2277,-32768, 2235, 2238,-32768 +/* YYDEFGOTO[NTERM-NUM]. */ +static const short yydefgoto[] = +{ + -1, 2, 217, 3, 11, 4, 21, 22, 23, 24, + 5, 73, 74, 75, 447, 1675, 665, 1580, 1677, 666, + 1581, 1679, 667, 1582, 1895, 668, 1841, 1897, 669, 1842, + 1899, 670, 1843, 2031, 671, 1993, 2033, 672, 1994, 2035, + 673, 1995, 2143, 674, 2113, 2145, 675, 2114, 2147, 676, + 2115, 2149, 677, 2116, 2151, 678, 2117, 2153, 679, 2118, + 2341, 680, 2335, 2343, 681, 2336, 2345, 682, 2337, 2290, + 683, 2278, 2292, 684, 2279, 2294, 685, 2280, 2239, 686, + 2221, 2241, 687, 2222, 2243, 688, 2223, 1702, 689, 1604, + 1797, 690, 1704, 691, 142, 254, 76, 577, 347, 563, + 564, 348, 80, 81, 82, 83, 84, 349, 1232, 1550, + 1658, 1235, 1555, 1662, 1238, 1559, 1665, 1414, 1415, 86, + 87, 1006, 350, 145, 369, 180, 249, 440, 885, 1044, + 1045, 352, 500, 202, 753, 914, 146 }; -static const short yypgoto[] = {-32768, - -178,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768, --32768,-32768, 1605,-32768,-32768,-32768,-32768,-32768,-32768,-32768, --32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768, --32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768, --32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768, --32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768, --32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768, --32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768, --32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768,-32768, --32768, -301, -17,-32768, 2239, -1, -365, -170, 1,-32768, --32768,-32768,-32768,-32768, 2240,-32768,-32768,-32768,-32768,-32768, --32768,-32768,-32768,-32768, -1295, -1369,-32768,-32768, -1066, -23, --32768, 136,-32768, -90,-32768, -1200, 1133, 1475, -177, -334, - -736, 1192,-32768, -68 +/* YYPACT[STATE-NUM] -- Index in YYTABLE of the portion describing + STATE-NUM. */ +#define YYPACT_NINF -1350 +static const short yypact[] = +{ + 2757, 34, 67, 277, 415, 3241, -1350, -1350, -1350, -1350, + -135, -1350, 63, 101, 105, 109, 113, 123, -116, -60, + -24, -1350, -1350, -1350, -1350, 2356, -9, 68, 130, -5, + 129, 135, -37, 132, 145, 148, 271, 173, 279, 335, + 356, 382, 475, 370, 374, 242, 240, -138, -138, 244, + 351, 9, 419, 15, 462, 497, 57, 481, 310, 325, + -17, 16, 18, -1350, 337, -1350, 500, -1350, 541, 545, + 520, 22, 70, -1350, -1350, -1350, -1350, -1350, -1350, -1350, + -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, 25, 3074, + -1350, -1350, -1350, -1350, -1350, 367, 367, 568, -1350, 311, + 17, -1350, -1350, -1350, -1350, 160, 187, 238, 280, 320, + 336, 342, 396, 404, 417, 418, 445, 463, 464, 478, + 479, 483, 484, 487, 492, 493, 390, 413, 511, -1350, + -1350, -1350, -1350, 2492, 2492, 2492, -1350, -1350, 2492, 993, + 39, 590, 2492, 660, 681, -1350, 675, 709, -1350, 2492, + -1350, 2492, 2492, 2492, 527, 2492, 533, 2492, 2492, 611, + 2492, 510, 536, 561, -144, 611, 558, 573, 574, 581, + 584, 594, 595, 794, -138, -138, -138, 2492, 2492, -143, + -1350, -103, -138, 610, 624, 625, 657, -1350, 611, 19, + -1350, -1350, -1350, 611, 611, 797, 2492, 2492, -74, 2492, + 659, 2492, 679, 770, 2492, 2492, -1350, 880, -1350, 689, + -1350, -1350, 883, -1350, 906, -1350, 921, 25, 729, 734, + 746, 747, 753, 754, 755, 756, 757, 758, 759, 760, + 761, 762, 767, 779, 781, 782, 783, 786, 787, 788, + 789, 790, 791, 793, 799, 800, 801, 802, 946, 821, + 784, 822, 2492, 989, -1350, -138, -1350, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 55, + 43, 43, 343, 830, 830, 830, 2248, 1022, 2390, 11317, + 174, 827, 1024, 832, 712, -1350, -1350, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, -1350, -113, 3685, 11905, 11928, 11951, 2492, 11974, + 2492, 11997, 12020, 395, 828, 1622, 2390, -1350, -1350, -1350, + 872, 1028, -1350, 12043, 2492, 2492, 2492, 2492, 2492, 1029, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 838, 4, -1350, + -1350, 3709, 3733, -138, -138, 509, 509, 8, 2492, 2492, + 2492, 2492, 2624, 360, -1350, 2492, 2887, 1032, 1033, -1350, + 12066, 12089, 935, 2492, 12112, 934, 3757, -1350, 837, 1827, + 12135, -1350, 2492, 2923, -1350, 2957, -1350, -1350, 25, 1040, + 1042, 1043, 1044, 1048, 1066, 1067, 1068, 1069, 1070, 1074, + 1076, 1077, 1078, 1079, 1080, 1081, 1082, 1083, 1084, 1085, + 1086, 1089, 937, 1091, 1092, 1093, 1094, 1097, 1096, -1350, + -63, 1098, 1101, 1103, 11338, 473, -94, 3058, 12158, 11359, + 12181, 11380, 12204, 11401, 12227, 11422, 12250, 11443, 12273, 11464, + 12296, 11485, 12319, 11506, 12342, 11527, 12365, 11548, 12388, 11569, + 3781, 3805, 12411, 11590, 12434, 11611, 12457, 11632, 12480, 11653, + 12503, 11674, 12526, 11695, 3829, 3853, 3877, 3901, 3925, 3949, + 7, -50, 904, 911, 2492, -1350, 611, 2587, 872, -1350, + 203, 188, 43, 2492, 1106, 1109, 20, 912, -1350, 1940, + 731, 565, 392, 392, 340, 340, 340, 340, 307, 307, + 830, 830, 830, 830, 1110, 2390, 2492, 1111, 1112, 1113, + 12549, 1118, 12572, 1119, 1120, 1217, 2492, 403, 2390, 345, + 2492, 2492, 1121, 1342, 12595, 12618, 12641, 2385, 2492, 3185, + 3217, 12664, 12687, 12710, 12733, 12756, 914, -138, 2492, 2492, + -1350, -1350, -1350, 923, 3279, -1350, 924, 2492, 3973, 3997, + 4021, 11716, -83, -43, -36, -38, -1350, -1350, -1350, 2492, + 11737, -1350, 926, 928, 1128, 1129, 964, 12779, 1157, 962, + 2492, 2995, 2492, 2492, -1350, 12802, -1350, -1350, 996, 963, + 965, 966, 967, 968, 969, 970, 972, 973, 974, 975, + 979, 980, 981, 983, 984, 985, 986, 988, 991, 995, + 998, 999, 1000, 1001, 1002, 1003, 1004, 1005, 1006, -1350, + 1162, 994, -1350, 1007, 149, -1350, -1350, 1014, 1015, 1018, + 1019, 1020, 1023, 1025, 1053, 1054, 1055, 1056, 1099, 1100, + 1105, 1107, 1115, 1122, 1123, 1124, 1125, 1126, 1127, 1131, + 1133, 1134, 1135, 1, 1163, -1350, -1350, -1350, -1350, -1350, + -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, + -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, + -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, + -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, + -1350, -1350, -1350, -1350, 2492, 2492, -1350, -1350, -1350, -1350, + -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 1194, -1350, 2390, 43, -1350, + 11758, 1195, 2390, 1095, 49, 2492, 1274, 1275, 752, -1350, + 1278, 1116, 16, 1302, -1350, 2492, -1350, -41, 4045, -138, + 611, 611, 1303, 611, 1305, 611, 611, -1350, 2390, 3243, + 1247, 490, -1350, 2450, 785, 1114, 1311, 1320, 1328, 1330, + 1331, 469, 1332, 1333, 1335, 1336, 1338, 1366, 1369, 1374, + 120, 4069, 4093, -1350, -1350, 3269, -138, -138, -138, 1373, + 2390, 2390, 2390, 2390, 1104, 1375, 2492, 2492, 611, 611, + 2492, 1378, 611, 1382, 4117, -1350, 2519, 304, 1380, 1220, + 1400, 2492, 2492, -138, 1401, 1404, 1219, 1407, 1409, 611, + 611, 1410, -138, 1411, 1412, 611, 611, 1414, 1415, 1417, + 1419, 1421, 611, 482, 611, 1422, 1423, 1424, 1427, 1428, + -1350, 1420, 367, 1429, -1350, 1426, 3092, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 611, 611, 1431, -1350, 12825, 11779, 12848, + 11800, 12871, 11821, 12894, 11842, 11863, 1227, -40, 1238, 274, + -1350, 872, -1350, 28, 205, 1236, 1433, 1210, -1350, -1350, + -1350, 16, 2492, -1350, 491, -1350, 13768, 1436, 2492, 30, + 26, 38, 611, 1437, 611, 1438, 1439, 494, -1350, -1350, + 2390, -1350, 2492, -1350, 2492, 611, 611, 611, 1248, 1249, + -1350, 372, 611, 611, 611, 611, 611, 611, 611, 467, + 2492, 2492, 2492, 1244, -107, -87, -67, -1350, 495, 506, + 514, 517, -1350, -1350, 4141, 4165, 1446, 1448, 12917, 1, + 1348, -1350, 2492, 2492, 2492, -1350, 1250, 1290, 1253, 4189, + 4213, -22, 1254, 1260, 1256, 1262, 1259, 1265, 1261, 1263, + 169, 1266, 1267, 1270, 1268, 1269, 1271, 1272, 1273, 1276, + 1279, -1350, -1350, -1350, -1350, -1350, 1277, 1280, 1282, 1283, + 1284, 1291, 1285, -1350, 1287, 473, -1350, 1469, 4237, 4261, + 4285, 4309, 4333, 4357, 4381, 4405, 4429, 4453, 4477, 4501, + 4525, 4549, 4573, 4597, 4621, 4645, 4669, 4693, 4717, 4741, + 4765, 4789, 4813, 4837, 11, -1350, 518, -1350, -1350, -1350, + -1350, -1350, -1350, -1350, -1350, -1350, 1281, -1350, -1350, -1350, + 611, 43, 2492, 1474, 1489, 20, -1350, 1488, 11884, 16, + -1350, -1350, 4861, -1350, -1350, -138, -1350, -138, 1511, -1350, + 1517, -1350, -1350, 1293, 522, 13768, 4885, 1529, 1530, 1531, + 2492, 2492, 2492, 2492, 1532, 1533, 1535, 1536, 1537, 1538, + 1539, -1350, 2458, 3295, 12940, 2656, 509, -138, 1556, -138, + 1557, -138, 1558, 1561, 1562, 1563, 1564, 2492, 2492, -1350, + -1350, 1565, 1466, 611, 2895, 269, 12963, 2492, 25, 1571, + 2492, 611, 1569, 1573, 1572, 1387, 1575, 482, 1576, 1580, + 2492, 1581, 1583, 1582, 1584, 1586, 482, 2492, 2492, 2492, + 611, 1585, 1589, 482, 2492, 1590, 1592, 1591, 2492, 367, + -1350, -1350, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, -1350, 611, + -1350, 1594, 1621, 1623, 1368, -1350, 1651, 1664, -1350, 1376, + -1350, 2492, 91, 128, -1350, -1350, -1350, 1394, 2492, -1350, + -1350, -1350, 4909, 4933, 1477, 1555, -1350, -1350, -1350, -1350, + -1350, -1350, -1350, 1579, 1665, 1468, -1350, 2492, -1350, 1465, + 207, -1350, 1470, 209, -1350, 1471, 215, -1350, 1472, -1350, + -1350, -1350, -1350, 4957, 4981, 1, 1476, 1524, 2492, -1350, + 2492, -1350, -1350, 5005, 25, 1480, 5029, 1478, -1350, 1479, + -1350, 1481, -1350, 1485, -1350, 1482, 12986, -1350, 1483, -1350, + -1350, 1490, 1492, 13009, 5053, 13032, 1484, -1350, 1493, 1494, + 5077, 1491, 1495, -1350, 5101, 1497, 5125, 5149, 5173, 5197, + 5221, 5245, 5269, 5293, 5317, 5341, 5365, 5389, 5413, 5437, + 5461, 5485, 5509, 5533, 5557, 5581, 5605, 5629, 5653, 5677, + 5701, 5725, -1350, 1498, -1350, -1350, -1350, 16, -1350, 1615, + 5749, -1350, -1350, -1350, 5773, 2492, 2492, -1350, -1350, -1350, + -1350, 509, 3064, -1350, 1862, 252, 1862, 252, 1862, 252, + 2492, 2492, 1593, 611, 2492, 3321, 3347, 611, 25, 1719, + 1, 482, 1723, 2492, 1721, 482, 1722, 1726, 1724, 1725, + 1730, 2492, 1742, 611, 1744, 1745, 2492, 1729, 1746, 2492, + 1749, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, -1350, 1750, -1350, + 2492, 1767, 13055, 13078, 1548, 2492, -1350, 1862, 1862, 2492, + 3373, 218, 1768, 1567, -34, -1350, 3399, 233, -30, 3425, + 239, -20, 3451, 3477, 1570, 1577, 1743, -1350, -1350, 1568, + 1611, -1350, 1578, 1600, 1601, 5797, -1350, 1607, -1350, 1608, + -1350, -1350, -1350, 13101, -1350, 1604, -1350, -1350, 13124, 1612, + -1350, 13147, 1609, 13170, 13193, 13216, 5821, 5845, 5869, 5893, + 5917, 5941, 5965, 5989, 6013, 6037, 6061, 6085, 6109, 6133, + 6157, 6181, 6205, 6229, 6253, 6277, 6301, 13239, 6325, -1350, + 6349, 1610, 611, 611, -1350, 3503, 2550, 1775, 2492, -1350, + 611, 1778, -1350, 1779, 2492, 1780, 1807, 2492, 1811, 1812, + 1813, 611, 611, -1350, 1814, 25, 482, 482, 482, 482, + 1816, 1817, 1818, 482, 1819, 1821, 1823, 1825, -1350, -1350, + -1350, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, -1350, 2492, 2492, 1826, 611, 611, -1350, -1350, + 1626, 3529, 1628, -1350, -1350, 1630, 3555, -1350, -1350, 1631, + 3581, -1350, -1350, -1350, 1629, 1633, -1350, 25, 1636, 1637, + 1638, 1643, -1350, -1350, -1350, 1662, -1350, -1350, -1350, 1663, + 1689, 1690, 1692, 6373, 6397, 6421, 6445, 6469, 6493, 6517, + 6541, 6565, 6589, 6613, 6637, 6661, 6685, 6709, 6733, 6757, + 6781, 6805, 6829, 6853, 1694, 13262, 3607, 1731, 1863, 1864, + 252, 1918, 611, 252, 1931, 252, 1932, 611, 1835, 25, + 482, 482, 1934, 1936, 482, 1938, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 43, -1350, 1939, 1941, -1350, -1350, -18, -1350, 1738, 526, + -1, -1350, 1741, 74, -1350, 1761, 1762, 1764, 1782, 1763, + 1766, -1350, -1350, 1751, 1772, 531, 13768, 534, 13768, 535, + 13768, 6877, 6901, 6925, 6949, 6973, 6997, 7021, 7045, 7069, + 7093, 7117, 7141, 7165, 7189, 7213, 7237, 7261, 7285, 7309, + 7333, 7357, 539, -1350, 1769, -1350, 1770, 1944, 252, 611, + 1967, 1968, 252, 1970, 252, 1874, 2492, 25, 482, 611, + 1973, 1974, 2492, 1975, 2492, 1976, 2492, 1977, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 43, + 1978, 43, 1979, -1350, 77, 1801, -1350, -1350, 119, -1350, + 219, 1815, 7381, 25, 1781, 1822, -1350, -1350, 13768, -1350, + 13768, -1350, 13768, -1350, 13285, 13308, 13331, 7405, 7429, 7453, + 7477, 7501, 7525, 7549, 7573, 7597, 7621, 7645, 7669, 7693, + 7717, 7741, 7765, 7789, 7813, -1350, -1350, 554, -1350, -1350, + 2014, 2016, 2017, 2018, 2492, 2492, 25, 482, 611, -1350, + -1350, -1350, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 43, 2020, -1350, -1350, -1350, -1350, 7837, 3633, 1857, 1828, + 1844, 1846, 1847, 1848, 7861, 7885, 7909, 7933, 7957, 7981, + 8005, 8029, 8053, 8077, 8101, 8125, 8149, 8173, 8197, 8221, + 8245, 8269, -1350, -1350, 2492, 2025, 1882, 611, 482, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 3659, -1350, -1350, 1852, 1858, 563, 13768, 564, 13768, 567, + 13768, 8293, 8317, 8341, 8365, 8389, 8413, 8437, 8461, 8485, + 8509, 8533, 8557, 8581, 8605, 8629, 8653, 8677, 8701, 2053, + 611, 2054, 2492, 2056, 2492, 2057, 2492, 2058, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, -1350, 1860, -1350, 13768, + -1350, 13768, -1350, 13768, -1350, 13354, 13377, 13400, 8725, 8749, + 8773, 8797, 8821, 8845, 8869, 8893, 8917, 8941, 8965, 8989, + 9013, 9037, 9061, 611, -1350, -1350, -1350, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 1865, 1861, 1866, 1867, 9085, 9109, 9133, 9157, + 9181, 9205, 9229, 9253, 9277, 9301, 9325, 9349, 9373, 9397, + 9421, 611, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 1869, 579, 13768, 582, 13768, 583, 13768, 9445, 9469, 9493, + 9517, 9541, 9565, 9589, 9613, 9637, 9661, 9685, 9709, 9733, + 9757, 9781, 482, 2492, 2063, 2492, 2065, 2492, 2069, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 1876, 13768, -1350, 13768, -1350, 13768, + -1350, 13423, 13446, 13469, 13492, 13515, 13538, 9805, 9829, 9853, + 9877, 9901, 9925, 9949, 9973, 9997, 2071, -1350, -1350, -1350, + -1350, -1350, -1350, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, -1350, 1881, 1883, 1884, 1885, 1886, 1887, 10021, + 10045, 10069, 10093, 10117, 10141, 10165, 10189, 10213, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 597, 13768, 601, 13768, 602, 13768, 606, + 13768, 607, 13768, 613, 13768, 10237, 10261, 10285, 10309, 10333, + 10357, 10381, 10405, 10429, 2492, 2082, 2492, 2088, 2492, 2089, + 2492, 2090, 2492, 2091, 2492, 2092, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 2492, 2492, 13768, -1350, 13768, -1350, 13768, + -1350, 13768, -1350, 13768, -1350, 13768, -1350, 10453, 10477, 10501, + 10525, 10549, 10573, 13561, 13584, 13607, 2492, 2492, 2492, 2492, + 2492, 2492, -1350, -1350, -1350, 10597, 10621, 10645, 10669, 10693, + 10717, 1893, 1894, 1895, 2492, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2492, 10741, 10765, 10789, 10813, 10837, 10861, 614, + 13768, 617, 13768, 618, 13768, 2492, 2492, 2492, 2492, 2492, + 2492, 2492, 2096, 2492, 2115, 2492, 2127, 10885, 10909, 10933, + 13630, 13653, 13676, 13768, -1350, 13768, -1350, 13768, -1350, 2492, + 2492, 2492, -1350, -1350, -1350, 10957, 10981, 11005, 1928, 1929, + 1930, 2492, 2492, 2492, 2492, 2492, 2492, 11029, 11053, 11077, + 621, 13768, 622, 13768, 669, 13768, 2492, 2492, 2492, 2492, + 2131, 2492, 2134, 2492, 2136, 11101, 11125, 11149, 13768, -1350, + 13768, -1350, 13768, -1350, 2492, 2492, 2492, 11173, 11197, 11221, + 2492, 2492, 2492, 11245, 11269, 11293, 2492, 2492, 2492, 13699, + 13722, 13745, -1350, -1350, -1350, 1942, 1954, 1955, 2492, 2492, + 2492, 670, 13768, 677, 13768, 701, 13768, 2492, 2138, 2492, + 2140, 2492, 2144, 13768, -1350, 13768, -1350, 13768, -1350 }; - -#define YYLAST 13400 - - -static const short yytable[] = { 142, - 210, 212, 76, 248, 77, 141, 501, 184, 564, 537, - 187, 906, 198, 253, 380, 747, 146, 384, 208, 1405, - 213, 208, 196, 201, 1406, 99, 382, 152, 1062, 152, - 154, 1411, 1332, 1414, 308, 1063, 406, 1486, 401, 390, - 403, 1486, 897, 1065, 1486, 208, 86, 124, 125, 126, - 124, 125, 126, 488, 208, 173, 174, 1405, 5, 1405, - 1405, 1254, 1406, 1405, 1406, 1406, 175, 255, 1406, 256, - 1263, 371, 372, 176, 124, 125, 126, 1270, 87, 1064, - 371, 372, 88, 124, 125, 126, 522, 1066, 1096, 208, - 1097, 523, 1311, 371, 372, 355, 257, 1098, 258, 1099, - 371, 372, 356, 371, 372, 371, 372, 301, 302, 303, - 627, 373, 304, 307, 89, 628, 312, 555, 124, 125, - 126, 374, 1100, 332, 1101, 333, 334, 335, 497, 337, - 1405, 339, 340, 391, 351, 1406, 1312, 309, 310, 90, - 371, 372, 1426, 91, 1405, 898, 899, 371, 372, 1406, - 1405, 369, 370, 149, 92, 1406, 99, 565, 1485, 153, - 796, 153, 371, 372, 93, 634, 497, 1056, 797, 798, - 388, 389, 94, 392, 1123, 394, 156, 197, 397, 398, - 177, 179, 191, 799, 95, 192, 371, 372, 753, 371, - 372, 127, 128, 129, 130, 145, 1489, 741, 1492, 1701, - 148, 767, 1705, 943, 154, 214, 1324, 159, 185, 371, - 372, 188, 1111, 199, 254, 147, 748, 202, 209, 1112, - 383, 211, 6, 7, 589, 8, 442, 596, 489, 490, - 491, 446, 447, 448, 449, 450, 451, 452, 453, 454, - 455, 456, 457, 458, 459, 460, 461, 462, 463, 464, - 465, 466, 467, 468, 469, 470, 471, 472, 473, 474, - 475, 476, 477, 478, 479, 480, 481, 482, 483, 484, - 485, 486, 487, 371, 372, 160, 1241, 1427, 134, 135, - 1486, 1431, 496, 1707, 1486, 149, 849, 1486, 150, 1794, - 502, 507, 508, 509, 510, 511, 512, 513, 514, 515, - 516, 517, 518, 519, 520, 521, 157, 366, 1650, 368, - 151, 1654, 528, 1657, 530, 375, 500, 371, 372, 302, - 496, 1188, 127, 128, 129, 130, 576, 577, 541, 542, - 543, 544, 545, 166, 547, 548, 549, 550, 551, 552, - 553, 134, 135, 134, 135, 497, 933, 371, 372, 849, - 10, 740, 566, 567, 568, 569, 1405, 1405, 497, 578, - 155, 1406, 1406, 156, 1326, 371, 372, 585, 371, 372, - 732, 560, 560, 563, 563, 733, 593, 1132, 1486, 172, - 371, 372, 1486, 158, 1486, 1328, 371, 372, 444, 161, - 371, 372, 162, 326, 327, 328, 934, 1482, 890, 910, - 171, 329, 967, 1488, 738, 167, 1748, 1491, 168, 169, - 1752, 170, 1754, 318, 319, 180, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 633, 314, 1047, 186, 920, - 329, 743, 738, 1562, 1563, 1564, 1565, 1333, 163, 164, - 1569, 165, 1334, 134, 135, 315, 316, 317, 318, 319, - 189, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 190, 951, 952, 953, 954, 329, 1081, 1082, 736, 506, - 193, 302, 134, 135, 1242, 1090, 1091, 744, 250, 194, - 251, 742, 127, 128, 129, 130, 11, 12, 13, 14, - 15, 16, 17, 18, 195, 1796, 1797, 903, 181, 496, - 754, 182, 183, 134, 135, 203, 558, 559, 204, 736, - 765, 259, 496, 260, 769, 770, 205, 315, 316, 317, - 318, 319, 777, 320, 321, 322, 323, 324, 325, 326, - 327, 328, 787, 788, 261, 206, 262, 329, 207, 246, - 263, 791, 264, 265, 1050, 266, 249, 1663, 1664, 297, - 267, 1667, 268, 800, 298, 497, 44, 45, 46, 47, - 895, 49, 299, 851, 810, 311, 812, 813, 313, 330, - 1391, 315, 316, 317, 318, 319, 331, 320, 321, 322, - 323, 324, 325, 326, 327, 328, 497, 269, 1073, 270, - 271, 329, 272, 968, 1049, 1051, 336, 315, 316, 317, - 318, 319, 338, 320, 321, 322, 323, 324, 325, 326, - 327, 328, 352, 273, 850, 274, 353, 329, 497, 497, - 497, 497, 275, 354, 276, 926, 324, 325, 326, 327, - 328, 134, 135, 277, 358, 278, 329, 492, 359, 251, - 315, 316, 317, 318, 319, 1758, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 134, 135, 365, 134, 135, - 329, 533, 376, 251, 766, 891, 251, 377, 315, 316, - 317, 318, 319, 360, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 279, 955, 280, 880, 881, 329, 378, - 786, 994, 995, 996, 997, 998, 281, 283, 282, 284, - 882, 883, 884, 885, 886, 887, 888, 361, 362, 496, - 127, 128, 129, 130, 894, 363, 285, 900, 286, 287, - 289, 288, 290, 291, 293, 292, 294, 909, 295, 1217, - 296, 134, 135, 1055, 1833, 730, 738, 731, 739, 379, - 496, 364, 736, 387, 738, 497, 768, 320, 321, 322, - 323, 324, 325, 326, 327, 328, 393, 1007, 317, 318, - 319, 329, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 395, 496, 496, 496, 496, 329, 399, 957, 958, - 396, 738, 961, 924, 1058, 400, 1059, 1306, 738, 738, - 1072, 1102, 402, 972, 973, 1888, 315, 316, 317, 318, - 319, 404, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 738, 738, 1103, 1104, 738, 329, 1105, 738, 1334, - 1195, 1335, 1703, 405, 1704, 1716, 1718, 1717, 1719, 1011, - 1012, 1013, 1014, 1015, 1016, 1017, 1018, 1019, 1020, 1021, - 1022, 1023, 1024, 1025, 1026, 1027, 1028, 1029, 1030, 1031, - 1032, 1033, 1034, 1035, 1036, 315, 316, 317, 318, 319, - 407, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 1720, 1743, 1721, 1744, 850, 329, 1824, 437, 1825, 1052, - 1916, 1057, 1917, 1918, 1920, 1919, 1921, 1061, 408, 2047, - 912, 2048, 2049, 2051, 2050, 2052, 2158, 409, 2159, 496, - 2160, 1074, 2161, 1075, 315, 316, 317, 318, 319, 410, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 1092, - 1093, 1094, 411, 2162, 329, 2163, 412, 947, 948, 949, - 2164, 440, 2165, 2166, 2168, 2167, 2169, 2245, 439, 2246, - 1245, 1115, 1116, 1117, 2247, 2249, 2248, 2250, 2293, 2295, - 2294, 2296, 413, 414, 974, 1397, 415, 416, 315, 316, - 317, 318, 319, 983, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 2297, 2341, 2298, 2342, 417, 329, 2068, - 2343, 1181, 2344, 418, 441, 96, 341, 2345, 419, 2346, - 1151, 100, 101, 102, 103, 104, 105, 106, 107, 108, - 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, - 119, 120, 121, 122, 123, 420, 421, 422, 443, 423, - 424, 342, 1212, 425, 426, 427, 428, 1182, 429, 430, - 431, 432, 433, 434, 435, 436, 329, 494, 504, 539, - 503, 505, 44, 45, 46, 47, 48, 49, 534, 546, - 554, 580, 581, 584, 587, 1200, 1201, 1202, 1203, 1276, - 590, 597, 598, 599, 600, 601, 1341, 1211, 602, 603, - 604, 605, 606, 607, 608, 609, 610, 611, 612, 613, - 614, 615, 1231, 1232, 616, 617, 618, 619, 620, 621, - 622, 623, 624, 560, 1244, 563, 1317, 1247, 625, 626, - 734, 629, 735, 630, 631, 746, 745, 1257, 750, 752, - 785, 755, 756, 757, 1264, 1265, 1266, 759, 761, 762, - 771, 1271, 789, 790, 802, 1275, 803, 804, 805, 1277, - 1278, 1279, 1280, 1281, 1282, 1283, 1284, 1285, 1286, 1287, - 1288, 1289, 1290, 1291, 1292, 1293, 1294, 1295, 1296, 1297, - 1298, 1299, 1300, 1301, 1302, 806, 808, 809, 815, 846, - 816, 879, 1424, 817, 818, 1310, 819, 820, 821, 131, - 343, 822, 1314, 823, 824, 133, 825, 826, 827, 828, - 136, 829, 830, 831, 832, 139, 847, 344, 833, 834, - 835, 1322, 836, 853, 837, 838, 839, 840, 841, 1190, - 842, 1191, 843, 844, 845, 848, 854, 855, 856, 857, - 858, 859, 889, 860, 861, 1338, 862, 1339, 863, 864, - 865, 866, 867, 868, 869, 870, 871, 872, 893, 901, - 902, 1218, 873, 1221, 874, 1224, 875, 96, 300, 876, - 896, 877, 904, 100, 101, 102, 103, 104, 105, 106, - 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, - 117, 118, 119, 120, 121, 122, 123, 315, 316, 317, - 318, 319, 908, 320, 321, 322, 323, 324, 325, 326, - 327, 328, 915, 905, 917, 928, 878, 329, 929, 930, - 931, 1395, 1396, 932, 927, 935, 936, 1318, 970, 937, - 1403, 938, 1409, 939, 1412, 940, 1415, 1416, 941, 942, - 950, 971, 956, 1420, 962, 964, 969, 975, 976, 560, - 1561, 563, 1429, 977, 978, 979, 982, 984, 985, 988, - 1437, 989, 990, 991, 992, 1442, 1001, 1002, 1445, 1003, - 1447, 1448, 1449, 1450, 1451, 1452, 1453, 1454, 1455, 1456, - 1457, 1458, 1459, 1460, 1461, 1462, 1463, 1464, 1465, 1466, - 1467, 1468, 1469, 1470, 1471, 1472, 1319, 1004, 1005, 1474, - 1046, 1008, 1006, 1048, 1479, 1009, 301, 302, 1480, 96, - 300, 1053, 1613, 1079, 1054, 100, 101, 102, 103, 104, - 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, - 115, 116, 117, 118, 119, 120, 121, 122, 123, 1060, - 1068, 1070, 1071, 1080, 1095, 1108, 1109, 1118, 1114, 1119, - 1120, 131, 132, 1124, 1125, 1126, 1127, 133, 1129, 1134, - 1128, 1152, 136, 1179, 1662, 305, 1130, 139, 1135, 306, - 1131, 1133, 315, 316, 317, 318, 319, 1136, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 1142, 1545, 1404, - 1137, 1410, 329, 1413, 1550, 1138, 499, 1554, 315, 316, - 317, 318, 319, 1497, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 1139, 1140, 1183, 1148, 1184, 329, 1141, - 1186, 1577, 1578, 1579, 1580, 1581, 1582, 1583, 1584, 1585, - 1586, 1587, 1588, 1589, 1590, 1591, 1592, 1593, 1594, 1595, - 1596, 1597, 1192, 1599, 1600, 315, 316, 317, 318, 319, - 1143, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 1193, 1144, 1757, 1197, 1198, 329, 368, 315, 316, 317, - 318, 319, 524, 320, 321, 322, 323, 324, 325, 326, - 327, 328, 538, 1145, 1146, 1147, 1149, 329, 1150, 1194, - 1199, 1204, 1205, 131, 132, 1233, 1206, 591, 1207, 133, - 1208, 1209, 1210, 1219, 136, 1697, 1222, 763, 1800, 139, - 1225, 764, 1227, 1228, 1229, 1230, 1237, 1246, 751, 1249, - 1250, 1251, 1253, 1256, 1255, 1258, 1670, 1672, 1674, 1675, - 1676, 1677, 1678, 1679, 1680, 1681, 1682, 1683, 1684, 1685, - 1686, 1687, 1688, 1689, 1690, 1691, 1692, 1693, 1694, 1695, - 1252, 1832, 1259, 1260, 1261, 1262, 1268, 1274, 1269, 1272, - 1273, 349, 925, 1303, 1304, 1309, 1305, 357, 1307, 1308, - 1313, 1320, 1321, 1325, 315, 316, 317, 318, 319, 1323, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 1327, - 381, 1329, 1336, 1342, 329, 385, 386, 1344, 1347, 1345, - 1346, 1337, 1348, 1425, 1789, 1350, 1792, 1351, 1417, 1356, - 1352, 1357, 1428, 1392, 1358, 1433, 1756, 1361, 1390, 1430, - 1360, 1363, 1762, 1432, 1764, 1434, 1766, 1435, 1768, 1769, - 1770, 1771, 1772, 1773, 1774, 1775, 1776, 1777, 1778, 1779, - 1780, 1781, 1782, 1783, 1784, 1785, 1786, 1787, 1788, 1436, - 1438, 315, 316, 317, 318, 319, 1440, 320, 321, 322, - 323, 324, 325, 326, 327, 328, 315, 316, 317, 318, - 319, 329, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 966, 1441, 1443, 1444, 1856, 329, 315, 316, 317, - 318, 319, 1446, 320, 321, 322, 323, 324, 325, 326, - 327, 328, 1473, 1475, 1830, 1831, 1483, 329, 1499, 1478, - 1504, 1505, 1838, 1839, 1840, 1841, 1842, 1843, 1844, 1845, - 1846, 1847, 1848, 1849, 1850, 1851, 1852, 1853, 1854, 1855, - 1484, 315, 316, 317, 318, 319, 1495, 320, 321, 322, - 323, 324, 325, 326, 327, 328, 315, 316, 317, 318, - 319, 329, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 1509, 1543, 1547, 1884, 1548, 329, 1551, 493, 1890, - 1892, 1894, 1895, 1896, 1897, 1898, 1899, 1900, 1901, 1902, - 1903, 1904, 1905, 1906, 1907, 1908, 1909, 1910, 1911, 1912, - 96, 300, 1496, 1498, 1500, 1501, 100, 101, 102, 103, - 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, - 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, - 1502, 1552, 1943, 1555, 1945, 1556, 1947, 1507, 1949, 1950, - 1951, 1952, 1953, 1954, 1955, 1956, 1957, 1958, 1959, 1960, - 1961, 1962, 1963, 1964, 1965, 1966, 1511, 1557, 1560, 1539, - 315, 316, 317, 318, 319, 1566, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 1567, 1568, 1570, 1571, 1572, - 329, 1604, 1573, 1601, 1606, 1612, 1607, 1990, 1991, 1992, - 1993, 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001, 2002, - 2003, 2004, 1616, 1609, 1611, 1614, 1615, 1648, 737, 1618, - 1617, 1619, 1649, 1651, 1620, 1655, 1658, 1621, 1622, 1644, - 1647, 1661, 2026, 2028, 2030, 2031, 2032, 2033, 2034, 2035, - 2036, 2037, 2038, 2039, 2040, 2041, 2042, 2043, 2044, 2045, - 1665, 315, 316, 317, 318, 319, 1666, 320, 321, 322, - 323, 324, 325, 326, 327, 328, 1668, 1702, 1699, 1700, - 1706, 329, 1708, 2069, 1709, 2071, 1710, 2073, 556, 2075, - 2076, 2077, 2078, 2079, 2080, 2081, 2082, 2083, 2084, 2085, - 2086, 2087, 2088, 2089, 131, 132, 1711, 1712, 1713, 1714, - 133, 1715, 1745, 1747, 1746, 136, 1750, 1751, 922, 1753, - 139, 1755, 923, 1760, 1761, 1763, 1765, 1767, 1790, 1793, - 1795, 1798, 1801, 2113, 2114, 2115, 2116, 2117, 2118, 2119, - 2120, 2121, 1826, 1802, 1827, 1828, 1829, 1857, 1860, 1863, - 1861, 1885, 1862, 1886, 1915, 1864, 1865, 1914, 2138, 2140, - 2142, 2144, 2146, 2148, 2149, 2150, 2151, 2152, 2153, 2154, - 2155, 2156, 2157, 315, 316, 317, 318, 319, 1940, 320, - 321, 322, 323, 324, 325, 326, 327, 328, 1942, 1944, - 1946, 1948, 1967, 329, 2179, 2070, 2181, 632, 2183, 2005, - 2185, 2072, 2187, 2046, 2189, 2006, 2191, 2192, 2193, 2194, - 2195, 2196, 2197, 2198, 2199, 315, 316, 317, 318, 319, - 2007, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 2008, 2074, 2090, 2106, 2180, 329, 2209, 2210, 2211, 2212, - 2213, 2214, 1215, 2182, 1216, 2122, 2123, 2124, 2125, 2126, - 2127, 2184, 2186, 2188, 2227, 2228, 2229, 2230, 2231, 2232, - 2234, 2236, 2238, 2190, 2224, 2258, 2225, 2226, 2260, 2262, - 2278, 2279, 2280, 2303, 2305, 2251, 2252, 2253, 2254, 2255, - 2256, 2257, 2307, 2259, 2332, 2261, 2333, 2334, 2348, 2350, - 913, 914, 2352, 916, 2354, 918, 919, 2355, 852, 2269, - 2270, 2271, 75, 83, 1236, 1185, 0, 0, 0, 0, - 0, 2281, 2282, 2283, 2285, 2287, 2289, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 2299, 2300, 2301, 2302, - 0, 2304, 0, 2306, 0, 0, 0, 0, 959, 960, - 0, 0, 963, 0, 2311, 2312, 2313, 0, 0, 0, - 2317, 2318, 2319, 0, 0, 0, 2323, 2324, 2325, 980, - 981, 0, 0, 0, 0, 986, 987, 0, 2336, 2338, - 2340, 0, 993, 0, 1000, 0, 0, 2347, 0, 2349, - 0, 2351, 96, 535, 0, 0, 0, 0, 100, 101, - 102, 103, 104, 105, 106, 107, 108, 109, 110, 111, - 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, - 122, 123, 96, 300, 0, 0, 0, 0, 100, 101, - 102, 103, 104, 105, 106, 107, 108, 109, 110, 111, - 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, - 122, 123, 0, 0, 0, 0, 0, 0, 0, 1067, - 0, 1069, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 1076, 1077, 1078, 0, 0, 0, 0, 1083, - 1084, 1085, 1086, 1087, 1088, 1089, 0, 0, 0, 96, - 97, 98, 0, 99, 0, 100, 101, 102, 103, 104, - 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, - 115, 116, 117, 118, 119, 120, 121, 122, 123, 0, - 124, 125, 126, 315, 316, 317, 318, 319, 0, 320, - 321, 322, 323, 324, 325, 326, 327, 328, 96, 341, - 0, 0, 0, 329, 100, 101, 102, 103, 104, 105, - 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, - 116, 117, 118, 119, 120, 121, 122, 123, 0, 0, - 0, 0, 0, 0, 342, 0, 131, 132, 0, 0, - 0, 0, 133, 0, 0, 0, 0, 136, 0, 0, - 0, 0, 139, 1180, 536, 44, 45, 46, 47, 48, - 49, 0, 0, 0, 0, 0, 1400, 1401, 0, 0, - 0, 0, 133, 0, 0, 0, 0, 1402, 0, 96, - 300, 208, 139, 0, 176, 100, 101, 102, 103, 104, - 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, - 115, 116, 117, 118, 119, 120, 121, 122, 123, 0, - 124, 125, 126, 0, 0, 0, 0, 0, 1238, 127, - 128, 129, 130, 0, 0, 0, 1248, 0, 0, 0, - 0, 0, 0, 131, 132, 0, 0, 0, 0, 133, - 134, 135, 0, 0, 136, 1267, 137, 0, 138, 139, - 0, 96, 300, 0, 0, 0, 0, 100, 101, 102, - 103, 104, 105, 106, 107, 108, 109, 110, 111, 112, - 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, - 123, 0, 131, 495, 0, 0, 0, 0, 133, 0, - 0, 0, 0, 136, 96, 535, 0, 0, 139, 0, - 100, 101, 102, 103, 104, 105, 106, 107, 108, 109, - 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, - 120, 121, 122, 123, 0, 0, 635, 636, 637, 638, - 639, 640, 641, 642, 643, 644, 645, 646, 647, 648, - 649, 650, 651, 652, 653, 654, 655, 656, 657, 658, - 659, 660, 0, 0, 0, 0, -7, 1, 0, -12, - -55, 0, 0, 131, 132, 0, 0, 0, 0, 133, - 0, 0, 0, 0, 136, 0, 0, 0, 0, 139, - 0, 0, 0, 0, 0, 0, 0, 0, 0, -55, - 0, 0, 0, -55, -55, -55, -55, -55, -55, -55, - -55, -55, -55, 0, -55, -55, -55, -55, -55, -55, - -55, -55, 0, 0, 0, -55, -55, -55, -55, -55, - -55, -55, 0, -55, -55, -55, -55, -55, 0, 0, - 0, 0, 0, 0, 0, 131, 132, 0, 1418, 0, - 1419, 133, 0, 0, 1423, 0, 136, 0, 0, 0, - 0, 139, 0, 0, 0, -55, -55, -55, -55, 661, - 1439, 0, 0, -55, 0, -55, 0, -55, -55, -55, - -55, -55, -55, -55, -55, -55, -55, 0, 131, 132, - 0, 0, 0, 0, 133, 0, 0, 0, 0, 136, - 0, 0, 0, 0, 139, -12, -12, -12, -12, -12, - -12, -12, -12, 570, 28, 29, 571, 572, 32, 573, - 34, 0, 35, 0, 37, 38, 39, 0, 41, 42, - -7, -7, 0, -7, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 54, 0, 0, 0, 0, - 570, 28, 29, 571, 572, 32, 573, 34, 0, 35, - 0, 37, 38, 39, 0, 41, 42, 0, 0, 0, - 0, 0, 0, 0, 56, 57, 58, 0, 0, 0, - 0, 0, 54, 0, 0, 0, 0, 0, 0, 0, - 1540, 1541, 68, 0, 0, 0, 0, 0, 1546, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 1558, - 1559, 56, 57, 58, 0, 570, 28, 29, 571, 572, - 32, 573, 34, 0, 35, 0, 37, 38, 39, 68, - 41, 42, 0, 0, 0, 0, 0, 570, 28, 29, - 571, 572, 32, 573, 34, 0, 35, 54, 37, 38, - 39, 0, 41, 42, 1602, 1603, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 54, - 0, 0, 0, 0, 0, 0, 56, 57, 58, 0, - 574, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 68, 0, 0, 0, 56, 57, - 58, 315, 316, 317, 318, 319, 0, 320, 321, 322, - 323, 324, 325, 326, 327, 328, 68, 579, 0, 0, - 1653, 329, 0, 525, 0, 1660, 570, 28, 29, 571, - 572, 32, 573, 34, 0, 35, 0, 37, 38, 39, - 0, 41, 42, 315, 316, 317, 318, 319, 0, 320, - 321, 322, 323, 324, 325, 326, 327, 328, 54, 0, - 0, 0, 0, 329, 0, 0, 0, 0, 0, 0, - 1239, 0, 1240, 0, 0, 0, 0, 0, 216, 0, - 0, 0, 594, 0, 0, 0, 0, 56, 57, 58, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 595, 68, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 1749, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 1759, 635, 636, - 637, 638, 639, 640, 641, 642, 643, 644, 645, 646, - 647, 648, 649, 650, 651, 652, 653, 654, 655, 656, - 657, 658, 659, 660, 0, 0, 0, 217, 218, 219, - 0, 0, 0, 0, 0, 220, 221, 222, 223, 224, - 225, 226, 227, 228, 229, 0, 0, 0, 0, 0, - 0, 0, 0, 230, 231, 232, 233, 234, 235, 236, - 237, 238, 239, 811, 240, 241, 242, 243, 244, 245, - 0, 0, 0, 0, 0, 0, 0, 23, 0, 0, - 0, 0, 0, 0, 0, 0, 1834, 0, 570, 28, - 29, 571, 572, 32, 573, 34, 0, 35, 0, 37, - 38, 39, 0, 41, 42, 0, 24, 0, 0, 0, - 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, - 54, 35, 36, 37, 38, 39, 40, 41, 42, 0, - 0, 1010, 43, 44, 45, 46, 47, 48, 49, 0, - 50, 51, 52, 53, 54, 1887, 0, 0, 0, 56, - 57, 58, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 68, 0, 0, - 0, 0, 55, 56, 57, 58, 0, 0, 0, 0, - 59, 0, 60, 0, 61, 62, 63, 64, 65, 66, - 67, 68, 69, 70, 0, 0, 0, 0, 1941, 315, - 316, 317, 318, 319, 0, 320, 321, 322, 323, 324, - 325, 326, 327, 328, 0, 0, 0, 0, 0, 329, - 0, 0, 0, 0, 0, 0, 1398, 0, 1399, 315, - 316, 317, 318, 319, 0, 320, 321, 322, 323, 324, - 325, 326, 327, 328, 0, 0, 0, 0, 0, 329, - 0, 1986, 0, 315, 316, 317, 318, 319, 772, 320, - 321, 322, 323, 324, 325, 326, 327, 328, 0, 0, - 0, 0, 0, 329, 0, 0, 0, 0, 0, 0, - 0, 0, 776, 0, 315, 316, 317, 318, 319, 2024, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 0, 0, 315, 316, - 317, 318, 319, 778, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 0, 0, 315, 316, 317, 318, 319, 779, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 0, 0, 315, 316, 317, 318, - 319, 921, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 0, 0, - 315, 316, 317, 318, 319, 946, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 0, 0, 315, 316, 317, 318, 319, 1213, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 0, 0, 315, 316, - 317, 318, 319, 1421, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 0, 0, 315, 316, 317, 318, 319, 1422, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 0, 0, 315, 316, 317, 318, - 319, 1481, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 0, 0, - 315, 316, 317, 318, 319, 1487, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 0, 0, 315, 316, 317, 318, 319, 1490, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 0, 0, 315, 316, - 317, 318, 319, 1493, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 0, 0, 315, 316, 317, 318, 319, 1494, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 0, 0, 315, 316, 317, 318, - 319, 1542, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 0, 0, - 315, 316, 317, 318, 319, 1605, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 0, 0, 315, 316, 317, 318, 319, 1608, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 0, 0, 315, 316, - 317, 318, 319, 1610, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 0, 0, 315, 316, 317, 318, 319, 1646, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 0, 0, 315, 316, 317, 318, - 319, 1859, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 0, 0, - 315, 316, 317, 318, 319, 1913, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 493, 0, 0, 0, 0, 556, 315, 316, - 317, 318, 319, 0, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 557, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 588, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 710, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 711, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 724, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 725, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 726, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 727, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 728, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 729, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 792, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 793, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 794, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 911, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 944, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 945, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 965, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1106, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1107, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1121, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1122, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1153, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1154, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1155, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1156, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1157, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1158, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1159, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1160, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1161, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1162, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1163, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1164, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1165, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1166, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1167, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1168, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1169, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1170, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1171, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1172, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1173, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1174, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1175, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1176, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1177, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1178, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1189, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1196, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1315, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1316, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1330, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1331, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1340, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1343, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1354, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1359, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1362, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1364, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1365, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1366, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1367, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1368, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1369, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1370, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1371, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1372, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1373, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1374, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1375, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1376, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1377, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1378, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1379, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1380, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1381, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1382, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1383, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1384, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1385, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1386, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1387, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1388, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1389, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1393, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1394, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1503, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1515, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1516, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1517, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1518, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1519, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1520, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1521, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1522, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1523, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1524, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1525, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1526, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1527, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1528, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1529, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1530, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1531, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1532, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1533, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1534, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1535, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1537, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1538, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1623, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1624, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1625, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1626, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1627, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1628, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1629, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1630, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1631, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1632, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1633, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1634, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1635, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1636, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1637, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1638, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1639, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1640, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1641, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1642, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1643, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1722, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1723, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1724, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1725, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1726, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1727, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1728, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1729, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1730, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1731, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1732, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1733, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1734, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1735, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1736, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1737, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1738, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1739, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1740, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1741, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1742, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1799, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1806, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1807, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1808, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1809, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1810, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1811, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1812, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1813, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1814, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1815, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1816, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1817, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1818, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1819, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1820, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1821, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1822, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1823, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1858, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1866, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1867, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1868, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1869, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1870, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1871, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1872, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1873, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1874, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1875, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1876, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1877, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1878, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1879, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1880, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1881, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1882, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1883, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1922, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1923, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1924, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1925, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1926, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1927, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1928, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1929, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1930, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1931, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1932, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1933, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1934, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1935, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1936, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1937, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1938, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1939, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1971, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1972, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1973, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1974, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1975, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1976, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1977, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1978, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1979, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1980, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 1981, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 1982, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 1983, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 1984, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 1985, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2009, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2010, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2011, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 2012, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 2013, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2014, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2015, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2016, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 2017, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 2018, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2019, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2020, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2021, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 2022, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 2023, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2053, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2054, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2055, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 2056, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 2057, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2058, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2059, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2060, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 2061, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 2062, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2063, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2064, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2065, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 2066, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 2067, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2097, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2098, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2099, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 2100, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 2101, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2102, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2103, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2104, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 2105, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 2128, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2129, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2130, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2131, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 2132, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 2133, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2134, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2135, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2136, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 2170, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 2171, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2172, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2173, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2174, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 2175, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 2176, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2177, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2178, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2200, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 2201, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 2202, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2203, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2204, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2205, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 2218, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 2219, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2220, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2221, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2222, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 2223, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 2239, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2240, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2241, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2242, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 2243, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 2244, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2263, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2264, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2265, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 2275, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 2276, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2277, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2290, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2291, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 2292, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 2308, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2309, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2310, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2314, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 315, 316, 317, 318, 319, 2315, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 315, 316, 317, 318, 319, 2316, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 315, 316, 317, 318, - 319, 2320, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 315, 316, - 317, 318, 319, 2321, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 315, 316, 317, 318, 319, 2322, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 0, 0, 689, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 0, 0, 691, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 0, 0, 693, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 0, 0, 695, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 0, 0, 697, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 0, 0, 699, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 0, 0, 701, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 0, 0, 703, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 0, 0, 705, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 0, 0, 707, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 0, 0, 709, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 0, 0, 713, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 0, 0, 715, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 0, 0, 717, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 0, 0, 719, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 0, 0, 721, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 0, 0, 723, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 0, 0, 795, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 0, 0, 801, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 0, 0, 892, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 0, 0, 1038, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 0, 0, 1040, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 0, 0, 1042, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 0, 0, 1044, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 0, 0, 1045, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 0, 0, 1187, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 526, 315, 316, 317, 318, 319, 0, 320, - 321, 322, 323, 324, 325, 326, 327, 328, 0, 0, - 0, 0, 0, 329, 0, 527, 315, 316, 317, 318, - 319, 0, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 529, 315, - 316, 317, 318, 319, 0, 320, 321, 322, 323, 324, - 325, 326, 327, 328, 0, 0, 0, 0, 0, 329, - 0, 531, 315, 316, 317, 318, 319, 0, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 532, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 540, 315, 316, - 317, 318, 319, 0, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 582, 315, 316, 317, 318, 319, 0, 320, 321, 322, - 323, 324, 325, 326, 327, 328, 0, 0, 0, 0, - 0, 329, 0, 583, 315, 316, 317, 318, 319, 0, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 586, 315, 316, 317, - 318, 319, 0, 320, 321, 322, 323, 324, 325, 326, - 327, 328, 0, 0, 0, 0, 0, 329, 0, 592, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 688, 315, 316, 317, 318, 319, 0, 320, - 321, 322, 323, 324, 325, 326, 327, 328, 0, 0, - 0, 0, 0, 329, 0, 690, 315, 316, 317, 318, - 319, 0, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 692, 315, - 316, 317, 318, 319, 0, 320, 321, 322, 323, 324, - 325, 326, 327, 328, 0, 0, 0, 0, 0, 329, - 0, 694, 315, 316, 317, 318, 319, 0, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 696, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 698, 315, 316, - 317, 318, 319, 0, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 700, 315, 316, 317, 318, 319, 0, 320, 321, 322, - 323, 324, 325, 326, 327, 328, 0, 0, 0, 0, - 0, 329, 0, 702, 315, 316, 317, 318, 319, 0, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 704, 315, 316, 317, - 318, 319, 0, 320, 321, 322, 323, 324, 325, 326, - 327, 328, 0, 0, 0, 0, 0, 329, 0, 706, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 708, 315, 316, 317, 318, 319, 0, 320, - 321, 322, 323, 324, 325, 326, 327, 328, 0, 0, - 0, 0, 0, 329, 0, 712, 315, 316, 317, 318, - 319, 0, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 714, 315, - 316, 317, 318, 319, 0, 320, 321, 322, 323, 324, - 325, 326, 327, 328, 0, 0, 0, 0, 0, 329, - 0, 716, 315, 316, 317, 318, 319, 0, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 718, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 720, 315, 316, - 317, 318, 319, 0, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 722, 315, 316, 317, 318, 319, 0, 320, 321, 322, - 323, 324, 325, 326, 327, 328, 0, 0, 0, 0, - 0, 329, 0, 758, 315, 316, 317, 318, 319, 0, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 760, 315, 316, 317, - 318, 319, 0, 320, 321, 322, 323, 324, 325, 326, - 327, 328, 0, 0, 0, 0, 0, 329, 0, 773, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 774, 315, 316, 317, 318, 319, 0, 320, - 321, 322, 323, 324, 325, 326, 327, 328, 0, 0, - 0, 0, 0, 329, 0, 775, 315, 316, 317, 318, - 319, 0, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 780, 315, - 316, 317, 318, 319, 0, 320, 321, 322, 323, 324, - 325, 326, 327, 328, 0, 0, 0, 0, 0, 329, - 0, 781, 315, 316, 317, 318, 319, 0, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 782, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 783, 315, 316, - 317, 318, 319, 0, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 784, 315, 316, 317, 318, 319, 0, 320, 321, 322, - 323, 324, 325, 326, 327, 328, 0, 0, 0, 0, - 0, 329, 0, 807, 315, 316, 317, 318, 319, 0, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 814, 315, 316, 317, - 318, 319, 0, 320, 321, 322, 323, 324, 325, 326, - 327, 328, 0, 0, 0, 0, 0, 329, 0, 1037, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 1039, 315, 316, 317, 318, 319, 0, 320, - 321, 322, 323, 324, 325, 326, 327, 328, 0, 0, - 0, 0, 0, 329, 0, 1041, 315, 316, 317, 318, - 319, 0, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 1043, 315, - 316, 317, 318, 319, 0, 320, 321, 322, 323, 324, - 325, 326, 327, 328, 0, 0, 0, 0, 0, 329, - 0, 1110, 315, 316, 317, 318, 319, 0, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 1214, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 1243, 315, 316, - 317, 318, 319, 0, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 1349, 315, 316, 317, 318, 319, 0, 320, 321, 322, - 323, 324, 325, 326, 327, 328, 0, 0, 0, 0, - 0, 329, 0, 1353, 315, 316, 317, 318, 319, 0, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 1355, 315, 316, 317, - 318, 319, 0, 320, 321, 322, 323, 324, 325, 326, - 327, 328, 0, 0, 0, 0, 0, 329, 0, 1476, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 1477, 315, 316, 317, 318, 319, 0, 320, - 321, 322, 323, 324, 325, 326, 327, 328, 0, 0, - 0, 0, 0, 329, 0, 1506, 315, 316, 317, 318, - 319, 0, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 1508, 315, - 316, 317, 318, 319, 0, 320, 321, 322, 323, 324, - 325, 326, 327, 328, 0, 0, 0, 0, 0, 329, - 0, 1510, 315, 316, 317, 318, 319, 0, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 1512, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 1513, 315, 316, - 317, 318, 319, 0, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 1514, 315, 316, 317, 318, 319, 0, 320, 321, 322, - 323, 324, 325, 326, 327, 328, 0, 0, 0, 0, - 0, 329, 0, 1536, 315, 316, 317, 318, 319, 0, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 1645, 315, 316, 317, - 318, 319, 0, 320, 321, 322, 323, 324, 325, 326, - 327, 328, 0, 0, 0, 0, 0, 329, 0, 1803, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 1804, 315, 316, 317, 318, 319, 0, 320, - 321, 322, 323, 324, 325, 326, 327, 328, 0, 0, - 0, 0, 0, 329, 0, 1805, 315, 316, 317, 318, - 319, 0, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 1968, 315, - 316, 317, 318, 319, 0, 320, 321, 322, 323, 324, - 325, 326, 327, 328, 0, 0, 0, 0, 0, 329, - 0, 1969, 315, 316, 317, 318, 319, 0, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 1970, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 2091, 315, 316, - 317, 318, 319, 0, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 2092, 315, 316, 317, 318, 319, 0, 320, 321, 322, - 323, 324, 325, 326, 327, 328, 0, 0, 0, 0, - 0, 329, 0, 2093, 315, 316, 317, 318, 319, 0, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 2094, 315, 316, 317, - 318, 319, 0, 320, 321, 322, 323, 324, 325, 326, - 327, 328, 0, 0, 0, 0, 0, 329, 0, 2095, - 315, 316, 317, 318, 319, 0, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 0, 0, 0, 0, 0, - 329, 0, 2096, 315, 316, 317, 318, 319, 0, 320, - 321, 322, 323, 324, 325, 326, 327, 328, 0, 0, - 0, 0, 0, 329, 0, 2206, 315, 316, 317, 318, - 319, 0, 320, 321, 322, 323, 324, 325, 326, 327, - 328, 0, 0, 0, 0, 0, 329, 0, 2207, 315, - 316, 317, 318, 319, 0, 320, 321, 322, 323, 324, - 325, 326, 327, 328, 0, 0, 0, 0, 0, 329, - 0, 2208, 315, 316, 317, 318, 319, 0, 320, 321, - 322, 323, 324, 325, 326, 327, 328, 0, 0, 0, - 0, 0, 329, 0, 2266, 315, 316, 317, 318, 319, - 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, - 0, 0, 0, 0, 0, 329, 0, 2267, 315, 316, - 317, 318, 319, 0, 320, 321, 322, 323, 324, 325, - 326, 327, 328, 0, 0, 0, 0, 0, 329, 0, - 2268, 315, 316, 317, 318, 319, 0, 320, 321, 322, - 323, 324, 325, 326, 327, 328, 0, 0, 0, 0, - 0, 329, 0, 2326, 315, 316, 317, 318, 319, 0, - 320, 321, 322, 323, 324, 325, 326, 327, 328, 0, - 0, 0, 0, 0, 329, 0, 2327, 315, 316, 317, - 318, 319, 0, 320, 321, 322, 323, 324, 325, 326, - 327, 328, 0, 0, 0, 0, 0, 329, 0, 2328 +/* YYPGOTO[NTERM-NUM]. */ +static const short yypgoto[] = +{ + -1350, -1350, -133, -1350, -1350, -1350, -1350, -1350, -1350, -1350, + -1350, -1350, -1350, -1350, 1526, -1350, -1350, -1350, -1350, -1350, + -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, + -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, + -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, + -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, + -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, + -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, + -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1350, + -1350, -1350, -1350, -1350, -302, -21, -1350, 2158, -2, -369, + -172, 0, -1350, -1350, -1350, -1350, -1350, 2159, -1350, -1350, + -1350, -1350, -1350, -1350, -1350, -1350, -1350, -1325, -1349, -1350, + -1350, -1073, -25, -1350, -31, -1350, -90, -1350, -958, 1286, + 1406, -215, -337, -742, 1108, -1350, -70 }; -static const short yycheck[] = { 23, - 69, 70, 4, 94, 4, 23, 308, 4, 374, 344, - 4, 748, 4, 4, 185, 4, 6, 188, 5, 67, - 3, 5, 43, 4, 72, 7, 6, 66, 6, 66, - 66, 1327, 1233, 1329, 4, 6, 215, 1407, 209, 104, - 211, 1411, 4, 6, 1414, 5, 168, 34, 35, 36, - 34, 35, 36, 4, 5, 187, 188, 67, 6, 67, - 67, 1128, 72, 67, 72, 72, 198, 198, 72, 200, - 1137, 187, 188, 205, 34, 35, 36, 1144, 7, 50, - 187, 188, 6, 34, 35, 36, 199, 50, 204, 5, - 206, 204, 6, 187, 188, 198, 198, 204, 200, 206, - 187, 188, 205, 187, 188, 187, 188, 131, 132, 133, - 199, 205, 136, 137, 6, 204, 140, 204, 34, 35, - 36, 205, 204, 147, 206, 149, 150, 151, 306, 153, - 67, 155, 156, 198, 158, 72, 6, 107, 108, 6, - 187, 188, 1343, 6, 67, 107, 108, 187, 188, 72, - 67, 175, 176, 198, 6, 72, 7, 204, 206, 198, - 205, 198, 187, 188, 198, 205, 344, 904, 205, 205, - 194, 195, 198, 197, 199, 199, 198, 198, 202, 203, - 45, 46, 39, 205, 198, 42, 187, 188, 523, 187, - 188, 173, 174, 175, 176, 198, 206, 499, 206, 206, - 6, 536, 206, 204, 66, 188, 204, 43, 205, 187, - 188, 205, 198, 205, 205, 205, 205, 198, 205, 205, - 200, 205, 164, 165, 395, 167, 250, 406, 297, 298, - 299, 255, 256, 257, 258, 259, 260, 261, 262, 263, - 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, - 274, 275, 276, 277, 278, 279, 280, 281, 282, 283, - 284, 285, 286, 287, 288, 289, 290, 291, 292, 293, - 294, 295, 296, 187, 188, 43, 8, 1344, 194, 195, - 1650, 1348, 306, 206, 1654, 198, 202, 1657, 198, 206, - 308, 315, 316, 317, 318, 319, 320, 321, 322, 323, - 324, 325, 326, 327, 328, 329, 47, 172, 1604, 174, - 198, 1607, 336, 1609, 338, 180, 7, 187, 188, 343, - 344, 1058, 173, 174, 175, 176, 6, 7, 352, 353, - 354, 355, 356, 45, 358, 359, 360, 361, 362, 363, - 364, 194, 195, 194, 195, 523, 6, 187, 188, 202, - 3, 202, 376, 377, 378, 379, 67, 67, 536, 383, - 198, 72, 72, 198, 204, 187, 188, 391, 187, 188, - 199, 373, 374, 373, 374, 204, 400, 199, 1748, 205, - 187, 188, 1752, 198, 1754, 204, 187, 188, 253, 43, - 187, 188, 43, 189, 190, 191, 56, 204, 733, 199, - 198, 197, 8, 204, 204, 39, 1702, 204, 42, 43, - 1706, 45, 1708, 180, 181, 205, 183, 184, 185, 186, - 187, 188, 189, 190, 191, 443, 6, 199, 43, 764, - 197, 500, 204, 1500, 1501, 1502, 1503, 199, 42, 43, - 1507, 45, 204, 194, 195, 177, 178, 179, 180, 181, - 6, 183, 184, 185, 186, 187, 188, 189, 190, 191, - 6, 796, 797, 798, 799, 197, 57, 58, 492, 6, - 4, 495, 194, 195, 206, 6, 7, 501, 200, 198, - 202, 499, 173, 174, 175, 176, 139, 140, 141, 142, - 143, 144, 145, 146, 198, 206, 206, 6, 39, 523, - 524, 42, 43, 194, 195, 198, 371, 372, 6, 533, - 534, 198, 536, 200, 538, 539, 4, 177, 178, 179, - 180, 181, 546, 183, 184, 185, 186, 187, 188, 189, - 190, 191, 556, 557, 198, 4, 200, 197, 43, 198, - 198, 565, 200, 198, 7, 200, 5, 1614, 1615, 198, - 198, 1618, 200, 577, 198, 733, 60, 61, 62, 63, - 738, 65, 198, 632, 588, 4, 590, 591, 6, 6, - 1307, 177, 178, 179, 180, 181, 5, 183, 184, 185, - 186, 187, 188, 189, 190, 191, 764, 198, 923, 200, - 198, 197, 200, 199, 896, 897, 198, 177, 178, 179, - 180, 181, 198, 183, 184, 185, 186, 187, 188, 189, - 190, 191, 205, 198, 632, 200, 198, 197, 796, 797, - 798, 799, 198, 198, 200, 6, 187, 188, 189, 190, - 191, 194, 195, 198, 205, 200, 197, 200, 205, 202, - 177, 178, 179, 180, 181, 1712, 183, 184, 185, 186, - 187, 188, 189, 190, 191, 194, 195, 4, 194, 195, - 197, 200, 205, 202, 200, 734, 202, 205, 177, 178, - 179, 180, 181, 198, 183, 184, 185, 186, 187, 188, - 189, 190, 191, 198, 6, 200, 710, 711, 197, 205, - 555, 124, 125, 126, 127, 128, 198, 198, 200, 200, - 724, 725, 726, 727, 728, 729, 730, 198, 198, 733, - 173, 174, 175, 176, 738, 198, 198, 741, 200, 198, - 198, 200, 200, 198, 198, 200, 200, 751, 198, 1095, - 200, 194, 195, 6, 1801, 200, 204, 202, 206, 200, - 764, 198, 766, 6, 204, 923, 206, 183, 184, 185, - 186, 187, 188, 189, 190, 191, 202, 848, 179, 180, - 181, 197, 183, 184, 185, 186, 187, 188, 189, 190, - 191, 205, 796, 797, 798, 799, 197, 6, 802, 803, - 110, 204, 806, 206, 204, 198, 206, 6, 204, 204, - 206, 206, 6, 817, 818, 1862, 177, 178, 179, 180, - 181, 6, 183, 184, 185, 186, 187, 188, 189, 190, - 191, 204, 204, 206, 206, 204, 197, 206, 204, 204, - 206, 206, 204, 3, 206, 204, 204, 206, 206, 853, - 854, 855, 856, 857, 858, 859, 860, 861, 862, 863, - 864, 865, 866, 867, 868, 869, 870, 871, 872, 873, - 874, 875, 876, 877, 878, 177, 178, 179, 180, 181, - 198, 183, 184, 185, 186, 187, 188, 189, 190, 191, - 204, 204, 206, 206, 892, 197, 204, 5, 206, 897, - 204, 905, 206, 204, 204, 206, 206, 911, 198, 204, - 755, 206, 204, 204, 206, 206, 204, 198, 206, 923, - 204, 925, 206, 927, 177, 178, 179, 180, 181, 198, - 183, 184, 185, 186, 187, 188, 189, 190, 191, 943, - 944, 945, 198, 204, 197, 206, 198, 792, 793, 794, - 204, 199, 206, 204, 204, 206, 206, 204, 204, 206, - 1119, 965, 966, 967, 204, 204, 206, 206, 204, 204, - 206, 206, 198, 198, 819, 1321, 198, 198, 177, 178, - 179, 180, 181, 828, 183, 184, 185, 186, 187, 188, - 189, 190, 191, 204, 204, 206, 206, 198, 197, 2046, - 204, 1050, 206, 198, 204, 3, 4, 204, 198, 206, - 1008, 9, 10, 11, 12, 13, 14, 15, 16, 17, - 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, - 28, 29, 30, 31, 32, 198, 198, 198, 4, 198, - 198, 39, 1091, 198, 198, 198, 198, 1051, 198, 198, - 198, 198, 198, 198, 198, 198, 197, 7, 7, 7, - 202, 200, 60, 61, 62, 63, 64, 65, 205, 7, - 199, 7, 7, 105, 107, 1079, 1080, 1081, 1082, 1150, - 205, 5, 5, 5, 5, 5, 1245, 1091, 5, 5, - 5, 5, 5, 5, 5, 5, 5, 5, 5, 5, - 5, 5, 1106, 1107, 5, 5, 5, 5, 157, 5, - 5, 5, 5, 1095, 1118, 1095, 6, 1121, 3, 5, - 204, 5, 199, 6, 5, 4, 6, 1131, 201, 6, - 202, 7, 7, 7, 1138, 1139, 1140, 7, 7, 7, - 7, 1145, 206, 206, 205, 1149, 205, 7, 7, 1153, - 1154, 1155, 1156, 1157, 1158, 1159, 1160, 1161, 1162, 1163, - 1164, 1165, 1166, 1167, 1168, 1169, 1170, 1171, 1172, 1173, - 1174, 1175, 1176, 1177, 1178, 198, 7, 202, 169, 5, - 204, 6, 1341, 204, 204, 1189, 204, 204, 204, 187, - 188, 204, 1196, 204, 204, 193, 204, 204, 204, 204, - 198, 204, 204, 204, 204, 203, 199, 205, 204, 204, - 204, 1215, 204, 198, 204, 204, 204, 204, 204, 1064, - 204, 1066, 204, 204, 204, 204, 198, 198, 198, 198, - 198, 198, 4, 198, 198, 1239, 198, 1241, 198, 198, - 198, 198, 198, 198, 198, 198, 198, 198, 6, 6, - 6, 1096, 198, 1098, 198, 1100, 198, 3, 4, 198, - 201, 198, 7, 9, 10, 11, 12, 13, 14, 15, - 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, - 26, 27, 28, 29, 30, 31, 32, 177, 178, 179, - 180, 181, 6, 183, 184, 185, 186, 187, 188, 189, - 190, 191, 7, 200, 7, 7, 198, 197, 7, 7, - 7, 1315, 1316, 7, 205, 7, 7, 6, 170, 7, - 1324, 7, 1326, 7, 1328, 7, 1330, 1331, 7, 4, - 6, 3, 6, 1337, 7, 4, 7, 3, 3, 1321, - 1499, 1321, 1346, 189, 3, 3, 3, 3, 3, 3, - 1354, 3, 3, 3, 3, 1359, 3, 5, 1362, 5, - 1364, 1365, 1366, 1367, 1368, 1369, 1370, 1371, 1372, 1373, - 1374, 1375, 1376, 1377, 1378, 1379, 1380, 1381, 1382, 1383, - 1384, 1385, 1386, 1387, 1388, 1389, 6, 3, 3, 1393, - 199, 4, 6, 199, 1398, 6, 1400, 1401, 1402, 3, - 4, 202, 1561, 198, 7, 9, 10, 11, 12, 13, - 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, - 24, 25, 26, 27, 28, 29, 30, 31, 32, 6, - 6, 6, 6, 198, 205, 6, 6, 205, 106, 166, - 204, 187, 188, 204, 199, 204, 199, 193, 199, 199, - 204, 6, 198, 202, 1613, 201, 204, 203, 199, 205, - 204, 204, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, 199, 1482, 1324, - 204, 1326, 197, 1328, 1488, 204, 201, 1491, 177, 178, - 179, 180, 181, 6, 183, 184, 185, 186, 187, 188, - 189, 190, 191, 204, 204, 6, 199, 4, 197, 204, - 6, 1515, 1516, 1517, 1518, 1519, 1520, 1521, 1522, 1523, - 1524, 1525, 1526, 1527, 1528, 1529, 1530, 1531, 1532, 1533, - 1534, 1535, 6, 1537, 1538, 177, 178, 179, 180, 181, - 204, 183, 184, 185, 186, 187, 188, 189, 190, 191, - 6, 204, 1711, 6, 6, 197, 1401, 177, 178, 179, - 180, 181, 204, 183, 184, 185, 186, 187, 188, 189, - 190, 191, 8, 204, 204, 204, 204, 197, 204, 201, - 6, 6, 6, 187, 188, 7, 6, 8, 6, 193, - 6, 6, 6, 6, 198, 1644, 6, 201, 1757, 203, - 6, 205, 6, 6, 6, 6, 106, 3, 8, 6, - 3, 6, 6, 3, 6, 6, 1620, 1621, 1622, 1623, - 1624, 1625, 1626, 1627, 1628, 1629, 1630, 1631, 1632, 1633, - 1634, 1635, 1636, 1637, 1638, 1639, 1640, 1641, 1642, 1643, - 189, 1800, 3, 6, 6, 3, 6, 6, 3, 3, - 3, 157, 8, 4, 6, 202, 6, 163, 7, 6, - 201, 6, 205, 205, 177, 178, 179, 180, 181, 206, - 183, 184, 185, 186, 187, 188, 189, 190, 191, 205, - 186, 205, 205, 199, 197, 191, 192, 204, 199, 204, - 204, 103, 204, 6, 1743, 204, 1745, 199, 106, 204, - 199, 199, 3, 108, 199, 3, 1710, 199, 199, 6, - 204, 204, 1716, 6, 1718, 6, 1720, 6, 1722, 1723, - 1724, 1725, 1726, 1727, 1728, 1729, 1730, 1731, 1732, 1733, - 1734, 1735, 1736, 1737, 1738, 1739, 1740, 1741, 1742, 6, - 6, 177, 178, 179, 180, 181, 6, 183, 184, 185, - 186, 187, 188, 189, 190, 191, 177, 178, 179, 180, - 181, 197, 183, 184, 185, 186, 187, 188, 189, 190, - 191, 8, 6, 3, 6, 1824, 197, 177, 178, 179, - 180, 181, 5, 183, 184, 185, 186, 187, 188, 189, - 190, 191, 6, 5, 1798, 1799, 6, 197, 166, 206, - 199, 199, 1806, 1807, 1808, 1809, 1810, 1811, 1812, 1813, - 1814, 1815, 1816, 1817, 1818, 1819, 1820, 1821, 1822, 1823, - 205, 177, 178, 179, 180, 181, 205, 183, 184, 185, - 186, 187, 188, 189, 190, 191, 177, 178, 179, 180, - 181, 197, 183, 184, 185, 186, 187, 188, 189, 190, - 191, 199, 6, 6, 1858, 6, 197, 6, 199, 1863, - 1864, 1865, 1866, 1867, 1868, 1869, 1870, 1871, 1872, 1873, - 1874, 1875, 1876, 1877, 1878, 1879, 1880, 1881, 1882, 1883, - 3, 4, 204, 206, 204, 204, 9, 10, 11, 12, - 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, - 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, - 204, 6, 1916, 6, 1918, 6, 1920, 204, 1922, 1923, - 1924, 1925, 1926, 1927, 1928, 1929, 1930, 1931, 1932, 1933, - 1934, 1935, 1936, 1937, 1938, 1939, 204, 6, 6, 204, - 177, 178, 179, 180, 181, 6, 183, 184, 185, 186, - 187, 188, 189, 190, 191, 6, 6, 6, 6, 6, - 197, 205, 5, 5, 204, 206, 205, 1971, 1972, 1973, - 1974, 1975, 1976, 1977, 1978, 1979, 1980, 1981, 1982, 1983, - 1984, 1985, 199, 205, 204, 204, 204, 6, 494, 204, - 199, 204, 6, 6, 205, 6, 6, 205, 205, 205, - 204, 103, 2006, 2007, 2008, 2009, 2010, 2011, 2012, 2013, - 2014, 2015, 2016, 2017, 2018, 2019, 2020, 2021, 2022, 2023, - 6, 177, 178, 179, 180, 181, 6, 183, 184, 185, - 186, 187, 188, 189, 190, 191, 5, 205, 6, 5, - 205, 197, 205, 2047, 206, 2049, 205, 2051, 204, 2053, - 2054, 2055, 2056, 2057, 2058, 2059, 2060, 2061, 2062, 2063, - 2064, 2065, 2066, 2067, 187, 188, 166, 204, 204, 199, - 193, 199, 205, 6, 206, 198, 6, 6, 201, 6, - 203, 103, 205, 6, 6, 6, 6, 6, 6, 6, - 206, 205, 204, 2097, 2098, 2099, 2100, 2101, 2102, 2103, - 2104, 2105, 6, 204, 6, 6, 6, 6, 171, 205, - 204, 6, 204, 172, 199, 205, 205, 204, 2122, 2123, - 2124, 2125, 2126, 2127, 2128, 2129, 2130, 2131, 2132, 2133, - 2134, 2135, 2136, 177, 178, 179, 180, 181, 6, 183, - 184, 185, 186, 187, 188, 189, 190, 191, 6, 6, - 6, 6, 204, 197, 2158, 6, 2160, 201, 2162, 204, - 2164, 6, 2166, 204, 2168, 205, 2170, 2171, 2172, 2173, - 2174, 2175, 2176, 2177, 2178, 177, 178, 179, 180, 181, - 205, 183, 184, 185, 186, 187, 188, 189, 190, 191, - 205, 6, 199, 6, 6, 197, 2200, 2201, 2202, 2203, - 2204, 2205, 204, 6, 206, 205, 205, 205, 205, 205, - 205, 6, 6, 6, 2218, 2219, 2220, 2221, 2222, 2223, - 2224, 2225, 2226, 6, 205, 6, 205, 205, 6, 6, - 205, 205, 205, 6, 6, 2239, 2240, 2241, 2242, 2243, - 2244, 2245, 6, 2247, 205, 2249, 205, 205, 6, 6, - 756, 757, 6, 759, 0, 761, 762, 0, 634, 2263, - 2264, 2265, 4, 4, 1112, 1054, -1, -1, -1, -1, - -1, 2275, 2276, 2277, 2278, 2279, 2280, -1, -1, -1, - -1, -1, -1, -1, -1, -1, 2290, 2291, 2292, 2293, - -1, 2295, -1, 2297, -1, -1, -1, -1, 804, 805, - -1, -1, 808, -1, 2308, 2309, 2310, -1, -1, -1, - 2314, 2315, 2316, -1, -1, -1, 2320, 2321, 2322, 825, - 826, -1, -1, -1, -1, 831, 832, -1, 2332, 2333, - 2334, -1, 838, -1, 840, -1, -1, 2341, -1, 2343, - -1, 2345, 3, 4, -1, -1, -1, -1, 9, 10, - 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, - 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, - 31, 32, 3, 4, -1, -1, -1, -1, 9, 10, - 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, - 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, - 31, 32, -1, -1, -1, -1, -1, -1, -1, 915, - -1, 917, -1, -1, -1, -1, -1, -1, -1, -1, - -1, -1, 928, 929, 930, -1, -1, -1, -1, 935, - 936, 937, 938, 939, 940, 941, -1, -1, -1, 3, - 4, 5, -1, 7, -1, 9, 10, 11, 12, 13, - 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, - 24, 25, 26, 27, 28, 29, 30, 31, 32, -1, - 34, 35, 36, 177, 178, 179, 180, 181, -1, 183, - 184, 185, 186, 187, 188, 189, 190, 191, 3, 4, - -1, -1, -1, 197, 9, 10, 11, 12, 13, 14, - 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, - 25, 26, 27, 28, 29, 30, 31, 32, -1, -1, - -1, -1, -1, -1, 39, -1, 187, 188, -1, -1, - -1, -1, 193, -1, -1, -1, -1, 198, -1, -1, - -1, -1, 203, 1049, 205, 60, 61, 62, 63, 64, - 65, -1, -1, -1, -1, -1, 187, 188, -1, -1, - -1, -1, 193, -1, -1, -1, -1, 198, -1, 3, - 4, 5, 203, -1, 205, 9, 10, 11, 12, 13, - 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, - 24, 25, 26, 27, 28, 29, 30, 31, 32, -1, - 34, 35, 36, -1, -1, -1, -1, -1, 1114, 173, - 174, 175, 176, -1, -1, -1, 1122, -1, -1, -1, - -1, -1, -1, 187, 188, -1, -1, -1, -1, 193, - 194, 195, -1, -1, 198, 1141, 200, -1, 202, 203, - -1, 3, 4, -1, -1, -1, -1, 9, 10, 11, - 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, - 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, - 32, -1, 187, 188, -1, -1, -1, -1, 193, -1, - -1, -1, -1, 198, 3, 4, -1, -1, 203, -1, - 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, - 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, - 29, 30, 31, 32, -1, -1, 73, 74, 75, 76, - 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, - 87, 88, 89, 90, 91, 92, 93, 94, 95, 96, - 97, 98, -1, -1, -1, -1, 0, 1, -1, 3, - 4, -1, -1, 187, 188, -1, -1, -1, -1, 193, - -1, -1, -1, -1, 198, -1, -1, -1, -1, 203, - -1, -1, -1, -1, -1, -1, -1, -1, -1, 33, - -1, -1, -1, 37, 38, 39, 40, 41, 42, 43, - 44, 45, 46, -1, 48, 49, 50, 51, 52, 53, - 54, 55, -1, -1, -1, 59, 60, 61, 62, 63, - 64, 65, -1, 67, 68, 69, 70, 71, -1, -1, - -1, -1, -1, -1, -1, 187, 188, -1, 1334, -1, - 1336, 193, -1, -1, 1340, -1, 198, -1, -1, -1, - -1, 203, -1, -1, -1, 99, 100, 101, 102, 206, - 1356, -1, -1, 107, -1, 109, -1, 111, 112, 113, - 114, 115, 116, 117, 118, 119, 120, -1, 187, 188, - -1, -1, -1, -1, 193, -1, -1, -1, -1, 198, - -1, -1, -1, -1, 203, 139, 140, 141, 142, 143, - 144, 145, 146, 39, 40, 41, 42, 43, 44, 45, - 46, -1, 48, -1, 50, 51, 52, -1, 54, 55, - 164, 165, -1, 167, -1, -1, -1, -1, -1, -1, - -1, -1, -1, -1, -1, 71, -1, -1, -1, -1, - 39, 40, 41, 42, 43, 44, 45, 46, -1, 48, - -1, 50, 51, 52, -1, 54, 55, -1, -1, -1, - -1, -1, -1, -1, 100, 101, 102, -1, -1, -1, - -1, -1, 71, -1, -1, -1, -1, -1, -1, -1, - 1476, 1477, 118, -1, -1, -1, -1, -1, 1484, -1, - -1, -1, -1, -1, -1, -1, -1, -1, -1, 1495, - 1496, 100, 101, 102, -1, 39, 40, 41, 42, 43, - 44, 45, 46, -1, 48, -1, 50, 51, 52, 118, - 54, 55, -1, -1, -1, -1, -1, 39, 40, 41, - 42, 43, 44, 45, 46, -1, 48, 71, 50, 51, - 52, -1, 54, 55, 1540, 1541, -1, -1, -1, -1, - -1, -1, -1, -1, -1, -1, -1, -1, -1, 71, - -1, -1, -1, -1, -1, -1, 100, 101, 102, -1, - 206, -1, -1, -1, -1, -1, -1, -1, -1, -1, - -1, -1, -1, -1, 118, -1, -1, -1, 100, 101, - 102, 177, 178, 179, 180, 181, -1, 183, 184, 185, - 186, 187, 188, 189, 190, 191, 118, 206, -1, -1, - 1606, 197, -1, 199, -1, 1611, 39, 40, 41, 42, - 43, 44, 45, 46, -1, 48, -1, 50, 51, 52, - -1, 54, 55, 177, 178, 179, 180, 181, -1, 183, - 184, 185, 186, 187, 188, 189, 190, 191, 71, -1, - -1, -1, -1, 197, -1, -1, -1, -1, -1, -1, - 204, -1, 206, -1, -1, -1, -1, -1, 42, -1, - -1, -1, 206, -1, -1, -1, -1, 100, 101, 102, - -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, - -1, -1, -1, -1, 206, 118, -1, -1, -1, -1, - -1, -1, -1, -1, -1, -1, -1, 1703, -1, -1, - -1, -1, -1, -1, -1, -1, -1, 1713, 73, 74, - 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, - 85, 86, 87, 88, 89, 90, 91, 92, 93, 94, - 95, 96, 97, 98, -1, -1, -1, 121, 122, 123, - -1, -1, -1, -1, -1, 129, 130, 131, 132, 133, - 134, 135, 136, 137, 138, -1, -1, -1, -1, -1, - -1, -1, -1, 147, 148, 149, 150, 151, 152, 153, - 154, 155, 156, 206, 158, 159, 160, 161, 162, 163, - -1, -1, -1, -1, -1, -1, -1, 4, -1, -1, - -1, -1, -1, -1, -1, -1, 1802, -1, 39, 40, - 41, 42, 43, 44, 45, 46, -1, 48, -1, 50, - 51, 52, -1, 54, 55, -1, 33, -1, -1, -1, - 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, - 71, 48, 49, 50, 51, 52, 53, 54, 55, -1, - -1, 206, 59, 60, 61, 62, 63, 64, 65, -1, - 67, 68, 69, 70, 71, 1861, -1, -1, -1, 100, - 101, 102, -1, -1, -1, -1, -1, -1, -1, -1, - -1, -1, -1, -1, -1, -1, -1, 118, -1, -1, - -1, -1, 99, 100, 101, 102, -1, -1, -1, -1, - 107, -1, 109, -1, 111, 112, 113, 114, 115, 116, - 117, 118, 119, 120, -1, -1, -1, -1, 1914, 177, - 178, 179, 180, 181, -1, 183, 184, 185, 186, 187, - 188, 189, 190, 191, -1, -1, -1, -1, -1, 197, - -1, -1, -1, -1, -1, -1, 204, -1, 206, 177, - 178, 179, 180, 181, -1, 183, 184, 185, 186, 187, - 188, 189, 190, 191, -1, -1, -1, -1, -1, 197, - -1, 1967, -1, 177, 178, 179, 180, 181, 206, 183, - 184, 185, 186, 187, 188, 189, 190, 191, -1, -1, - -1, -1, -1, 197, -1, -1, -1, -1, -1, -1, - -1, -1, 206, -1, 177, 178, 179, 180, 181, 2005, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, -1, -1, 177, 178, - 179, 180, 181, 206, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - -1, -1, 177, 178, 179, 180, 181, 206, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, -1, -1, 177, 178, 179, 180, - 181, 206, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, -1, -1, - 177, 178, 179, 180, 181, 206, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, -1, -1, 177, 178, 179, 180, 181, 206, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, -1, -1, 177, 178, - 179, 180, 181, 206, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - -1, -1, 177, 178, 179, 180, 181, 206, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, -1, -1, 177, 178, 179, 180, - 181, 206, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, -1, -1, - 177, 178, 179, 180, 181, 206, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, -1, -1, 177, 178, 179, 180, 181, 206, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, -1, -1, 177, 178, - 179, 180, 181, 206, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - -1, -1, 177, 178, 179, 180, 181, 206, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, -1, -1, 177, 178, 179, 180, - 181, 206, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, -1, -1, - 177, 178, 179, 180, 181, 206, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, -1, -1, 177, 178, 179, 180, 181, 206, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, -1, -1, 177, 178, - 179, 180, 181, 206, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - -1, -1, 177, 178, 179, 180, 181, 206, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, -1, -1, 177, 178, 179, 180, - 181, 206, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, -1, -1, - 177, 178, 179, 180, 181, 206, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 199, -1, -1, -1, -1, 204, 177, 178, - 179, 180, 181, -1, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 177, 178, 179, 180, 181, 204, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 177, 178, 179, 180, 181, 204, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 177, 178, 179, 180, - 181, 204, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 177, 178, - 179, 180, 181, 204, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 177, 178, 179, 180, 181, 204, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, -1, -1, 201, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, -1, -1, 201, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, -1, -1, 201, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, -1, -1, 201, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, -1, -1, 201, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, -1, -1, 201, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, -1, -1, 201, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, -1, -1, 201, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, -1, -1, 201, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, -1, -1, 201, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, -1, -1, 201, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, -1, -1, 201, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, -1, -1, 201, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, -1, -1, 201, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, -1, -1, 201, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, -1, -1, 201, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, -1, -1, 201, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, -1, -1, 201, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, -1, -1, 201, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, -1, -1, 201, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, -1, -1, 201, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, -1, -1, 201, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, -1, -1, 201, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, -1, -1, 201, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, -1, -1, 201, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, -1, -1, 201, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 199, 177, 178, 179, 180, 181, -1, 183, - 184, 185, 186, 187, 188, 189, 190, 191, -1, -1, - -1, -1, -1, 197, -1, 199, 177, 178, 179, 180, - 181, -1, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 199, 177, - 178, 179, 180, 181, -1, 183, 184, 185, 186, 187, - 188, 189, 190, 191, -1, -1, -1, -1, -1, 197, - -1, 199, 177, 178, 179, 180, 181, -1, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 199, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, 199, 177, 178, - 179, 180, 181, -1, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 199, 177, 178, 179, 180, 181, -1, 183, 184, 185, - 186, 187, 188, 189, 190, 191, -1, -1, -1, -1, - -1, 197, -1, 199, 177, 178, 179, 180, 181, -1, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 199, 177, 178, 179, - 180, 181, -1, 183, 184, 185, 186, 187, 188, 189, - 190, 191, -1, -1, -1, -1, -1, 197, -1, 199, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 199, 177, 178, 179, 180, 181, -1, 183, - 184, 185, 186, 187, 188, 189, 190, 191, -1, -1, - -1, -1, -1, 197, -1, 199, 177, 178, 179, 180, - 181, -1, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 199, 177, - 178, 179, 180, 181, -1, 183, 184, 185, 186, 187, - 188, 189, 190, 191, -1, -1, -1, -1, -1, 197, - -1, 199, 177, 178, 179, 180, 181, -1, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 199, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, 199, 177, 178, - 179, 180, 181, -1, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 199, 177, 178, 179, 180, 181, -1, 183, 184, 185, - 186, 187, 188, 189, 190, 191, -1, -1, -1, -1, - -1, 197, -1, 199, 177, 178, 179, 180, 181, -1, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 199, 177, 178, 179, - 180, 181, -1, 183, 184, 185, 186, 187, 188, 189, - 190, 191, -1, -1, -1, -1, -1, 197, -1, 199, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 199, 177, 178, 179, 180, 181, -1, 183, - 184, 185, 186, 187, 188, 189, 190, 191, -1, -1, - -1, -1, -1, 197, -1, 199, 177, 178, 179, 180, - 181, -1, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 199, 177, - 178, 179, 180, 181, -1, 183, 184, 185, 186, 187, - 188, 189, 190, 191, -1, -1, -1, -1, -1, 197, - -1, 199, 177, 178, 179, 180, 181, -1, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 199, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, 199, 177, 178, - 179, 180, 181, -1, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 199, 177, 178, 179, 180, 181, -1, 183, 184, 185, - 186, 187, 188, 189, 190, 191, -1, -1, -1, -1, - -1, 197, -1, 199, 177, 178, 179, 180, 181, -1, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 199, 177, 178, 179, - 180, 181, -1, 183, 184, 185, 186, 187, 188, 189, - 190, 191, -1, -1, -1, -1, -1, 197, -1, 199, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 199, 177, 178, 179, 180, 181, -1, 183, - 184, 185, 186, 187, 188, 189, 190, 191, -1, -1, - -1, -1, -1, 197, -1, 199, 177, 178, 179, 180, - 181, -1, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 199, 177, - 178, 179, 180, 181, -1, 183, 184, 185, 186, 187, - 188, 189, 190, 191, -1, -1, -1, -1, -1, 197, - -1, 199, 177, 178, 179, 180, 181, -1, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 199, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, 199, 177, 178, - 179, 180, 181, -1, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 199, 177, 178, 179, 180, 181, -1, 183, 184, 185, - 186, 187, 188, 189, 190, 191, -1, -1, -1, -1, - -1, 197, -1, 199, 177, 178, 179, 180, 181, -1, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 199, 177, 178, 179, - 180, 181, -1, 183, 184, 185, 186, 187, 188, 189, - 190, 191, -1, -1, -1, -1, -1, 197, -1, 199, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 199, 177, 178, 179, 180, 181, -1, 183, - 184, 185, 186, 187, 188, 189, 190, 191, -1, -1, - -1, -1, -1, 197, -1, 199, 177, 178, 179, 180, - 181, -1, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 199, 177, - 178, 179, 180, 181, -1, 183, 184, 185, 186, 187, - 188, 189, 190, 191, -1, -1, -1, -1, -1, 197, - -1, 199, 177, 178, 179, 180, 181, -1, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 199, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, 199, 177, 178, - 179, 180, 181, -1, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 199, 177, 178, 179, 180, 181, -1, 183, 184, 185, - 186, 187, 188, 189, 190, 191, -1, -1, -1, -1, - -1, 197, -1, 199, 177, 178, 179, 180, 181, -1, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 199, 177, 178, 179, - 180, 181, -1, 183, 184, 185, 186, 187, 188, 189, - 190, 191, -1, -1, -1, -1, -1, 197, -1, 199, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 199, 177, 178, 179, 180, 181, -1, 183, - 184, 185, 186, 187, 188, 189, 190, 191, -1, -1, - -1, -1, -1, 197, -1, 199, 177, 178, 179, 180, - 181, -1, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 199, 177, - 178, 179, 180, 181, -1, 183, 184, 185, 186, 187, - 188, 189, 190, 191, -1, -1, -1, -1, -1, 197, - -1, 199, 177, 178, 179, 180, 181, -1, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 199, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, 199, 177, 178, - 179, 180, 181, -1, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 199, 177, 178, 179, 180, 181, -1, 183, 184, 185, - 186, 187, 188, 189, 190, 191, -1, -1, -1, -1, - -1, 197, -1, 199, 177, 178, 179, 180, 181, -1, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 199, 177, 178, 179, - 180, 181, -1, 183, 184, 185, 186, 187, 188, 189, - 190, 191, -1, -1, -1, -1, -1, 197, -1, 199, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 199, 177, 178, 179, 180, 181, -1, 183, - 184, 185, 186, 187, 188, 189, 190, 191, -1, -1, - -1, -1, -1, 197, -1, 199, 177, 178, 179, 180, - 181, -1, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 199, 177, - 178, 179, 180, 181, -1, 183, 184, 185, 186, 187, - 188, 189, 190, 191, -1, -1, -1, -1, -1, 197, - -1, 199, 177, 178, 179, 180, 181, -1, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 199, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, 199, 177, 178, - 179, 180, 181, -1, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 199, 177, 178, 179, 180, 181, -1, 183, 184, 185, - 186, 187, 188, 189, 190, 191, -1, -1, -1, -1, - -1, 197, -1, 199, 177, 178, 179, 180, 181, -1, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 199, 177, 178, 179, - 180, 181, -1, 183, 184, 185, 186, 187, 188, 189, - 190, 191, -1, -1, -1, -1, -1, 197, -1, 199, - 177, 178, 179, 180, 181, -1, 183, 184, 185, 186, - 187, 188, 189, 190, 191, -1, -1, -1, -1, -1, - 197, -1, 199, 177, 178, 179, 180, 181, -1, 183, - 184, 185, 186, 187, 188, 189, 190, 191, -1, -1, - -1, -1, -1, 197, -1, 199, 177, 178, 179, 180, - 181, -1, 183, 184, 185, 186, 187, 188, 189, 190, - 191, -1, -1, -1, -1, -1, 197, -1, 199, 177, - 178, 179, 180, 181, -1, 183, 184, 185, 186, 187, - 188, 189, 190, 191, -1, -1, -1, -1, -1, 197, - -1, 199, 177, 178, 179, 180, 181, -1, 183, 184, - 185, 186, 187, 188, 189, 190, 191, -1, -1, -1, - -1, -1, 197, -1, 199, 177, 178, 179, 180, 181, - -1, 183, 184, 185, 186, 187, 188, 189, 190, 191, - -1, -1, -1, -1, -1, 197, -1, 199, 177, 178, - 179, 180, 181, -1, 183, 184, 185, 186, 187, 188, - 189, 190, 191, -1, -1, -1, -1, -1, 197, -1, - 199, 177, 178, 179, 180, 181, -1, 183, 184, 185, - 186, 187, 188, 189, 190, 191, -1, -1, -1, -1, - -1, 197, -1, 199, 177, 178, 179, 180, 181, -1, - 183, 184, 185, 186, 187, 188, 189, 190, 191, -1, - -1, -1, -1, -1, 197, -1, 199, 177, 178, 179, - 180, 181, -1, 183, 184, 185, 186, 187, 188, 189, - 190, 191, -1, -1, -1, -1, -1, 197, -1, 199 +/* YYTABLE[YYPACT[STATE-NUM]]. What to do in state STATE-NUM. If + positive, shift that token. If negative, reduce the rule which + number is the opposite. If zero, do what YYDEFACT says. + If YYTABLE_NINF, syntax error. */ +#define YYTABLE_NINF -57 +static const short yytable[] = +{ + 144, 212, 214, 78, 143, 79, 250, 566, 503, 539, + 913, 1122, 1418, 186, 1421, 382, 179, 181, 386, 189, + 200, 255, 203, 154, 751, 384, 198, 210, 215, 154, + 156, 392, 1074, 1412, 88, 101, 1073, 1412, 1413, 403, + 6, 405, 1413, 310, 1076, 373, 374, 1412, 210, 1412, + 175, 176, 1413, 904, 1413, 357, 126, 127, 128, 490, + 210, 177, 358, 375, 1263, 1492, 1412, 7, 178, 1492, + 89, 1413, 1492, 1272, 148, 210, 1075, 126, 127, 128, + 1279, 373, 374, 95, 408, 373, 374, 524, 1077, 126, + 127, 128, 525, 499, 373, 374, 193, 1321, 1107, 194, + 1108, 373, 374, 376, 126, 127, 128, 90, 303, 304, + 305, 91, 636, 306, 309, 92, 151, 314, 1109, 93, + 1110, 373, 374, 800, 334, 393, 335, 336, 337, 94, + 339, 499, 341, 342, 1322, 353, 150, 629, 1111, 96, + 1112, 1412, 630, 368, 1412, 370, 1413, 311, 312, 1413, + 736, 377, 371, 372, 210, 737, 155, 905, 906, 917, + 1058, 158, 155, 801, 742, 742, 373, 374, 803, 1067, + 802, 390, 391, 1491, 394, 97, 396, 1495, 1132, 399, + 400, 502, 199, 126, 127, 128, 1412, 1498, 757, 1707, + 147, 1413, 373, 374, 151, 101, 373, 374, 156, 745, + 883, 771, 129, 130, 131, 132, 1711, 884, 734, 557, + 735, 1188, 1061, 567, 216, 187, 1189, 204, 373, 374, + 385, 190, 201, 256, 446, 591, 752, 444, 211, 491, + 492, 493, 448, 449, 450, 451, 452, 453, 454, 455, + 456, 457, 458, 459, 460, 461, 462, 463, 464, 465, + 466, 467, 468, 469, 470, 471, 472, 473, 474, 475, + 476, 477, 478, 479, 480, 481, 482, 483, 484, 485, + 486, 487, 488, 489, 149, 598, 213, 1250, 1433, 373, + 374, 1713, 1437, 498, 1800, 1656, 1412, 1342, 1660, 504, + 1663, 1413, 509, 510, 511, 512, 513, 514, 515, 516, + 517, 518, 519, 520, 521, 522, 523, 1492, 373, 374, + 499, 1492, 974, 530, 1492, 532, 373, 374, 159, 1412, + 304, 498, 161, 499, 1413, 950, 1802, 1200, 152, 543, + 544, 545, 546, 547, 153, 549, 550, 551, 552, 553, + 554, 555, 560, 561, 157, 136, 137, 158, 129, 130, + 131, 132, 853, 568, 569, 570, 571, 373, 374, 257, + 580, 258, 129, 130, 131, 132, 578, 579, 587, 1141, + 136, 137, 160, 562, 562, 565, 565, 595, 162, 129, + 130, 131, 132, 1754, 136, 137, 259, 1758, 260, 1760, + 183, 744, 1432, 184, 185, 373, 374, 373, 374, 163, + 897, 136, 137, 373, 374, 1492, 373, 374, 742, 1492, + 743, 1492, 1334, 169, 1336, 168, 170, 171, 12, 172, + 1338, 373, 374, 1488, 635, 164, 1803, 373, 374, 1092, + 1093, 927, 747, 1568, 1569, 1570, 1571, 261, 1494, 262, + 1575, 173, 8, 9, 1497, 10, 174, 317, 318, 319, + 182, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 188, 958, 959, 960, 961, 331, 191, 740, + 136, 137, 304, 1101, 1102, 940, 1251, 853, 748, 263, + 746, 264, 317, 318, 319, 195, 320, 321, 322, 323, + 324, 325, 326, 327, 328, 329, 330, 328, 329, 330, + 498, 758, 331, 192, 975, 331, 206, 136, 137, 196, + 740, 769, 252, 498, 253, 773, 774, 165, 166, 265, + 167, 266, 499, 781, 197, 941, 790, 902, 326, 327, + 328, 329, 330, 791, 792, 267, 205, 268, 331, 136, + 137, 269, 795, 270, 494, 207, 253, 1669, 1670, 208, + 742, 1673, 772, 499, 804, 13, 14, 15, 16, 17, + 18, 19, 20, 209, 855, 814, 248, 816, 817, 46, + 47, 48, 49, 251, 51, 1398, 322, 323, 324, 325, + 326, 327, 328, 329, 330, 499, 499, 499, 499, 299, + 331, 136, 137, 1084, 313, 271, 535, 272, 253, 136, + 137, 1060, 1062, 273, 770, 274, 253, 1001, 1002, 1003, + 1004, 1005, 300, 854, 98, 343, 275, 277, 276, 278, + 102, 103, 104, 105, 106, 107, 108, 109, 110, 111, + 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, + 122, 123, 124, 125, 279, 1764, 280, 317, 318, 319, + 344, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 281, 283, 282, 284, 315, 331, 898, 136, + 137, 46, 47, 48, 49, 50, 51, 285, 287, 286, + 288, 332, 289, 291, 290, 292, 293, 316, 294, 887, + 888, 295, 297, 296, 298, 742, 1069, 931, 1070, 742, + 742, 1083, 1113, 889, 890, 891, 892, 893, 894, 895, + 301, 742, 498, 1114, 333, 499, 354, 901, 508, 742, + 907, 1115, 742, 1189, 1116, 1190, 338, 742, 919, 1207, + 916, 1709, 340, 1710, 1839, 355, 1722, 1229, 1723, 1724, + 1726, 1725, 1727, 498, 1749, 740, 1750, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 910, 1830, + 356, 1831, 1014, 331, 360, 954, 955, 956, 1922, 1924, + 1923, 1925, 1926, 362, 1927, 498, 498, 498, 498, 361, + 363, 964, 965, 364, 2053, 968, 2054, 2055, 2057, 2056, + 2058, 933, 981, 365, 366, 1894, 979, 980, 367, 133, + 345, 990, 2164, 389, 2165, 135, 2166, 2168, 2167, 2169, + 138, 2170, 2172, 2171, 2173, 141, 378, 346, 2174, 2251, + 2175, 2252, 2253, 2255, 2254, 2256, 2299, 2301, 2300, 2302, + 379, 380, 1018, 1019, 1020, 1021, 1022, 1023, 1024, 1025, + 1026, 1027, 1028, 1029, 1030, 1031, 1032, 1033, 1034, 1035, + 1036, 1037, 1038, 1039, 1040, 1041, 1042, 1043, 381, 317, + 318, 319, 395, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 2303, 2347, 2304, 2348, 854, 331, + 540, 398, 2349, 1063, 2350, 397, 401, 1068, 402, 404, + 317, 318, 319, 1072, 320, 321, 322, 323, 324, 325, + 326, 327, 328, 329, 330, 498, 2351, 1085, 2352, 1086, + 331, 319, 406, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 407, 1103, 1104, 1105, 409, 331, + 317, 318, 319, 410, 320, 321, 322, 323, 324, 325, + 326, 327, 328, 329, 330, 411, 412, 1124, 1125, 1126, + 331, 439, 413, 414, 415, 416, 417, 418, 419, 420, + 421, 422, 1404, 317, 318, 319, 423, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 424, 2074, + 425, 426, 427, 331, 442, 428, 429, 430, 431, 432, + 433, 1193, 434, 445, 1160, 1254, 98, 302, 435, 436, + 437, 438, 102, 103, 104, 105, 106, 107, 108, 109, + 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, + 120, 121, 122, 123, 124, 125, 441, 443, 331, 496, + 505, 506, 1224, 507, 536, 541, 548, 1194, 556, 582, + 583, 586, 589, 592, 1202, 599, 1203, 600, 601, 602, + 317, 318, 319, 603, 320, 321, 322, 323, 324, 325, + 326, 327, 328, 329, 330, 1212, 1213, 1214, 1215, 1285, + 331, 604, 605, 606, 607, 608, 1230, 1223, 1233, 609, + 1236, 610, 611, 612, 613, 614, 615, 616, 617, 618, + 619, 620, 1243, 1244, 621, 622, 623, 624, 625, 626, + 627, 628, 1253, 631, 562, 1256, 565, 632, 633, 738, + 962, 739, 749, 750, 754, 1266, 756, 789, 759, 760, + 761, 1348, 1273, 1274, 1275, 763, 765, 766, 775, 1280, + 793, 794, 806, 1284, 807, 808, 809, 1286, 1287, 1288, + 1289, 1290, 1291, 1292, 1293, 1294, 1295, 1296, 1297, 1298, + 1299, 1300, 1301, 1302, 1303, 1304, 1305, 1306, 1307, 1308, + 1309, 1310, 1311, 810, 812, 813, 819, 850, 820, 886, + 821, 822, 823, 824, 825, 826, 1320, 827, 828, 829, + 830, 133, 134, 1324, 831, 832, 833, 135, 834, 835, + 836, 837, 138, 838, 851, 307, 839, 141, 896, 308, + 840, 900, 1332, 841, 842, 843, 844, 845, 846, 847, + 848, 849, 852, 857, 858, 1430, 1066, 859, 860, 861, + 98, 302, 862, 1345, 863, 1346, 102, 103, 104, 105, + 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, + 116, 117, 118, 119, 120, 121, 122, 123, 124, 125, + 98, 302, 864, 865, 866, 867, 102, 103, 104, 105, + 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, + 116, 117, 118, 119, 120, 121, 122, 123, 124, 125, + 908, 909, 317, 318, 319, 911, 320, 321, 322, 323, + 324, 325, 326, 327, 328, 329, 330, 903, 868, 869, + 1402, 1403, 331, 1411, 870, 1417, 871, 1420, 915, 1410, + 922, 1416, 924, 1419, 872, 1422, 1423, 912, 935, 1426, + 934, 873, 874, 875, 876, 877, 878, 936, 1435, 562, + 879, 565, 880, 881, 882, 937, 1443, 938, 939, 942, + 943, 1448, 944, 945, 1451, 946, 1453, 1454, 1455, 1456, + 1457, 1458, 1459, 1460, 1461, 1462, 1463, 1464, 1465, 1466, + 1467, 1468, 1469, 1470, 1471, 1472, 1473, 1474, 1475, 1476, + 1477, 1478, 1567, 947, 1316, 1480, 948, 370, 949, 957, + 1485, 963, 303, 304, 1486, 969, 971, 976, 317, 318, + 319, 977, 320, 321, 322, 323, 324, 325, 326, 327, + 328, 329, 330, 978, 982, 133, 134, 983, 331, 984, + 985, 135, 986, 989, 991, 992, 138, 995, 996, 767, + 997, 141, 998, 768, 999, 1008, 1013, 1057, 1009, 1010, + 1011, 1012, 1016, 1015, 1619, 133, 134, 1047, 1059, 1064, + 1065, 135, 1071, 1079, 1081, 1082, 138, 1090, 1091, 929, + 1106, 141, 1119, 930, 1120, 1123, 1127, 1128, 1129, 1133, + 1134, 1135, 1136, 1551, 1137, 1138, 1139, 1143, 1140, 1556, + 1144, 1142, 1560, 1145, 1146, 1161, 1147, 1148, 1149, 1151, + 1195, 1150, 1152, 1327, 1191, 1153, 1668, 1154, 1155, 1156, + 1158, 1157, 1159, 1196, 1198, 1206, 1583, 1584, 1585, 1586, + 1587, 1588, 1589, 1590, 1591, 1592, 1593, 1594, 1595, 1596, + 1597, 1598, 1599, 1600, 1601, 1602, 1603, 1204, 1605, 1606, + 317, 318, 319, 1205, 320, 321, 322, 323, 324, 325, + 326, 327, 328, 329, 330, 1209, 1210, 1211, 1216, 1217, + 331, 1218, 1219, 1220, 1221, 1222, 317, 318, 319, 776, + 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, + 330, 1328, 1231, 1234, 1237, 351, 331, 1239, 1240, 1241, + 1242, 359, 1245, 1246, 1255, 1258, 1259, 1261, 1260, 1319, + 1703, 1262, 1264, 1265, 1763, 1329, 1268, 1267, 1269, 1271, + 1270, 1277, 1278, 1281, 383, 1282, 1323, 1283, 1313, 387, + 388, 1676, 1678, 1680, 1681, 1682, 1683, 1684, 1685, 1686, + 1687, 1688, 1689, 1690, 1691, 1692, 1693, 1694, 1695, 1696, + 1697, 1698, 1699, 1700, 1701, 98, 537, 1314, 1344, 1315, + 1806, 102, 103, 104, 105, 106, 107, 108, 109, 110, + 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, + 121, 122, 123, 124, 125, 317, 318, 319, 1317, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 1318, 1330, 1333, 1838, 1331, 331, 1335, 1337, 1339, 1795, + 1349, 1798, 1343, 1351, 1352, 1354, 1353, 1355, 1357, 1363, + 1358, 1762, 1359, 1364, 1365, 1368, 1367, 1768, 1397, 1770, + 1424, 1772, 1370, 1774, 1775, 1776, 1777, 1778, 1779, 1780, + 1781, 1782, 1783, 1784, 1785, 1786, 1787, 1788, 1789, 1790, + 1791, 1792, 1793, 1794, 1399, 1431, 1434, 1436, 1438, 1439, + 1440, 1441, 1449, 317, 318, 319, 1442, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 1444, 1503, + 1446, 1447, 1450, 331, 1452, 1484, 1479, 317, 318, 319, + 1862, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 1481, 1490, 1489, 1504, 1501, 331, 1505, 1836, + 1837, 1549, 1502, 1506, 1553, 1554, 1557, 1844, 1845, 1846, + 1847, 1848, 1849, 1850, 1851, 1852, 1853, 1854, 1855, 1856, + 1857, 1858, 1859, 1860, 1861, 1507, 1508, 1510, 1511, 1513, + 133, 134, 1515, 1558, 1517, 1545, 135, 1561, 1562, 1563, + 1566, 138, 1572, 1573, 1574, 1576, 141, 1577, 538, 1578, + 1579, 1607, 1610, 1612, 1617, 593, 1613, 1615, 1622, 1890, + 1618, 1620, 1621, 1623, 1896, 1898, 1900, 1901, 1902, 1903, + 1904, 1905, 1906, 1907, 1908, 1909, 1910, 1911, 1912, 1913, + 1914, 1915, 1916, 1917, 1918, 98, 302, 1624, 1625, 1654, + 1655, 102, 103, 104, 105, 106, 107, 108, 109, 110, + 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, + 121, 122, 123, 124, 125, 1626, 1627, 1949, 1628, 1951, + 1650, 1953, 741, 1955, 1956, 1957, 1958, 1959, 1960, 1961, + 1962, 1963, 1964, 1965, 1966, 1967, 1968, 1969, 1970, 1971, + 1972, 317, 318, 319, 1657, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 1653, 1661, 1664, 1667, + 1671, 331, 1672, 1674, 1708, 1705, 1706, 1712, 755, 1717, + 1753, 1720, 1996, 1997, 1998, 1999, 2000, 2001, 2002, 2003, + 2004, 2005, 2006, 2007, 2008, 2009, 2010, 1714, 1718, 1715, + 1716, 1719, 1721, 1756, 1757, 1751, 1759, 1752, 1761, 1766, + 1767, 1769, 1771, 1773, 1796, 1799, 1807, 2032, 2034, 2036, + 2037, 2038, 2039, 2040, 2041, 2042, 2043, 2044, 2045, 2046, + 2047, 2048, 2049, 2050, 2051, 317, 318, 319, 1801, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 1832, 1804, 1833, 1834, 1835, 331, 1863, 1808, 2075, 1866, + 2077, 1891, 2079, 1867, 2081, 2082, 2083, 2084, 2085, 2086, + 2087, 2088, 2089, 2090, 2091, 2092, 2093, 2094, 2095, 1868, + 1407, 1408, 1869, 1870, 1871, 1892, 135, 1920, 1921, 1946, + 1948, 1409, 1950, 1952, 1954, 1973, 141, 2012, 178, 2076, + 2011, 2078, 2013, 2014, 2052, 2080, 2096, 2112, 2119, 2120, + 2121, 2122, 2123, 2124, 2125, 2126, 2127, 2128, 2186, 2129, + 2130, 2131, 2132, 2133, 2188, 2190, 2192, 2194, 2196, 2230, + 2231, 2232, 2264, 2144, 2146, 2148, 2150, 2152, 2154, 2155, + 2156, 2157, 2158, 2159, 2160, 2161, 2162, 2163, 317, 318, + 319, 2266, 320, 321, 322, 323, 324, 325, 326, 327, + 328, 329, 330, 2268, 2284, 2285, 2286, 2309, 331, 2185, + 2311, 2187, 2313, 2189, 2354, 2191, 2356, 2193, 2338, 2195, + 2358, 2197, 2198, 2199, 2200, 2201, 2202, 2203, 2204, 2205, + 2339, 2340, 856, 77, 85, 0, 920, 921, 0, 923, + 1046, 925, 926, 1197, 0, 0, 0, 0, 0, 0, + 0, 2215, 2216, 2217, 2218, 2219, 2220, 0, 0, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 2233, + 2234, 2235, 2236, 2237, 2238, 2240, 2242, 2244, 0, 0, + 0, 0, 0, 0, 966, 967, 0, 0, 970, 0, + 2257, 2258, 2259, 2260, 2261, 2262, 2263, 0, 2265, 0, + 2267, 0, 0, 0, 0, 987, 988, 0, 0, 0, + 0, 993, 994, 0, 2275, 2276, 2277, 0, 1000, 0, + 1007, 0, 0, 0, 0, 0, 2287, 2288, 2289, 2291, + 2293, 2295, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 2305, 2306, 2307, 2308, 0, 2310, 0, 2312, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 2317, + 2318, 2319, 0, 0, 0, 2323, 2324, 2325, 0, 0, + 0, 2329, 2330, 2331, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 2342, 2344, 2346, 0, 0, 0, 0, + 0, 0, 2353, 0, 2355, 0, 2357, 0, 1078, 0, + 1080, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 1087, 1088, 1089, 0, 0, 0, 0, 1094, 1095, + 1096, 1097, 1098, 1099, 1100, 0, 0, 0, 0, 98, + 99, 100, 0, 101, 0, 102, 103, 104, 105, 106, + 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, + 117, 118, 119, 120, 121, 122, 123, 124, 125, 0, + 126, 127, 128, 98, 343, 0, 0, 0, 0, 102, + 103, 104, 105, 106, 107, 108, 109, 110, 111, 112, + 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, + 123, 124, 125, 0, 0, 0, 317, 318, 319, 344, + 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, + 330, 0, 0, 0, 0, 0, 331, 0, 495, 0, + 46, 47, 48, 49, 50, 51, 0, 0, 932, 0, + 0, 98, 302, 210, 0, 0, 1192, 102, 103, 104, + 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, + 115, 116, 117, 118, 119, 120, 121, 122, 123, 124, + 125, 0, 126, 127, 128, 98, 302, 0, 0, 0, + 0, 102, 103, 104, 105, 106, 107, 108, 109, 110, + 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, + 121, 122, 123, 124, 125, 0, 0, 973, 0, 1247, + 129, 130, 131, 132, 0, 0, 0, 1257, 0, 0, + 0, 0, 0, 0, 133, 134, 0, 0, 0, 0, + 135, 0, 136, 137, 0, 138, 1276, 139, 0, 140, + 141, 0, 0, 317, 318, 319, 0, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 133, 497, + 0, 0, 0, 331, 135, 0, 0, 0, 0, 138, + 98, 537, 780, 0, 141, 1312, 102, 103, 104, 105, + 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, + 116, 117, 118, 119, 120, 121, 122, 123, 124, 125, + 0, 0, 0, 0, 0, 0, 0, 0, 317, 318, + 319, 0, 320, 321, 322, 323, 324, 325, 326, 327, + 328, 329, 330, 0, 0, 0, 133, 134, 331, 0, + 0, 0, 135, 0, 0, 0, 0, 138, 0, 0, + 0, 0, 141, 572, 30, 31, 573, 574, 34, 575, + 36, 0, 37, 0, 39, 40, 41, 0, 43, 44, + 133, 134, 0, 0, 0, 0, 135, 0, 0, 0, + 0, 138, 0, 0, 0, 56, 141, 317, 318, 319, + 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 0, 0, 0, 0, 58, 59, 60, 317, 318, + 319, 0, 320, 321, 322, 323, 324, 325, 326, 327, + 328, 329, 330, 70, 0, 0, 0, 0, 331, 1425, + 495, 0, 0, 1429, 0, 558, 0, -8, 1, 0, + -13, -56, 0, 0, 0, 0, 0, 0, 0, 1445, + 0, 0, 0, 0, 0, 133, 134, 0, 0, 0, + 0, 135, 0, 0, 0, 0, 138, 0, 0, 0, + -56, 141, 0, 0, -56, -56, -56, -56, -56, -56, + -56, -56, -56, -56, 0, -56, -56, -56, -56, -56, + -56, -56, -56, 0, 0, 0, -56, -56, -56, -56, + -56, -56, -56, 0, -56, -56, -56, -56, -56, 0, + 0, 576, 0, 0, 317, 318, 319, 0, 320, 321, + 322, 323, 324, 325, 326, 327, 328, 329, 330, 0, + 0, 0, 0, 0, 331, 0, 0, -56, -56, -56, + -56, 1227, 0, 1228, 0, -56, 0, -56, 0, -56, + -56, -56, -56, -56, -56, -56, -56, -56, -56, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 1546, 1547, + 0, 0, 0, 0, 0, 0, 1552, -13, -13, -13, + -13, -13, -13, -13, -13, 0, 0, 1564, 1565, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, -8, -8, 0, -8, 572, 30, 31, 573, + 574, 34, 575, 36, 0, 37, 0, 39, 40, 41, + 0, 43, 44, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 1608, 1609, 0, 0, 0, 0, 56, 0, + 0, 0, 572, 30, 31, 573, 574, 34, 575, 36, + 0, 37, 0, 39, 40, 41, 0, 43, 44, 0, + 0, 0, 0, 0, 0, 0, 0, 0, 58, 59, + 60, 0, 0, 0, 56, 0, 572, 30, 31, 573, + 574, 34, 575, 36, 0, 37, 70, 39, 40, 41, + 0, 43, 44, 0, 0, 0, 0, 0, 1659, 0, + 0, 0, 0, 1666, 58, 59, 60, 0, 56, 0, + 0, 0, 0, 0, 572, 30, 31, 573, 574, 34, + 575, 36, 70, 37, 0, 39, 40, 41, 0, 43, + 44, 0, 0, 0, 0, 0, 0, 0, 58, 59, + 60, 0, 0, 0, 0, 0, 56, 0, 0, 0, + 0, 0, 0, 317, 318, 319, 70, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 581, 0, 58, 59, 60, 0, + 1248, 0, 1249, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, 0, 70, 1755, 218, 0, 0, 0, + 0, 0, 0, 0, 0, 1765, 0, 0, 0, 0, + 596, 637, 638, 639, 640, 641, 642, 643, 644, 645, + 646, 647, 648, 649, 650, 651, 652, 653, 654, 655, + 656, 657, 658, 659, 660, 661, 662, 663, 0, 0, + 0, 0, 0, 0, 597, 637, 638, 639, 640, 641, + 642, 643, 644, 645, 646, 647, 648, 649, 650, 651, + 652, 653, 654, 655, 656, 657, 658, 659, 660, 661, + 662, 663, 0, 0, 0, 0, 219, 220, 221, 0, + 0, 0, 815, 0, 222, 223, 224, 225, 226, 227, + 228, 229, 230, 231, 1840, 0, 0, 0, 0, 0, + 0, 0, 232, 233, 234, 235, 236, 237, 238, 239, + 240, 241, 0, 242, 243, 244, 245, 246, 247, 0, + 0, 0, 317, 318, 319, 25, 320, 321, 322, 323, + 324, 325, 326, 327, 328, 329, 330, 0, 0, 0, + 0, 0, 331, 0, 0, 664, 0, 0, 0, 1405, + 0, 1406, 0, 1893, 26, 0, 0, 0, 27, 28, + 29, 30, 31, 32, 33, 34, 35, 36, 0, 37, + 38, 39, 40, 41, 42, 43, 44, 0, 0, 1017, + 45, 46, 47, 48, 49, 50, 51, 0, 52, 53, + 54, 55, 56, 0, 0, 0, 0, 0, 572, 30, + 31, 573, 574, 34, 575, 36, 1947, 37, 0, 39, + 40, 41, 0, 43, 44, 0, 0, 0, 0, 0, + 0, 57, 58, 59, 60, 0, 0, 0, 0, 61, + 56, 62, 0, 63, 64, 65, 66, 67, 68, 69, + 70, 71, 72, 317, 318, 319, 0, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 1992, + 58, 59, 60, 331, 0, 0, 0, 0, 0, 0, + 0, 0, 782, 0, 0, 317, 318, 319, 70, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 2030, 0, 0, + 0, 317, 318, 319, 783, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 0, 0, 317, 318, 319, + 928, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 0, 0, 317, 318, 319, 953, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 0, 0, 317, + 318, 319, 1225, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 0, 0, 317, 318, 319, 1427, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 0, + 0, 317, 318, 319, 1428, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 0, 0, 317, 318, 319, + 1487, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 0, 0, 317, 318, 319, 1493, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 0, 0, 317, + 318, 319, 1496, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 0, 0, 317, 318, 319, 1499, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 0, + 0, 317, 318, 319, 1500, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 0, 0, 317, 318, 319, + 1548, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 0, 0, 317, 318, 319, 1611, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 0, 0, 317, + 318, 319, 1614, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 0, 0, 317, 318, 319, 1616, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 0, + 0, 317, 318, 319, 1652, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 0, 0, 317, 318, 319, + 1865, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 0, 0, 317, 318, 319, 1919, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 526, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 558, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 559, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 590, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 714, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 715, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 728, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 729, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 730, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 731, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 732, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 733, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 796, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 797, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 798, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 918, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 951, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 952, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 972, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1117, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1118, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1130, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1131, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1162, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1163, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1164, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1165, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1166, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1167, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1168, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1169, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1170, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1171, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1172, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1173, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1174, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1175, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1176, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1177, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1178, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1179, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1180, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1181, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1182, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1183, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1184, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1185, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1186, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1187, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1201, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1208, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1325, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1326, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1340, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1341, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1347, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1350, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1361, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1366, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1369, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1371, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1372, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1373, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1374, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1375, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1376, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1377, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1378, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1379, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1380, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1381, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1382, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1383, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1384, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1385, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1386, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1387, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1388, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1389, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1390, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1391, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1392, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1393, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1394, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1395, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1396, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1400, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1401, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1509, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1521, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1522, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1523, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1524, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1525, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1526, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1527, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1528, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1529, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1530, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1531, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1532, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1533, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1534, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1535, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1536, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1537, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1538, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1539, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1540, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1541, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1543, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1544, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1629, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1630, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1631, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1632, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1633, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1634, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1635, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1636, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1637, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1638, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1639, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1640, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1641, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1642, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1643, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1644, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1645, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1646, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1647, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1648, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1649, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1728, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1729, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1730, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1731, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1732, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1733, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1734, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1735, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1736, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1737, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1738, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1739, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1740, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1741, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1742, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1743, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1744, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1745, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1746, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1747, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1748, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1805, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1812, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1813, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1814, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1815, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1816, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1817, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1818, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1819, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1820, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1821, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1822, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1823, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1824, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1825, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1826, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1827, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1828, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1829, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1864, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1872, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1873, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1874, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1875, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1876, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1877, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1878, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1879, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1880, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1881, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1882, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1883, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1884, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1885, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1886, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1887, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1888, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1889, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1928, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1929, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1930, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1931, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1932, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1933, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1934, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1935, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1936, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1937, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1938, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1939, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1940, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1941, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1942, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1943, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1944, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1945, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1977, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1978, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1979, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1980, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1981, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1982, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1983, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1984, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1985, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1986, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 1987, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 1988, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 1989, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 1990, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 1991, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2015, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2016, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2017, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 2018, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 2019, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2020, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2021, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2022, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 2023, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 2024, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2025, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2026, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2027, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 2028, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 2029, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2059, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2060, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2061, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 2062, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 2063, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2064, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2065, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2066, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 2067, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 2068, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2069, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2070, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2071, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 2072, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 2073, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2103, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2104, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2105, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 2106, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 2107, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2108, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2109, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2110, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 2111, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 2134, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2135, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2136, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2137, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 2138, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 2139, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2140, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2141, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2142, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 2176, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 2177, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2178, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2179, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2180, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 2181, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 2182, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2183, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2184, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2206, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 2207, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 2208, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2209, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2210, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2211, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 2224, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 2225, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2226, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2227, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2228, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 2229, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 2245, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2246, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2247, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2248, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 2249, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 2250, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2269, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2270, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2271, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 2281, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 2282, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2283, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2296, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2297, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 2298, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 2314, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2315, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2316, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2320, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 0, 0, 317, + 318, 319, 2321, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 0, 0, 317, 318, 319, 2322, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 0, 0, 317, 318, 319, + 2326, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 0, + 0, 317, 318, 319, 2327, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 0, 0, 317, 318, 319, 2328, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 317, 318, 319, 501, + 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, + 330, 0, 0, 0, 0, 0, 331, 317, 318, 319, + 634, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 317, 318, + 319, 693, 320, 321, 322, 323, 324, 325, 326, 327, + 328, 329, 330, 0, 0, 0, 0, 0, 331, 317, + 318, 319, 695, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 317, 318, 319, 697, 320, 321, 322, 323, 324, 325, + 326, 327, 328, 329, 330, 0, 0, 0, 0, 0, + 331, 317, 318, 319, 699, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 317, 318, 319, 701, 320, 321, 322, 323, + 324, 325, 326, 327, 328, 329, 330, 0, 0, 0, + 0, 0, 331, 317, 318, 319, 703, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 317, 318, 319, 705, 320, 321, + 322, 323, 324, 325, 326, 327, 328, 329, 330, 0, + 0, 0, 0, 0, 331, 317, 318, 319, 707, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 317, 318, 319, 709, + 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, + 330, 0, 0, 0, 0, 0, 331, 317, 318, 319, + 711, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 317, 318, + 319, 713, 320, 321, 322, 323, 324, 325, 326, 327, + 328, 329, 330, 0, 0, 0, 0, 0, 331, 317, + 318, 319, 717, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 317, 318, 319, 719, 320, 321, 322, 323, 324, 325, + 326, 327, 328, 329, 330, 0, 0, 0, 0, 0, + 331, 317, 318, 319, 721, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 317, 318, 319, 723, 320, 321, 322, 323, + 324, 325, 326, 327, 328, 329, 330, 0, 0, 0, + 0, 0, 331, 317, 318, 319, 725, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 317, 318, 319, 727, 320, 321, + 322, 323, 324, 325, 326, 327, 328, 329, 330, 0, + 0, 0, 0, 0, 331, 317, 318, 319, 799, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 317, 318, 319, 805, + 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, + 330, 0, 0, 0, 0, 0, 331, 317, 318, 319, + 899, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 317, 318, + 319, 1049, 320, 321, 322, 323, 324, 325, 326, 327, + 328, 329, 330, 0, 0, 0, 0, 0, 331, 317, + 318, 319, 1051, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 317, 318, 319, 1053, 320, 321, 322, 323, 324, 325, + 326, 327, 328, 329, 330, 0, 0, 0, 0, 0, + 331, 317, 318, 319, 1055, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 317, 318, 319, 1056, 320, 321, 322, 323, + 324, 325, 326, 327, 328, 329, 330, 0, 0, 0, + 0, 0, 331, 317, 318, 319, 1199, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 527, 317, 318, 319, 0, + 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, + 330, 0, 0, 0, 0, 0, 331, 0, 528, 317, + 318, 319, 0, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 529, 317, 318, 319, 0, 320, 321, 322, 323, + 324, 325, 326, 327, 328, 329, 330, 0, 0, 0, + 0, 0, 331, 0, 531, 317, 318, 319, 0, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 533, 317, 318, + 319, 0, 320, 321, 322, 323, 324, 325, 326, 327, + 328, 329, 330, 0, 0, 0, 0, 0, 331, 0, + 534, 317, 318, 319, 0, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 542, 317, 318, 319, 0, 320, 321, + 322, 323, 324, 325, 326, 327, 328, 329, 330, 0, + 0, 0, 0, 0, 331, 0, 584, 317, 318, 319, + 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 585, + 317, 318, 319, 0, 320, 321, 322, 323, 324, 325, + 326, 327, 328, 329, 330, 0, 0, 0, 0, 0, + 331, 0, 588, 317, 318, 319, 0, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 594, 317, 318, 319, 0, + 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, + 330, 0, 0, 0, 0, 0, 331, 0, 692, 317, + 318, 319, 0, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 694, 317, 318, 319, 0, 320, 321, 322, 323, + 324, 325, 326, 327, 328, 329, 330, 0, 0, 0, + 0, 0, 331, 0, 696, 317, 318, 319, 0, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 698, 317, 318, + 319, 0, 320, 321, 322, 323, 324, 325, 326, 327, + 328, 329, 330, 0, 0, 0, 0, 0, 331, 0, + 700, 317, 318, 319, 0, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 702, 317, 318, 319, 0, 320, 321, + 322, 323, 324, 325, 326, 327, 328, 329, 330, 0, + 0, 0, 0, 0, 331, 0, 704, 317, 318, 319, + 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 706, + 317, 318, 319, 0, 320, 321, 322, 323, 324, 325, + 326, 327, 328, 329, 330, 0, 0, 0, 0, 0, + 331, 0, 708, 317, 318, 319, 0, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 710, 317, 318, 319, 0, + 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, + 330, 0, 0, 0, 0, 0, 331, 0, 712, 317, + 318, 319, 0, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 716, 317, 318, 319, 0, 320, 321, 322, 323, + 324, 325, 326, 327, 328, 329, 330, 0, 0, 0, + 0, 0, 331, 0, 718, 317, 318, 319, 0, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 720, 317, 318, + 319, 0, 320, 321, 322, 323, 324, 325, 326, 327, + 328, 329, 330, 0, 0, 0, 0, 0, 331, 0, + 722, 317, 318, 319, 0, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 724, 317, 318, 319, 0, 320, 321, + 322, 323, 324, 325, 326, 327, 328, 329, 330, 0, + 0, 0, 0, 0, 331, 0, 726, 317, 318, 319, + 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 762, + 317, 318, 319, 0, 320, 321, 322, 323, 324, 325, + 326, 327, 328, 329, 330, 0, 0, 0, 0, 0, + 331, 0, 764, 317, 318, 319, 0, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 777, 317, 318, 319, 0, + 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, + 330, 0, 0, 0, 0, 0, 331, 0, 778, 317, + 318, 319, 0, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 779, 317, 318, 319, 0, 320, 321, 322, 323, + 324, 325, 326, 327, 328, 329, 330, 0, 0, 0, + 0, 0, 331, 0, 784, 317, 318, 319, 0, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 785, 317, 318, + 319, 0, 320, 321, 322, 323, 324, 325, 326, 327, + 328, 329, 330, 0, 0, 0, 0, 0, 331, 0, + 786, 317, 318, 319, 0, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 787, 317, 318, 319, 0, 320, 321, + 322, 323, 324, 325, 326, 327, 328, 329, 330, 0, + 0, 0, 0, 0, 331, 0, 788, 317, 318, 319, + 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 811, + 317, 318, 319, 0, 320, 321, 322, 323, 324, 325, + 326, 327, 328, 329, 330, 0, 0, 0, 0, 0, + 331, 0, 818, 317, 318, 319, 0, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 1048, 317, 318, 319, 0, + 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, + 330, 0, 0, 0, 0, 0, 331, 0, 1050, 317, + 318, 319, 0, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 1052, 317, 318, 319, 0, 320, 321, 322, 323, + 324, 325, 326, 327, 328, 329, 330, 0, 0, 0, + 0, 0, 331, 0, 1054, 317, 318, 319, 0, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 1121, 317, 318, + 319, 0, 320, 321, 322, 323, 324, 325, 326, 327, + 328, 329, 330, 0, 0, 0, 0, 0, 331, 0, + 1226, 317, 318, 319, 0, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 1252, 317, 318, 319, 0, 320, 321, + 322, 323, 324, 325, 326, 327, 328, 329, 330, 0, + 0, 0, 0, 0, 331, 0, 1356, 317, 318, 319, + 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 1360, + 317, 318, 319, 0, 320, 321, 322, 323, 324, 325, + 326, 327, 328, 329, 330, 0, 0, 0, 0, 0, + 331, 0, 1362, 317, 318, 319, 0, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 1482, 317, 318, 319, 0, + 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, + 330, 0, 0, 0, 0, 0, 331, 0, 1483, 317, + 318, 319, 0, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 1512, 317, 318, 319, 0, 320, 321, 322, 323, + 324, 325, 326, 327, 328, 329, 330, 0, 0, 0, + 0, 0, 331, 0, 1514, 317, 318, 319, 0, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 1516, 317, 318, + 319, 0, 320, 321, 322, 323, 324, 325, 326, 327, + 328, 329, 330, 0, 0, 0, 0, 0, 331, 0, + 1518, 317, 318, 319, 0, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 1519, 317, 318, 319, 0, 320, 321, + 322, 323, 324, 325, 326, 327, 328, 329, 330, 0, + 0, 0, 0, 0, 331, 0, 1520, 317, 318, 319, + 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 1542, + 317, 318, 319, 0, 320, 321, 322, 323, 324, 325, + 326, 327, 328, 329, 330, 0, 0, 0, 0, 0, + 331, 0, 1651, 317, 318, 319, 0, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 1809, 317, 318, 319, 0, + 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, + 330, 0, 0, 0, 0, 0, 331, 0, 1810, 317, + 318, 319, 0, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 1811, 317, 318, 319, 0, 320, 321, 322, 323, + 324, 325, 326, 327, 328, 329, 330, 0, 0, 0, + 0, 0, 331, 0, 1974, 317, 318, 319, 0, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 1975, 317, 318, + 319, 0, 320, 321, 322, 323, 324, 325, 326, 327, + 328, 329, 330, 0, 0, 0, 0, 0, 331, 0, + 1976, 317, 318, 319, 0, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 2097, 317, 318, 319, 0, 320, 321, + 322, 323, 324, 325, 326, 327, 328, 329, 330, 0, + 0, 0, 0, 0, 331, 0, 2098, 317, 318, 319, + 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 2099, + 317, 318, 319, 0, 320, 321, 322, 323, 324, 325, + 326, 327, 328, 329, 330, 0, 0, 0, 0, 0, + 331, 0, 2100, 317, 318, 319, 0, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 2101, 317, 318, 319, 0, + 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, + 330, 0, 0, 0, 0, 0, 331, 0, 2102, 317, + 318, 319, 0, 320, 321, 322, 323, 324, 325, 326, + 327, 328, 329, 330, 0, 0, 0, 0, 0, 331, + 0, 2212, 317, 318, 319, 0, 320, 321, 322, 323, + 324, 325, 326, 327, 328, 329, 330, 0, 0, 0, + 0, 0, 331, 0, 2213, 317, 318, 319, 0, 320, + 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, + 0, 0, 0, 0, 0, 331, 0, 2214, 317, 318, + 319, 0, 320, 321, 322, 323, 324, 325, 326, 327, + 328, 329, 330, 0, 0, 0, 0, 0, 331, 0, + 2272, 317, 318, 319, 0, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 0, 0, 0, 0, + 0, 331, 0, 2273, 317, 318, 319, 0, 320, 321, + 322, 323, 324, 325, 326, 327, 328, 329, 330, 0, + 0, 0, 0, 0, 331, 0, 2274, 317, 318, 319, + 0, 320, 321, 322, 323, 324, 325, 326, 327, 328, + 329, 330, 0, 0, 0, 0, 0, 331, 0, 2332, + 317, 318, 319, 0, 320, 321, 322, 323, 324, 325, + 326, 327, 328, 329, 330, 0, 0, 0, 0, 0, + 331, 0, 2333, 317, 318, 319, 0, 320, 321, 322, + 323, 324, 325, 326, 327, 328, 329, 330, 0, 0, + 0, 0, 0, 331, 0, 2334, 317, 318, 319, 0, + 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, + 330, 0, 0, 0, 0, 0, 331 }; -/* -*-C-*- Note some compilers choke on comments on `#line' lines. */ -#line 3 "/usr/share/bison.simple" -/* This file comes from bison-1.28. */ - -/* Skeleton output parser for bison, - Copyright (C) 1984, 1989, 1990 Free Software Foundation, Inc. - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2, or (at your option) - any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License - along with this program; if not, write to the Free Software - Foundation, Inc., 59 Temple Place - Suite 330, - Boston, MA 02111-1307, USA. */ +static const short yycheck[] = +{ + 25, 71, 72, 5, 25, 5, 96, 376, 310, 346, + 752, 969, 1337, 4, 1339, 187, 47, 48, 190, 4, + 4, 4, 4, 66, 4, 6, 43, 5, 3, 66, + 66, 105, 6, 67, 169, 7, 6, 67, 72, 211, + 6, 213, 72, 4, 6, 188, 189, 67, 5, 67, + 188, 189, 72, 4, 72, 199, 34, 35, 36, 4, + 5, 199, 206, 206, 1137, 1414, 67, 0, 206, 1418, + 7, 72, 1421, 1146, 6, 5, 50, 34, 35, 36, + 1153, 188, 189, 199, 217, 188, 189, 200, 50, 34, + 35, 36, 205, 308, 188, 189, 39, 6, 205, 42, + 207, 188, 189, 206, 34, 35, 36, 6, 133, 134, + 135, 6, 206, 138, 139, 6, 199, 142, 205, 6, + 207, 188, 189, 206, 149, 199, 151, 152, 153, 6, + 155, 346, 157, 158, 6, 160, 6, 200, 205, 199, + 207, 67, 205, 174, 67, 176, 72, 108, 109, 72, + 200, 182, 177, 178, 5, 205, 199, 108, 109, 200, + 200, 199, 199, 206, 205, 205, 188, 189, 206, 911, + 206, 196, 197, 207, 199, 199, 201, 207, 200, 204, + 205, 7, 199, 34, 35, 36, 67, 207, 525, 207, + 199, 72, 188, 189, 199, 7, 188, 189, 66, 501, + 199, 538, 174, 175, 176, 177, 207, 206, 201, 205, + 203, 200, 7, 205, 189, 206, 205, 199, 188, 189, + 201, 206, 206, 206, 255, 397, 206, 252, 206, 299, + 300, 301, 257, 258, 259, 260, 261, 262, 263, 264, + 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, + 275, 276, 277, 278, 279, 280, 281, 282, 283, 284, + 285, 286, 287, 288, 289, 290, 291, 292, 293, 294, + 295, 296, 297, 298, 206, 408, 206, 8, 1351, 188, + 189, 207, 1355, 308, 207, 1610, 67, 1245, 1613, 310, + 1615, 72, 317, 318, 319, 320, 321, 322, 323, 324, + 325, 326, 327, 328, 329, 330, 331, 1656, 188, 189, + 525, 1660, 8, 338, 1663, 340, 188, 189, 47, 67, + 345, 346, 43, 538, 72, 205, 207, 1069, 199, 354, + 355, 356, 357, 358, 199, 360, 361, 362, 363, 364, + 365, 366, 373, 374, 199, 196, 197, 199, 174, 175, + 176, 177, 203, 378, 379, 380, 381, 188, 189, 199, + 385, 201, 174, 175, 176, 177, 6, 7, 393, 200, + 196, 197, 199, 375, 376, 375, 376, 402, 43, 174, + 175, 176, 177, 1708, 196, 197, 199, 1712, 201, 1714, + 39, 203, 1350, 42, 43, 188, 189, 188, 189, 43, + 737, 196, 197, 188, 189, 1754, 188, 189, 205, 1758, + 207, 1760, 205, 39, 205, 45, 42, 43, 3, 45, + 205, 188, 189, 205, 445, 43, 207, 188, 189, 57, + 58, 768, 502, 1506, 1507, 1508, 1509, 199, 205, 201, + 1513, 199, 165, 166, 205, 168, 206, 178, 179, 180, + 206, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, 43, 800, 801, 802, 803, 198, 6, 494, + 196, 197, 497, 6, 7, 6, 207, 203, 503, 199, + 501, 201, 178, 179, 180, 4, 182, 183, 184, 185, + 186, 187, 188, 189, 190, 191, 192, 190, 191, 192, + 525, 526, 198, 6, 200, 198, 6, 196, 197, 199, + 535, 536, 201, 538, 203, 540, 541, 42, 43, 199, + 45, 201, 737, 548, 199, 56, 557, 742, 188, 189, + 190, 191, 192, 558, 559, 199, 199, 201, 198, 196, + 197, 199, 567, 201, 201, 4, 203, 1620, 1621, 4, + 205, 1624, 207, 768, 579, 140, 141, 142, 143, 144, + 145, 146, 147, 43, 634, 590, 199, 592, 593, 60, + 61, 62, 63, 5, 65, 1317, 184, 185, 186, 187, + 188, 189, 190, 191, 192, 800, 801, 802, 803, 199, + 198, 196, 197, 930, 4, 199, 201, 201, 203, 196, + 197, 903, 904, 199, 201, 201, 203, 125, 126, 127, + 128, 129, 199, 634, 3, 4, 199, 199, 201, 201, + 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, + 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, + 29, 30, 31, 32, 199, 1718, 201, 178, 179, 180, + 39, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, 199, 199, 201, 201, 6, 198, 738, 196, + 197, 60, 61, 62, 63, 64, 65, 199, 199, 201, + 201, 6, 199, 199, 201, 201, 199, 6, 201, 714, + 715, 199, 199, 201, 201, 205, 205, 207, 207, 205, + 205, 207, 207, 728, 729, 730, 731, 732, 733, 734, + 199, 205, 737, 207, 5, 930, 206, 742, 6, 205, + 745, 207, 205, 205, 207, 207, 199, 205, 759, 207, + 755, 205, 199, 207, 1807, 199, 205, 1106, 207, 205, + 205, 207, 207, 768, 205, 770, 207, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, 6, 205, + 199, 207, 852, 198, 206, 796, 797, 798, 205, 205, + 207, 207, 205, 199, 207, 800, 801, 802, 803, 206, + 199, 806, 807, 199, 205, 810, 207, 205, 205, 207, + 207, 6, 823, 199, 199, 1868, 821, 822, 4, 188, + 189, 832, 205, 6, 207, 194, 205, 205, 207, 207, + 199, 205, 205, 207, 207, 204, 206, 206, 205, 205, + 207, 207, 205, 205, 207, 207, 205, 205, 207, 207, + 206, 206, 857, 858, 859, 860, 861, 862, 863, 864, + 865, 866, 867, 868, 869, 870, 871, 872, 873, 874, + 875, 876, 877, 878, 879, 880, 881, 882, 201, 178, + 179, 180, 203, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, 205, 205, 207, 207, 899, 198, + 8, 111, 205, 904, 207, 206, 6, 912, 199, 6, + 178, 179, 180, 918, 182, 183, 184, 185, 186, 187, + 188, 189, 190, 191, 192, 930, 205, 932, 207, 934, + 198, 180, 6, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, 3, 950, 951, 952, 199, 198, + 178, 179, 180, 199, 182, 183, 184, 185, 186, 187, + 188, 189, 190, 191, 192, 199, 199, 972, 973, 974, + 198, 5, 199, 199, 199, 199, 199, 199, 199, 199, + 199, 199, 1331, 178, 179, 180, 199, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, 199, 2052, + 199, 199, 199, 198, 200, 199, 199, 199, 199, 199, + 199, 1061, 199, 4, 1015, 1128, 3, 4, 199, 199, + 199, 199, 9, 10, 11, 12, 13, 14, 15, 16, + 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, + 27, 28, 29, 30, 31, 32, 205, 205, 198, 7, + 203, 7, 1102, 201, 206, 7, 7, 1062, 200, 7, + 7, 106, 108, 206, 1075, 5, 1077, 5, 5, 5, + 178, 179, 180, 5, 182, 183, 184, 185, 186, 187, + 188, 189, 190, 191, 192, 1090, 1091, 1092, 1093, 1159, + 198, 5, 5, 5, 5, 5, 1107, 1102, 1109, 5, + 1111, 5, 5, 5, 5, 5, 5, 5, 5, 5, + 5, 5, 1117, 1118, 5, 158, 5, 5, 5, 5, + 3, 5, 1127, 5, 1106, 1130, 1106, 6, 5, 205, + 6, 200, 6, 4, 202, 1140, 6, 203, 7, 7, + 7, 1254, 1147, 1148, 1149, 7, 7, 7, 7, 1154, + 207, 207, 206, 1158, 206, 7, 7, 1162, 1163, 1164, + 1165, 1166, 1167, 1168, 1169, 1170, 1171, 1172, 1173, 1174, + 1175, 1176, 1177, 1178, 1179, 1180, 1181, 1182, 1183, 1184, + 1185, 1186, 1187, 199, 7, 203, 170, 5, 205, 6, + 205, 205, 205, 205, 205, 205, 1201, 205, 205, 205, + 205, 188, 189, 1208, 205, 205, 205, 194, 205, 205, + 205, 205, 199, 205, 200, 202, 205, 204, 4, 206, + 205, 6, 1227, 205, 205, 205, 205, 205, 205, 205, + 205, 205, 205, 199, 199, 1348, 6, 199, 199, 199, + 3, 4, 199, 1248, 199, 1250, 9, 10, 11, 12, + 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, + 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, + 3, 4, 199, 199, 199, 199, 9, 10, 11, 12, + 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, + 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, + 6, 6, 178, 179, 180, 7, 182, 183, 184, 185, + 186, 187, 188, 189, 190, 191, 192, 202, 199, 199, + 1325, 1326, 198, 1334, 199, 1336, 199, 1338, 6, 1334, + 7, 1336, 7, 1338, 199, 1340, 1341, 201, 7, 1344, + 206, 199, 199, 199, 199, 199, 199, 7, 1353, 1331, + 199, 1331, 199, 199, 199, 7, 1361, 7, 7, 7, + 7, 1366, 7, 7, 1369, 7, 1371, 1372, 1373, 1374, + 1375, 1376, 1377, 1378, 1379, 1380, 1381, 1382, 1383, 1384, + 1385, 1386, 1387, 1388, 1389, 1390, 1391, 1392, 1393, 1394, + 1395, 1396, 1505, 7, 6, 1400, 7, 1408, 4, 6, + 1405, 6, 1407, 1408, 1409, 7, 4, 7, 178, 179, + 180, 171, 182, 183, 184, 185, 186, 187, 188, 189, + 190, 191, 192, 3, 3, 188, 189, 3, 198, 190, + 3, 194, 3, 3, 3, 3, 199, 3, 3, 202, + 3, 204, 3, 206, 3, 3, 6, 200, 5, 5, + 3, 3, 6, 4, 1567, 188, 189, 6, 200, 203, + 7, 194, 6, 6, 6, 6, 199, 199, 199, 202, + 206, 204, 6, 206, 6, 107, 206, 167, 205, 205, + 200, 205, 200, 1488, 205, 200, 205, 200, 205, 1494, + 200, 205, 1497, 205, 205, 6, 205, 205, 205, 200, + 6, 205, 205, 6, 203, 205, 1619, 205, 205, 205, + 205, 200, 205, 4, 6, 202, 1521, 1522, 1523, 1524, + 1525, 1526, 1527, 1528, 1529, 1530, 1531, 1532, 1533, 1534, + 1535, 1536, 1537, 1538, 1539, 1540, 1541, 6, 1543, 1544, + 178, 179, 180, 6, 182, 183, 184, 185, 186, 187, + 188, 189, 190, 191, 192, 6, 6, 6, 6, 6, + 198, 6, 6, 6, 6, 6, 178, 179, 180, 207, + 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, + 192, 6, 6, 6, 6, 159, 198, 6, 6, 6, + 6, 165, 7, 107, 3, 6, 3, 190, 6, 203, + 1650, 6, 6, 3, 1717, 6, 3, 6, 6, 3, + 6, 6, 3, 3, 188, 3, 202, 6, 4, 193, + 194, 1626, 1627, 1628, 1629, 1630, 1631, 1632, 1633, 1634, + 1635, 1636, 1637, 1638, 1639, 1640, 1641, 1642, 1643, 1644, + 1645, 1646, 1647, 1648, 1649, 3, 4, 6, 104, 6, + 1763, 9, 10, 11, 12, 13, 14, 15, 16, 17, + 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, + 28, 29, 30, 31, 32, 178, 179, 180, 7, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + 6, 6, 207, 1806, 206, 198, 206, 206, 206, 1749, + 200, 1751, 206, 205, 205, 200, 205, 205, 205, 205, + 200, 1716, 200, 200, 200, 200, 205, 1722, 200, 1724, + 107, 1726, 205, 1728, 1729, 1730, 1731, 1732, 1733, 1734, + 1735, 1736, 1737, 1738, 1739, 1740, 1741, 1742, 1743, 1744, + 1745, 1746, 1747, 1748, 109, 6, 3, 6, 6, 3, + 6, 6, 3, 178, 179, 180, 6, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, 6, 6, + 6, 6, 6, 198, 5, 207, 6, 178, 179, 180, + 1830, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, 5, 206, 6, 207, 206, 198, 167, 1804, + 1805, 6, 205, 205, 6, 6, 6, 1812, 1813, 1814, + 1815, 1816, 1817, 1818, 1819, 1820, 1821, 1822, 1823, 1824, + 1825, 1826, 1827, 1828, 1829, 205, 205, 200, 200, 205, + 188, 189, 200, 6, 205, 205, 194, 6, 6, 6, + 6, 199, 6, 6, 6, 6, 204, 6, 206, 6, + 5, 5, 206, 205, 205, 8, 206, 206, 200, 1864, + 207, 205, 205, 200, 1869, 1870, 1871, 1872, 1873, 1874, + 1875, 1876, 1877, 1878, 1879, 1880, 1881, 1882, 1883, 1884, + 1885, 1886, 1887, 1888, 1889, 3, 4, 205, 205, 6, + 6, 9, 10, 11, 12, 13, 14, 15, 16, 17, + 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, + 28, 29, 30, 31, 32, 206, 206, 1922, 206, 1924, + 206, 1926, 496, 1928, 1929, 1930, 1931, 1932, 1933, 1934, + 1935, 1936, 1937, 1938, 1939, 1940, 1941, 1942, 1943, 1944, + 1945, 178, 179, 180, 6, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, 205, 6, 6, 104, + 6, 198, 6, 5, 206, 6, 5, 206, 8, 167, + 6, 200, 1977, 1978, 1979, 1980, 1981, 1982, 1983, 1984, + 1985, 1986, 1987, 1988, 1989, 1990, 1991, 206, 205, 207, + 206, 205, 200, 6, 6, 206, 6, 207, 104, 6, + 6, 6, 6, 6, 6, 6, 205, 2012, 2013, 2014, + 2015, 2016, 2017, 2018, 2019, 2020, 2021, 2022, 2023, 2024, + 2025, 2026, 2027, 2028, 2029, 178, 179, 180, 207, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + 6, 206, 6, 6, 6, 198, 6, 205, 2053, 172, + 2055, 6, 2057, 205, 2059, 2060, 2061, 2062, 2063, 2064, + 2065, 2066, 2067, 2068, 2069, 2070, 2071, 2072, 2073, 205, + 188, 189, 206, 206, 206, 173, 194, 205, 200, 6, + 6, 199, 6, 6, 6, 205, 204, 206, 206, 6, + 205, 6, 206, 206, 205, 6, 200, 6, 2103, 2104, + 2105, 2106, 2107, 2108, 2109, 2110, 2111, 206, 6, 206, + 206, 206, 206, 206, 6, 6, 6, 6, 6, 206, + 206, 206, 6, 2128, 2129, 2130, 2131, 2132, 2133, 2134, + 2135, 2136, 2137, 2138, 2139, 2140, 2141, 2142, 178, 179, + 180, 6, 182, 183, 184, 185, 186, 187, 188, 189, + 190, 191, 192, 6, 206, 206, 206, 6, 198, 2164, + 6, 2166, 6, 2168, 6, 2170, 6, 2172, 206, 2174, + 6, 2176, 2177, 2178, 2179, 2180, 2181, 2182, 2183, 2184, + 206, 206, 636, 5, 5, -1, 760, 761, -1, 763, + 884, 765, 766, 1065, -1, -1, -1, -1, -1, -1, + -1, 2206, 2207, 2208, 2209, 2210, 2211, -1, -1, -1, + -1, -1, -1, -1, -1, -1, -1, -1, -1, 2224, + 2225, 2226, 2227, 2228, 2229, 2230, 2231, 2232, -1, -1, + -1, -1, -1, -1, 808, 809, -1, -1, 812, -1, + 2245, 2246, 2247, 2248, 2249, 2250, 2251, -1, 2253, -1, + 2255, -1, -1, -1, -1, 829, 830, -1, -1, -1, + -1, 835, 836, -1, 2269, 2270, 2271, -1, 842, -1, + 844, -1, -1, -1, -1, -1, 2281, 2282, 2283, 2284, + 2285, 2286, -1, -1, -1, -1, -1, -1, -1, -1, + -1, 2296, 2297, 2298, 2299, -1, 2301, -1, 2303, -1, + -1, -1, -1, -1, -1, -1, -1, -1, -1, 2314, + 2315, 2316, -1, -1, -1, 2320, 2321, 2322, -1, -1, + -1, 2326, 2327, 2328, -1, -1, -1, -1, -1, -1, + -1, -1, -1, 2338, 2339, 2340, -1, -1, -1, -1, + -1, -1, 2347, -1, 2349, -1, 2351, -1, 922, -1, + 924, -1, -1, -1, -1, -1, -1, -1, -1, -1, + -1, 935, 936, 937, -1, -1, -1, -1, 942, 943, + 944, 945, 946, 947, 948, -1, -1, -1, -1, 3, + 4, 5, -1, 7, -1, 9, 10, 11, 12, 13, + 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, + 24, 25, 26, 27, 28, 29, 30, 31, 32, -1, + 34, 35, 36, 3, 4, -1, -1, -1, -1, 9, + 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, + 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, + 30, 31, 32, -1, -1, -1, 178, 179, 180, 39, + 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, + 192, -1, -1, -1, -1, -1, 198, -1, 200, -1, + 60, 61, 62, 63, 64, 65, -1, -1, 8, -1, + -1, 3, 4, 5, -1, -1, 1060, 9, 10, 11, + 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, + 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, + 32, -1, 34, 35, 36, 3, 4, -1, -1, -1, + -1, 9, 10, 11, 12, 13, 14, 15, 16, 17, + 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, + 28, 29, 30, 31, 32, -1, -1, 8, -1, 1123, + 174, 175, 176, 177, -1, -1, -1, 1131, -1, -1, + -1, -1, -1, -1, 188, 189, -1, -1, -1, -1, + 194, -1, 196, 197, -1, 199, 1150, 201, -1, 203, + 204, -1, -1, 178, 179, 180, -1, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, 188, 189, + -1, -1, -1, 198, 194, -1, -1, -1, -1, 199, + 3, 4, 207, -1, 204, 1189, 9, 10, 11, 12, + 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, + 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, + -1, -1, -1, -1, -1, -1, -1, -1, 178, 179, + 180, -1, 182, 183, 184, 185, 186, 187, 188, 189, + 190, 191, 192, -1, -1, -1, 188, 189, 198, -1, + -1, -1, 194, -1, -1, -1, -1, 199, -1, -1, + -1, -1, 204, 39, 40, 41, 42, 43, 44, 45, + 46, -1, 48, -1, 50, 51, 52, -1, 54, 55, + 188, 189, -1, -1, -1, -1, 194, -1, -1, -1, + -1, 199, -1, -1, -1, 71, 204, 178, 179, 180, + -1, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, -1, -1, -1, -1, 101, 102, 103, 178, 179, + 180, -1, 182, 183, 184, 185, 186, 187, 188, 189, + 190, 191, 192, 119, -1, -1, -1, -1, 198, 1343, + 200, -1, -1, 1347, -1, 205, -1, 0, 1, -1, + 3, 4, -1, -1, -1, -1, -1, -1, -1, 1363, + -1, -1, -1, -1, -1, 188, 189, -1, -1, -1, + -1, 194, -1, -1, -1, -1, 199, -1, -1, -1, + 33, 204, -1, -1, 37, 38, 39, 40, 41, 42, + 43, 44, 45, 46, -1, 48, 49, 50, 51, 52, + 53, 54, 55, -1, -1, -1, 59, 60, 61, 62, + 63, 64, 65, -1, 67, 68, 69, 70, 71, -1, + -1, 207, -1, -1, 178, 179, 180, -1, 182, 183, + 184, 185, 186, 187, 188, 189, 190, 191, 192, -1, + -1, -1, -1, -1, 198, -1, -1, 100, 101, 102, + 103, 205, -1, 207, -1, 108, -1, 110, -1, 112, + 113, 114, 115, 116, 117, 118, 119, 120, 121, -1, + -1, -1, -1, -1, -1, -1, -1, -1, 1482, 1483, + -1, -1, -1, -1, -1, -1, 1490, 140, 141, 142, + 143, 144, 145, 146, 147, -1, -1, 1501, 1502, -1, + -1, -1, -1, -1, -1, -1, -1, -1, -1, -1, + -1, -1, 165, 166, -1, 168, 39, 40, 41, 42, + 43, 44, 45, 46, -1, 48, -1, 50, 51, 52, + -1, 54, 55, -1, -1, -1, -1, -1, -1, -1, + -1, -1, 1546, 1547, -1, -1, -1, -1, 71, -1, + -1, -1, 39, 40, 41, 42, 43, 44, 45, 46, + -1, 48, -1, 50, 51, 52, -1, 54, 55, -1, + -1, -1, -1, -1, -1, -1, -1, -1, 101, 102, + 103, -1, -1, -1, 71, -1, 39, 40, 41, 42, + 43, 44, 45, 46, -1, 48, 119, 50, 51, 52, + -1, 54, 55, -1, -1, -1, -1, -1, 1612, -1, + -1, -1, -1, 1617, 101, 102, 103, -1, 71, -1, + -1, -1, -1, -1, 39, 40, 41, 42, 43, 44, + 45, 46, 119, 48, -1, 50, 51, 52, -1, 54, + 55, -1, -1, -1, -1, -1, -1, -1, 101, 102, + 103, -1, -1, -1, -1, -1, 71, -1, -1, -1, + -1, -1, -1, 178, 179, 180, 119, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, 207, -1, 101, 102, 103, -1, + 205, -1, 207, -1, -1, -1, -1, -1, -1, -1, + -1, -1, -1, -1, 119, 1709, 42, -1, -1, -1, + -1, -1, -1, -1, -1, 1719, -1, -1, -1, -1, + 207, 73, 74, 75, 76, 77, 78, 79, 80, 81, + 82, 83, 84, 85, 86, 87, 88, 89, 90, 91, + 92, 93, 94, 95, 96, 97, 98, 99, -1, -1, + -1, -1, -1, -1, 207, 73, 74, 75, 76, 77, + 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, + 88, 89, 90, 91, 92, 93, 94, 95, 96, 97, + 98, 99, -1, -1, -1, -1, 122, 123, 124, -1, + -1, -1, 207, -1, 130, 131, 132, 133, 134, 135, + 136, 137, 138, 139, 1808, -1, -1, -1, -1, -1, + -1, -1, 148, 149, 150, 151, 152, 153, 154, 155, + 156, 157, -1, 159, 160, 161, 162, 163, 164, -1, + -1, -1, 178, 179, 180, 4, 182, 183, 184, 185, + 186, 187, 188, 189, 190, 191, 192, -1, -1, -1, + -1, -1, 198, -1, -1, 207, -1, -1, -1, 205, + -1, 207, -1, 1867, 33, -1, -1, -1, 37, 38, + 39, 40, 41, 42, 43, 44, 45, 46, -1, 48, + 49, 50, 51, 52, 53, 54, 55, -1, -1, 207, + 59, 60, 61, 62, 63, 64, 65, -1, 67, 68, + 69, 70, 71, -1, -1, -1, -1, -1, 39, 40, + 41, 42, 43, 44, 45, 46, 1920, 48, -1, 50, + 51, 52, -1, 54, 55, -1, -1, -1, -1, -1, + -1, 100, 101, 102, 103, -1, -1, -1, -1, 108, + 71, 110, -1, 112, 113, 114, 115, 116, 117, 118, + 119, 120, 121, 178, 179, 180, -1, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, 1973, + 101, 102, 103, 198, -1, -1, -1, -1, -1, -1, + -1, -1, 207, -1, -1, 178, 179, 180, 119, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, 2011, -1, -1, + -1, 178, 179, 180, 207, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, -1, -1, 178, 179, 180, + 207, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, -1, -1, 178, 179, 180, 207, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, -1, -1, 178, + 179, 180, 207, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, -1, -1, 178, 179, 180, 207, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, -1, + -1, 178, 179, 180, 207, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, -1, -1, 178, 179, 180, + 207, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, -1, -1, 178, 179, 180, 207, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, -1, -1, 178, + 179, 180, 207, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, -1, -1, 178, 179, 180, 207, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, -1, + -1, 178, 179, 180, 207, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, -1, -1, 178, 179, 180, + 207, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, -1, -1, 178, 179, 180, 207, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, -1, -1, 178, + 179, 180, 207, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, -1, -1, 178, 179, 180, 207, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, -1, + -1, 178, 179, 180, 207, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, -1, -1, 178, 179, 180, + 207, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, -1, -1, 178, 179, 180, 207, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, -1, -1, 178, + 179, 180, 205, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, -1, -1, 178, 179, 180, 205, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, -1, -1, 178, 179, 180, + 205, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, -1, + -1, 178, 179, 180, 205, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, -1, -1, 178, 179, 180, 205, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, 178, 179, 180, 202, + 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, + 192, -1, -1, -1, -1, -1, 198, 178, 179, 180, + 202, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, 178, 179, + 180, 202, 182, 183, 184, 185, 186, 187, 188, 189, + 190, 191, 192, -1, -1, -1, -1, -1, 198, 178, + 179, 180, 202, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + 178, 179, 180, 202, 182, 183, 184, 185, 186, 187, + 188, 189, 190, 191, 192, -1, -1, -1, -1, -1, + 198, 178, 179, 180, 202, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, 178, 179, 180, 202, 182, 183, 184, 185, + 186, 187, 188, 189, 190, 191, 192, -1, -1, -1, + -1, -1, 198, 178, 179, 180, 202, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, 178, 179, 180, 202, 182, 183, + 184, 185, 186, 187, 188, 189, 190, 191, 192, -1, + -1, -1, -1, -1, 198, 178, 179, 180, 202, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, 178, 179, 180, 202, + 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, + 192, -1, -1, -1, -1, -1, 198, 178, 179, 180, + 202, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, 178, 179, + 180, 202, 182, 183, 184, 185, 186, 187, 188, 189, + 190, 191, 192, -1, -1, -1, -1, -1, 198, 178, + 179, 180, 202, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + 178, 179, 180, 202, 182, 183, 184, 185, 186, 187, + 188, 189, 190, 191, 192, -1, -1, -1, -1, -1, + 198, 178, 179, 180, 202, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, 178, 179, 180, 202, 182, 183, 184, 185, + 186, 187, 188, 189, 190, 191, 192, -1, -1, -1, + -1, -1, 198, 178, 179, 180, 202, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, 178, 179, 180, 202, 182, 183, + 184, 185, 186, 187, 188, 189, 190, 191, 192, -1, + -1, -1, -1, -1, 198, 178, 179, 180, 202, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, 178, 179, 180, 202, + 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, + 192, -1, -1, -1, -1, -1, 198, 178, 179, 180, + 202, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, 178, 179, + 180, 202, 182, 183, 184, 185, 186, 187, 188, 189, + 190, 191, 192, -1, -1, -1, -1, -1, 198, 178, + 179, 180, 202, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + 178, 179, 180, 202, 182, 183, 184, 185, 186, 187, + 188, 189, 190, 191, 192, -1, -1, -1, -1, -1, + 198, 178, 179, 180, 202, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, 178, 179, 180, 202, 182, 183, 184, 185, + 186, 187, 188, 189, 190, 191, 192, -1, -1, -1, + -1, -1, 198, 178, 179, 180, 202, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, 200, 178, 179, 180, -1, + 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, + 192, -1, -1, -1, -1, -1, 198, -1, 200, 178, + 179, 180, -1, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, 200, 178, 179, 180, -1, 182, 183, 184, 185, + 186, 187, 188, 189, 190, 191, 192, -1, -1, -1, + -1, -1, 198, -1, 200, 178, 179, 180, -1, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, 200, 178, 179, + 180, -1, 182, 183, 184, 185, 186, 187, 188, 189, + 190, 191, 192, -1, -1, -1, -1, -1, 198, -1, + 200, 178, 179, 180, -1, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, 200, 178, 179, 180, -1, 182, 183, + 184, 185, 186, 187, 188, 189, 190, 191, 192, -1, + -1, -1, -1, -1, 198, -1, 200, 178, 179, 180, + -1, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, 200, + 178, 179, 180, -1, 182, 183, 184, 185, 186, 187, + 188, 189, 190, 191, 192, -1, -1, -1, -1, -1, + 198, -1, 200, 178, 179, 180, -1, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, 200, 178, 179, 180, -1, + 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, + 192, -1, -1, -1, -1, -1, 198, -1, 200, 178, + 179, 180, -1, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, 200, 178, 179, 180, -1, 182, 183, 184, 185, + 186, 187, 188, 189, 190, 191, 192, -1, -1, -1, + -1, -1, 198, -1, 200, 178, 179, 180, -1, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, 200, 178, 179, + 180, -1, 182, 183, 184, 185, 186, 187, 188, 189, + 190, 191, 192, -1, -1, -1, -1, -1, 198, -1, + 200, 178, 179, 180, -1, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, 200, 178, 179, 180, -1, 182, 183, + 184, 185, 186, 187, 188, 189, 190, 191, 192, -1, + -1, -1, -1, -1, 198, -1, 200, 178, 179, 180, + -1, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, 200, + 178, 179, 180, -1, 182, 183, 184, 185, 186, 187, + 188, 189, 190, 191, 192, -1, -1, -1, -1, -1, + 198, -1, 200, 178, 179, 180, -1, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, 200, 178, 179, 180, -1, + 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, + 192, -1, -1, -1, -1, -1, 198, -1, 200, 178, + 179, 180, -1, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, 200, 178, 179, 180, -1, 182, 183, 184, 185, + 186, 187, 188, 189, 190, 191, 192, -1, -1, -1, + -1, -1, 198, -1, 200, 178, 179, 180, -1, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, 200, 178, 179, + 180, -1, 182, 183, 184, 185, 186, 187, 188, 189, + 190, 191, 192, -1, -1, -1, -1, -1, 198, -1, + 200, 178, 179, 180, -1, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, 200, 178, 179, 180, -1, 182, 183, + 184, 185, 186, 187, 188, 189, 190, 191, 192, -1, + -1, -1, -1, -1, 198, -1, 200, 178, 179, 180, + -1, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, 200, + 178, 179, 180, -1, 182, 183, 184, 185, 186, 187, + 188, 189, 190, 191, 192, -1, -1, -1, -1, -1, + 198, -1, 200, 178, 179, 180, -1, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, 200, 178, 179, 180, -1, + 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, + 192, -1, -1, -1, -1, -1, 198, -1, 200, 178, + 179, 180, -1, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, 200, 178, 179, 180, -1, 182, 183, 184, 185, + 186, 187, 188, 189, 190, 191, 192, -1, -1, -1, + -1, -1, 198, -1, 200, 178, 179, 180, -1, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, 200, 178, 179, + 180, -1, 182, 183, 184, 185, 186, 187, 188, 189, + 190, 191, 192, -1, -1, -1, -1, -1, 198, -1, + 200, 178, 179, 180, -1, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, 200, 178, 179, 180, -1, 182, 183, + 184, 185, 186, 187, 188, 189, 190, 191, 192, -1, + -1, -1, -1, -1, 198, -1, 200, 178, 179, 180, + -1, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, 200, + 178, 179, 180, -1, 182, 183, 184, 185, 186, 187, + 188, 189, 190, 191, 192, -1, -1, -1, -1, -1, + 198, -1, 200, 178, 179, 180, -1, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, 200, 178, 179, 180, -1, + 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, + 192, -1, -1, -1, -1, -1, 198, -1, 200, 178, + 179, 180, -1, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, 200, 178, 179, 180, -1, 182, 183, 184, 185, + 186, 187, 188, 189, 190, 191, 192, -1, -1, -1, + -1, -1, 198, -1, 200, 178, 179, 180, -1, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, 200, 178, 179, + 180, -1, 182, 183, 184, 185, 186, 187, 188, 189, + 190, 191, 192, -1, -1, -1, -1, -1, 198, -1, + 200, 178, 179, 180, -1, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, 200, 178, 179, 180, -1, 182, 183, + 184, 185, 186, 187, 188, 189, 190, 191, 192, -1, + -1, -1, -1, -1, 198, -1, 200, 178, 179, 180, + -1, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, 200, + 178, 179, 180, -1, 182, 183, 184, 185, 186, 187, + 188, 189, 190, 191, 192, -1, -1, -1, -1, -1, + 198, -1, 200, 178, 179, 180, -1, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, 200, 178, 179, 180, -1, + 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, + 192, -1, -1, -1, -1, -1, 198, -1, 200, 178, + 179, 180, -1, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, 200, 178, 179, 180, -1, 182, 183, 184, 185, + 186, 187, 188, 189, 190, 191, 192, -1, -1, -1, + -1, -1, 198, -1, 200, 178, 179, 180, -1, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, 200, 178, 179, + 180, -1, 182, 183, 184, 185, 186, 187, 188, 189, + 190, 191, 192, -1, -1, -1, -1, -1, 198, -1, + 200, 178, 179, 180, -1, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, 200, 178, 179, 180, -1, 182, 183, + 184, 185, 186, 187, 188, 189, 190, 191, 192, -1, + -1, -1, -1, -1, 198, -1, 200, 178, 179, 180, + -1, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, 200, + 178, 179, 180, -1, 182, 183, 184, 185, 186, 187, + 188, 189, 190, 191, 192, -1, -1, -1, -1, -1, + 198, -1, 200, 178, 179, 180, -1, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, 200, 178, 179, 180, -1, + 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, + 192, -1, -1, -1, -1, -1, 198, -1, 200, 178, + 179, 180, -1, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, 200, 178, 179, 180, -1, 182, 183, 184, 185, + 186, 187, 188, 189, 190, 191, 192, -1, -1, -1, + -1, -1, 198, -1, 200, 178, 179, 180, -1, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, 200, 178, 179, + 180, -1, 182, 183, 184, 185, 186, 187, 188, 189, + 190, 191, 192, -1, -1, -1, -1, -1, 198, -1, + 200, 178, 179, 180, -1, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, 200, 178, 179, 180, -1, 182, 183, + 184, 185, 186, 187, 188, 189, 190, 191, 192, -1, + -1, -1, -1, -1, 198, -1, 200, 178, 179, 180, + -1, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, 200, + 178, 179, 180, -1, 182, 183, 184, 185, 186, 187, + 188, 189, 190, 191, 192, -1, -1, -1, -1, -1, + 198, -1, 200, 178, 179, 180, -1, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, 200, 178, 179, 180, -1, + 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, + 192, -1, -1, -1, -1, -1, 198, -1, 200, 178, + 179, 180, -1, 182, 183, 184, 185, 186, 187, 188, + 189, 190, 191, 192, -1, -1, -1, -1, -1, 198, + -1, 200, 178, 179, 180, -1, 182, 183, 184, 185, + 186, 187, 188, 189, 190, 191, 192, -1, -1, -1, + -1, -1, 198, -1, 200, 178, 179, 180, -1, 182, + 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, + -1, -1, -1, -1, -1, 198, -1, 200, 178, 179, + 180, -1, 182, 183, 184, 185, 186, 187, 188, 189, + 190, 191, 192, -1, -1, -1, -1, -1, 198, -1, + 200, 178, 179, 180, -1, 182, 183, 184, 185, 186, + 187, 188, 189, 190, 191, 192, -1, -1, -1, -1, + -1, 198, -1, 200, 178, 179, 180, -1, 182, 183, + 184, 185, 186, 187, 188, 189, 190, 191, 192, -1, + -1, -1, -1, -1, 198, -1, 200, 178, 179, 180, + -1, 182, 183, 184, 185, 186, 187, 188, 189, 190, + 191, 192, -1, -1, -1, -1, -1, 198, -1, 200, + 178, 179, 180, -1, 182, 183, 184, 185, 186, 187, + 188, 189, 190, 191, 192, -1, -1, -1, -1, -1, + 198, -1, 200, 178, 179, 180, -1, 182, 183, 184, + 185, 186, 187, 188, 189, 190, 191, 192, -1, -1, + -1, -1, -1, 198, -1, 200, 178, 179, 180, -1, + 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, + 192, -1, -1, -1, -1, -1, 198 +}; -/* As a special exception, when this file is copied by Bison into a - Bison output file, you may use that output file without restriction. - This special exception was added by the Free Software Foundation - in version 1.24 of Bison. */ +/* YYSTOS[STATE-NUM] -- The (internal number of the) accessing + symbol of state STATE-NUM. */ +static const unsigned short yystos[] = +{ + 0, 1, 209, 211, 213, 218, 6, 0, 165, 166, + 168, 212, 3, 140, 141, 142, 143, 144, 145, 146, + 147, 214, 215, 216, 217, 4, 33, 37, 38, 39, + 40, 41, 42, 43, 44, 45, 46, 48, 49, 50, + 51, 52, 53, 54, 55, 59, 60, 61, 62, 63, + 64, 65, 67, 68, 69, 70, 71, 100, 101, 102, + 103, 108, 110, 112, 113, 114, 115, 116, 117, 118, + 119, 120, 121, 219, 220, 221, 304, 305, 306, 309, + 310, 311, 312, 313, 314, 315, 327, 328, 169, 7, + 6, 6, 6, 6, 6, 199, 199, 199, 3, 4, + 5, 7, 9, 10, 11, 12, 13, 14, 15, 16, + 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, + 27, 28, 29, 30, 31, 32, 34, 35, 36, 174, + 175, 176, 177, 188, 189, 194, 196, 197, 199, 201, + 203, 204, 302, 303, 330, 331, 344, 199, 6, 206, + 6, 199, 199, 199, 66, 199, 66, 199, 199, 47, + 199, 43, 43, 43, 43, 42, 43, 45, 45, 39, + 42, 43, 45, 199, 206, 188, 189, 199, 206, 332, + 333, 332, 206, 39, 42, 43, 4, 206, 43, 4, + 206, 6, 6, 39, 42, 4, 199, 199, 43, 199, + 4, 206, 341, 4, 199, 199, 6, 4, 4, 43, + 5, 206, 344, 206, 344, 3, 189, 210, 42, 122, + 123, 124, 130, 131, 132, 133, 134, 135, 136, 137, + 138, 139, 148, 149, 150, 151, 152, 153, 154, 155, + 156, 157, 159, 160, 161, 162, 163, 164, 199, 334, + 334, 5, 201, 203, 303, 4, 206, 199, 201, 199, + 201, 199, 201, 199, 201, 199, 201, 199, 201, 199, + 201, 199, 201, 199, 201, 199, 201, 199, 201, 199, + 201, 199, 201, 199, 201, 199, 201, 199, 201, 199, + 201, 199, 201, 199, 201, 199, 201, 199, 201, 199, + 199, 199, 4, 330, 330, 330, 330, 202, 206, 330, + 4, 108, 109, 4, 330, 6, 6, 178, 179, 180, + 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, + 192, 198, 6, 5, 330, 330, 330, 330, 199, 330, + 199, 330, 330, 4, 39, 189, 206, 306, 309, 315, + 330, 338, 339, 330, 206, 199, 199, 199, 206, 338, + 206, 206, 199, 199, 199, 199, 199, 4, 332, 332, + 332, 330, 330, 188, 189, 206, 206, 332, 206, 206, + 206, 201, 308, 338, 6, 201, 308, 338, 338, 6, + 330, 330, 105, 199, 330, 203, 330, 206, 111, 330, + 330, 6, 199, 308, 6, 308, 6, 3, 210, 199, + 199, 199, 199, 199, 199, 199, 199, 199, 199, 199, + 199, 199, 199, 199, 199, 199, 199, 199, 199, 199, + 199, 199, 199, 199, 199, 199, 199, 199, 199, 5, + 335, 205, 200, 205, 330, 4, 332, 222, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 4, 344, 344, 344, 201, 200, 7, 189, 330, 339, + 340, 202, 7, 302, 303, 203, 7, 201, 6, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 200, 205, 205, 200, 200, 200, + 330, 200, 330, 200, 200, 201, 206, 4, 206, 340, + 8, 7, 200, 330, 330, 330, 330, 330, 7, 330, + 330, 330, 330, 330, 330, 330, 200, 205, 205, 205, + 332, 332, 306, 307, 308, 309, 307, 205, 330, 330, + 330, 330, 39, 42, 43, 45, 207, 305, 6, 7, + 330, 207, 7, 7, 200, 200, 106, 330, 200, 108, + 205, 308, 206, 8, 200, 330, 207, 207, 210, 5, + 5, 5, 5, 5, 5, 5, 5, 5, 5, 5, + 5, 5, 5, 5, 5, 5, 5, 5, 5, 5, + 5, 5, 158, 5, 5, 5, 5, 3, 5, 200, + 205, 5, 6, 5, 202, 303, 206, 73, 74, 75, + 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, + 86, 87, 88, 89, 90, 91, 92, 93, 94, 95, + 96, 97, 98, 99, 207, 224, 227, 230, 233, 236, + 239, 242, 245, 248, 251, 254, 257, 260, 263, 266, + 269, 272, 275, 278, 281, 284, 287, 290, 293, 296, + 299, 301, 200, 202, 200, 202, 200, 202, 200, 202, + 200, 202, 200, 202, 200, 202, 200, 202, 200, 202, + 200, 202, 200, 202, 205, 205, 200, 202, 200, 202, + 200, 202, 200, 202, 200, 202, 200, 202, 205, 205, + 205, 205, 205, 205, 201, 203, 200, 205, 205, 200, + 330, 338, 205, 207, 203, 302, 303, 344, 330, 6, + 4, 4, 206, 342, 202, 8, 6, 340, 330, 7, + 7, 7, 200, 7, 200, 7, 7, 202, 206, 330, + 201, 340, 207, 330, 330, 7, 207, 200, 200, 200, + 207, 330, 207, 207, 200, 200, 200, 200, 200, 203, + 332, 330, 330, 207, 207, 330, 205, 205, 205, 202, + 206, 206, 206, 206, 330, 202, 206, 206, 7, 7, + 199, 200, 7, 203, 330, 207, 330, 330, 200, 170, + 205, 205, 205, 205, 205, 205, 205, 205, 205, 205, + 205, 205, 205, 205, 205, 205, 205, 205, 205, 205, + 205, 205, 205, 205, 205, 205, 205, 205, 205, 205, + 5, 200, 205, 203, 303, 344, 222, 199, 199, 199, + 199, 199, 199, 199, 199, 199, 199, 199, 199, 199, + 199, 199, 199, 199, 199, 199, 199, 199, 199, 199, + 199, 199, 199, 199, 206, 336, 6, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 4, 340, 344, 202, + 6, 330, 339, 202, 4, 108, 109, 330, 6, 6, + 6, 7, 201, 341, 343, 6, 330, 200, 205, 332, + 338, 338, 7, 338, 7, 338, 338, 340, 207, 202, + 206, 207, 8, 6, 206, 7, 7, 7, 7, 7, + 6, 56, 7, 7, 7, 7, 7, 7, 7, 4, + 205, 205, 205, 207, 332, 332, 332, 6, 340, 340, + 340, 340, 6, 6, 330, 330, 338, 338, 330, 7, + 338, 4, 205, 8, 8, 200, 7, 171, 3, 330, + 330, 332, 3, 3, 190, 3, 3, 338, 338, 3, + 332, 3, 3, 338, 338, 3, 3, 3, 3, 3, + 338, 125, 126, 127, 128, 129, 329, 338, 3, 5, + 5, 3, 3, 6, 334, 4, 6, 207, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 337, 338, 337, 6, 200, 202, + 200, 202, 200, 202, 200, 202, 202, 200, 200, 200, + 302, 7, 302, 303, 203, 7, 6, 341, 330, 205, + 207, 6, 330, 6, 6, 50, 6, 50, 338, 6, + 338, 6, 6, 207, 340, 330, 330, 338, 338, 338, + 199, 199, 57, 58, 338, 338, 338, 338, 338, 338, + 338, 6, 7, 330, 330, 330, 206, 205, 207, 205, + 207, 205, 207, 207, 207, 207, 207, 205, 205, 6, + 6, 200, 336, 107, 330, 330, 330, 206, 167, 205, + 205, 205, 200, 205, 200, 205, 200, 205, 200, 205, + 205, 200, 205, 200, 200, 205, 205, 205, 205, 205, + 205, 200, 205, 205, 205, 205, 205, 200, 205, 205, + 303, 6, 205, 205, 205, 205, 205, 205, 205, 205, + 205, 205, 205, 205, 205, 205, 205, 205, 205, 205, + 205, 205, 205, 205, 205, 205, 205, 205, 200, 205, + 207, 203, 338, 344, 330, 6, 4, 342, 6, 202, + 341, 205, 332, 332, 6, 6, 202, 207, 205, 6, + 6, 6, 330, 330, 330, 330, 6, 6, 6, 6, + 6, 6, 6, 330, 344, 207, 200, 205, 207, 307, + 332, 6, 316, 332, 6, 319, 332, 6, 322, 6, + 6, 6, 6, 330, 330, 7, 107, 338, 205, 207, + 8, 207, 200, 330, 210, 3, 330, 338, 6, 3, + 6, 190, 6, 329, 6, 3, 330, 6, 3, 6, + 6, 3, 329, 330, 330, 330, 338, 6, 3, 329, + 330, 3, 3, 6, 330, 334, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 338, 4, 6, 6, 6, 7, 6, 203, + 330, 6, 6, 202, 330, 205, 205, 6, 6, 6, + 6, 206, 330, 207, 205, 206, 205, 206, 205, 206, + 205, 205, 336, 206, 104, 330, 330, 205, 210, 200, + 205, 205, 205, 205, 200, 205, 200, 205, 200, 200, + 200, 205, 200, 205, 200, 200, 205, 205, 200, 205, + 205, 205, 205, 205, 205, 205, 205, 205, 205, 205, + 205, 205, 205, 205, 205, 205, 205, 205, 205, 205, + 205, 205, 205, 205, 205, 205, 205, 200, 341, 109, + 205, 205, 330, 330, 307, 205, 207, 188, 189, 199, + 330, 332, 67, 72, 325, 326, 330, 332, 325, 330, + 332, 325, 330, 330, 107, 338, 330, 207, 207, 338, + 210, 6, 336, 329, 3, 330, 6, 329, 6, 3, + 6, 6, 6, 330, 6, 338, 6, 6, 330, 3, + 6, 330, 5, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 6, + 330, 5, 200, 200, 207, 330, 330, 207, 205, 6, + 206, 207, 326, 207, 205, 207, 207, 205, 207, 207, + 207, 206, 205, 6, 207, 167, 205, 205, 205, 205, + 200, 200, 200, 205, 200, 200, 200, 205, 200, 200, + 200, 205, 205, 205, 205, 205, 205, 205, 205, 205, + 205, 205, 205, 205, 205, 205, 205, 205, 205, 205, + 205, 205, 200, 205, 205, 205, 338, 338, 207, 6, + 317, 330, 338, 6, 6, 320, 330, 6, 6, 323, + 330, 6, 6, 6, 338, 338, 6, 210, 329, 329, + 329, 329, 6, 6, 6, 329, 6, 6, 6, 5, + 225, 228, 231, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 297, 330, 330, 5, 338, 338, + 206, 207, 205, 206, 207, 206, 207, 205, 207, 210, + 205, 205, 200, 200, 205, 205, 206, 206, 206, 205, + 205, 205, 205, 205, 205, 205, 205, 205, 205, 205, + 205, 205, 205, 205, 205, 205, 205, 205, 205, 205, + 206, 200, 207, 205, 6, 6, 325, 6, 318, 338, + 325, 6, 321, 325, 6, 324, 338, 104, 210, 329, + 329, 6, 6, 329, 5, 223, 330, 226, 330, 229, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 295, 344, 300, 6, 5, 207, 206, 205, + 207, 207, 206, 207, 206, 207, 206, 167, 205, 205, + 200, 200, 205, 207, 205, 207, 205, 207, 205, 205, + 205, 205, 205, 205, 205, 205, 205, 205, 205, 205, + 205, 205, 205, 205, 205, 205, 205, 205, 205, 205, + 207, 206, 207, 6, 325, 338, 6, 6, 325, 6, + 325, 104, 330, 210, 329, 338, 6, 6, 330, 6, + 330, 6, 330, 6, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 344, 6, 298, 344, 6, + 207, 207, 207, 207, 206, 205, 210, 205, 205, 200, + 200, 200, 205, 205, 205, 205, 205, 205, 205, 205, + 205, 205, 205, 205, 205, 205, 205, 205, 205, 205, + 205, 207, 6, 6, 6, 6, 330, 330, 210, 329, + 338, 234, 237, 240, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 344, 6, 205, 207, 172, 205, 205, 206, + 206, 206, 205, 205, 205, 205, 205, 205, 205, 205, + 205, 205, 205, 205, 205, 205, 205, 205, 205, 205, + 330, 6, 173, 338, 329, 232, 330, 235, 330, 238, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 207, + 205, 200, 205, 207, 205, 207, 205, 207, 205, 205, + 205, 205, 205, 205, 205, 205, 205, 205, 205, 205, + 205, 205, 205, 205, 205, 205, 6, 338, 6, 330, + 6, 330, 6, 330, 6, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 205, 200, 200, 200, 205, 205, 205, + 205, 205, 205, 205, 205, 205, 205, 205, 205, 205, + 205, 205, 338, 243, 246, 249, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 205, 206, 206, 206, 205, 205, 205, 205, 205, + 205, 205, 205, 205, 205, 205, 205, 205, 205, 205, + 338, 241, 330, 244, 330, 247, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 205, 205, 207, 205, 207, 205, 207, 205, + 205, 205, 205, 205, 205, 205, 205, 205, 205, 205, + 205, 205, 205, 205, 329, 330, 6, 330, 6, 330, + 6, 330, 330, 330, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 200, 200, 200, 200, + 200, 200, 200, 205, 205, 205, 205, 205, 205, 205, + 205, 205, 6, 252, 255, 258, 261, 264, 267, 330, + 330, 330, 330, 330, 330, 330, 330, 330, 206, 206, + 206, 206, 206, 206, 205, 205, 205, 205, 205, 205, + 205, 205, 205, 250, 330, 253, 330, 256, 330, 259, + 330, 262, 330, 265, 330, 330, 330, 330, 330, 330, + 330, 330, 330, 330, 205, 207, 205, 207, 205, 207, + 205, 207, 205, 207, 205, 207, 205, 205, 205, 205, + 205, 205, 205, 205, 205, 330, 6, 330, 6, 330, + 6, 330, 6, 330, 6, 330, 6, 330, 330, 330, + 330, 330, 330, 330, 330, 330, 205, 205, 205, 205, + 205, 205, 200, 200, 200, 330, 330, 330, 330, 330, + 330, 288, 291, 294, 205, 205, 205, 205, 205, 205, + 206, 206, 206, 330, 330, 330, 330, 330, 330, 286, + 330, 289, 330, 292, 330, 205, 205, 205, 205, 205, + 205, 205, 207, 205, 207, 205, 207, 330, 330, 330, + 330, 330, 330, 330, 6, 330, 6, 330, 6, 205, + 205, 205, 200, 200, 200, 330, 330, 330, 279, 282, + 285, 205, 205, 205, 206, 206, 206, 330, 330, 330, + 277, 330, 280, 330, 283, 330, 205, 205, 205, 205, + 207, 205, 207, 205, 207, 330, 330, 330, 330, 6, + 330, 6, 330, 6, 205, 205, 205, 330, 330, 330, + 205, 205, 205, 330, 330, 330, 205, 205, 205, 330, + 330, 330, 200, 200, 200, 270, 273, 276, 206, 206, + 206, 268, 330, 271, 330, 274, 330, 205, 207, 205, + 207, 205, 207, 330, 6, 330, 6, 330, 6 +}; -/* This is the parser code that is written into each bison parser - when the %semantic_parser declaration is not specified in the grammar. - It was written by Richard Stallman by simplifying the hairy parser - used when %semantic_parser is specified. */ - -#ifndef YYSTACK_USE_ALLOCA -#ifdef alloca -#define YYSTACK_USE_ALLOCA -#else /* alloca not defined */ -#ifdef __GNUC__ -#define YYSTACK_USE_ALLOCA -#define alloca __builtin_alloca -#else /* not GNU C. */ -#if (!defined (__STDC__) && defined (sparc)) || defined (__sparc__) || defined (__sparc) || defined (__sgi) || (defined (__sun) && defined (__i386)) -#define YYSTACK_USE_ALLOCA -#include <alloca.h> -#else /* not sparc */ -/* We think this test detects Watcom and Microsoft C. */ -/* This used to test MSDOS, but that is a bad idea - since that symbol is in the user namespace. */ -#if (defined (_MSDOS) || defined (_MSDOS_)) && !defined (__TURBOC__) -#if 0 /* No need for malloc.h, which pollutes the namespace; - instead, just don't use alloca. */ -#include <malloc.h> +#if ! defined (YYSIZE_T) && defined (__SIZE_TYPE__) +# define YYSIZE_T __SIZE_TYPE__ #endif -#else /* not MSDOS, or __TURBOC__ */ -#if defined(_AIX) -/* I don't know what this was needed for, but it pollutes the namespace. - So I turned it off. rms, 2 May 1997. */ -/* #include <malloc.h> */ - #pragma alloca -#define YYSTACK_USE_ALLOCA -#else /* not MSDOS, or __TURBOC__, or _AIX */ -#if 0 -#ifdef __hpux /* haible@ilog.fr says this works for HPUX 9.05 and up, - and on HPUX 10. Eventually we can turn this on. */ -#define YYSTACK_USE_ALLOCA -#define alloca __builtin_alloca -#endif /* __hpux */ +#if ! defined (YYSIZE_T) && defined (size_t) +# define YYSIZE_T size_t #endif -#endif /* not _AIX */ -#endif /* not MSDOS, or __TURBOC__ */ -#endif /* not sparc */ -#endif /* not GNU C */ -#endif /* alloca not defined */ -#endif /* YYSTACK_USE_ALLOCA not defined */ - -#ifdef YYSTACK_USE_ALLOCA -#define YYSTACK_ALLOC alloca -#else -#define YYSTACK_ALLOC malloc +#if ! defined (YYSIZE_T) +# if defined (__STDC__) || defined (__cplusplus) +# include <stddef.h> /* INFRINGES ON USER NAME SPACE */ +# define YYSIZE_T size_t +# endif +#endif +#if ! defined (YYSIZE_T) +# define YYSIZE_T unsigned int #endif - -/* Note: there must be only one dollar sign in this file. - It is replaced by the list of actions, each action - as one case of the switch. */ #define yyerrok (yyerrstatus = 0) #define yyclearin (yychar = YYEMPTY) -#define YYEMPTY -2 +#define YYEMPTY (-2) #define YYEOF 0 + #define YYACCEPT goto yyacceptlab -#define YYABORT goto yyabortlab +#define YYABORT goto yyabortlab #define YYERROR goto yyerrlab1 -/* Like YYERROR except do call yyerror. - This remains here temporarily to ease the - transition to the new meaning of YYERROR, for GCC. + + +/* Like YYERROR except do call yyerror. This remains here temporarily + to ease the transition to the new meaning of YYERROR, for GCC. Once GCC version 2 has supplanted version 1, this can go. */ + #define YYFAIL goto yyerrlab + #define YYRECOVERING() (!!yyerrstatus) -#define YYBACKUP(token, value) \ + +#define YYBACKUP(Token, Value) \ do \ if (yychar == YYEMPTY && yylen == 1) \ - { yychar = (token), yylval = (value); \ - yychar1 = YYTRANSLATE (yychar); \ + { \ + yychar = (Token); \ + yylval = (Value); \ + yytoken = YYTRANSLATE (yychar); \ YYPOPSTACK; \ goto yybackup; \ } \ else \ - { yyerror ("syntax error: cannot back up"); YYERROR; } \ + { \ + yyerror ("syntax error: cannot back up");\ + YYERROR; \ + } \ while (0) #define YYTERROR 1 #define YYERRCODE 256 -#ifndef YYPURE -#define YYLEX yylex() -#endif +/* YYLLOC_DEFAULT -- Compute the default location (before the actions + are run). */ -#ifdef YYPURE -#ifdef YYLSP_NEEDED -#ifdef YYLEX_PARAM -#define YYLEX yylex(&yylval, &yylloc, YYLEX_PARAM) -#else -#define YYLEX yylex(&yylval, &yylloc) +#ifndef YYLLOC_DEFAULT +# define YYLLOC_DEFAULT(Current, Rhs, N) \ + Current.first_line = Rhs[1].first_line; \ + Current.first_column = Rhs[1].first_column; \ + Current.last_line = Rhs[N].last_line; \ + Current.last_column = Rhs[N].last_column; #endif -#else /* not YYLSP_NEEDED */ + +/* YYLEX -- calling `yylex' with the right arguments. */ + #ifdef YYLEX_PARAM -#define YYLEX yylex(&yylval, YYLEX_PARAM) +# define YYLEX yylex (YYLEX_PARAM) #else -#define YYLEX yylex(&yylval) +# define YYLEX yylex () #endif -#endif /* not YYLSP_NEEDED */ -#endif - -/* If nonreentrant, generate the variables here */ -#ifndef YYPURE +/* Enable debugging if requested. */ +#if YYDEBUG + +# ifndef YYFPRINTF +# include <stdio.h> /* INFRINGES ON USER NAME SPACE */ +# define YYFPRINTF fprintf +# endif + +# define YYDPRINTF(Args) \ +do { \ + if (yydebug) \ + YYFPRINTF Args; \ +} while (0) + +# define YYDSYMPRINT(Args) \ +do { \ + if (yydebug) \ + yysymprint Args; \ +} while (0) + +# define YYDSYMPRINTF(Title, Token, Value, Location) \ +do { \ + if (yydebug) \ + { \ + YYFPRINTF (stderr, "%s ", Title); \ + yysymprint (stderr, \ + Token, Value); \ + YYFPRINTF (stderr, "\n"); \ + } \ +} while (0) -int yychar; /* the lookahead symbol */ -YYSTYPE yylval; /* the semantic value of the */ - /* lookahead symbol */ +/*------------------------------------------------------------------. +| yy_stack_print -- Print the state stack from its BOTTOM up to its | +| TOP (cinluded). | +`------------------------------------------------------------------*/ -#ifdef YYLSP_NEEDED -YYLTYPE yylloc; /* location data for the lookahead */ - /* symbol */ +#if defined (__STDC__) || defined (__cplusplus) +static void +yy_stack_print (short *bottom, short *top) +#else +static void +yy_stack_print (bottom, top) + short *bottom; + short *top; #endif +{ + YYFPRINTF (stderr, "Stack now"); + for (/* Nothing. */; bottom <= top; ++bottom) + YYFPRINTF (stderr, " %d", *bottom); + YYFPRINTF (stderr, "\n"); +} -int yynerrs; /* number of parse errors so far */ -#endif /* not YYPURE */ +# define YY_STACK_PRINT(Bottom, Top) \ +do { \ + if (yydebug) \ + yy_stack_print ((Bottom), (Top)); \ +} while (0) -#if YYDEBUG != 0 -int yydebug; /* nonzero means print parse trace */ -/* Since this is uninitialized, it does not stop multiple parsers - from coexisting. */ -#endif -/* YYINITDEPTH indicates the initial size of the parser's stacks */ +/*------------------------------------------------. +| Report that the YYRULE is going to be reduced. | +`------------------------------------------------*/ +#if defined (__STDC__) || defined (__cplusplus) +static void +yy_reduce_print (int yyrule) +#else +static void +yy_reduce_print (yyrule) + int yyrule; +#endif +{ + int yyi; + unsigned int yylno = yyrline[yyrule]; + YYFPRINTF (stderr, "Reducing stack by rule %d (line %u), ", + yyrule - 1, yylno); + /* Print the symbols being reduced, and their result. */ + for (yyi = yyprhs[yyrule]; 0 <= yyrhs[yyi]; yyi++) + YYFPRINTF (stderr, "%s ", yytname [yyrhs[yyi]]); + YYFPRINTF (stderr, "-> %s\n", yytname [yyr1[yyrule]]); +} + +# define YY_REDUCE_PRINT(Rule) \ +do { \ + if (yydebug) \ + yy_reduce_print (Rule); \ +} while (0) + +/* Nonzero means print parse trace. It is left uninitialized so that + multiple parsers can coexist. */ +int yydebug; +#else /* !YYDEBUG */ +# define YYDPRINTF(Args) +# define YYDSYMPRINT(Args) +# define YYDSYMPRINTF(Title, Token, Value, Location) +# define YY_STACK_PRINT(Bottom, Top) +# define YY_REDUCE_PRINT(Rule) +#endif /* !YYDEBUG */ + + +/* YYINITDEPTH -- initial size of the parser's stacks. */ #ifndef YYINITDEPTH -#define YYINITDEPTH 200 +# define YYINITDEPTH 200 #endif -/* YYMAXDEPTH is the maximum size the stacks can grow to - (effective only if the built-in stack extension method is used). */ +/* YYMAXDEPTH -- maximum size the stacks can grow to (effective only + if the built-in stack extension method is used). + + Do not make this value too large; the results are undefined if + SIZE_MAX < YYSTACK_BYTES (YYMAXDEPTH) + evaluated with infinite-precision integer arithmetic. */ #if YYMAXDEPTH == 0 -#undef YYMAXDEPTH +# undef YYMAXDEPTH #endif #ifndef YYMAXDEPTH -#define YYMAXDEPTH 10000 +# define YYMAXDEPTH 10000 #endif + -/* Define __yy_memcpy. Note that the size argument - should be passed with type unsigned int, because that is what the non-GCC - definitions require. With GCC, __builtin_memcpy takes an arg - of type size_t, but it can handle unsigned int. */ - -#if __GNUC__ > 1 /* GNU C and GNU C++ define this. */ -#define __yy_memcpy(TO,FROM,COUNT) __builtin_memcpy(TO,FROM,COUNT) -#else /* not GNU C or C++ */ -#ifndef __cplusplus - -/* This is the most reliable way to avoid incompatibilities - in available built-in functions on various systems. */ -static void -__yy_memcpy (to, from, count) - char *to; - char *from; - unsigned int count; + +#if YYERROR_VERBOSE + +# ifndef yystrlen +# if defined (__GLIBC__) && defined (_STRING_H) +# define yystrlen strlen +# else +/* Return the length of YYSTR. */ +static YYSIZE_T +# if defined (__STDC__) || defined (__cplusplus) +yystrlen (const char *yystr) +# else +yystrlen (yystr) + const char *yystr; +# endif { - register char *f = from; - register char *t = to; - register int i = count; + register const char *yys = yystr; - while (i-- > 0) - *t++ = *f++; + while (*yys++ != '\0') + continue; + + return yys - yystr - 1; +} +# endif +# endif + +# ifndef yystpcpy +# if defined (__GLIBC__) && defined (_STRING_H) && defined (_GNU_SOURCE) +# define yystpcpy stpcpy +# else +/* Copy YYSRC to YYDEST, returning the address of the terminating '\0' in + YYDEST. */ +static char * +# if defined (__STDC__) || defined (__cplusplus) +yystpcpy (char *yydest, const char *yysrc) +# else +yystpcpy (yydest, yysrc) + char *yydest; + const char *yysrc; +# endif +{ + register char *yyd = yydest; + register const char *yys = yysrc; + + while ((*yyd++ = *yys++) != '\0') + continue; + + return yyd - 1; } +# endif +# endif + +#endif /* !YYERROR_VERBOSE */ -#else /* __cplusplus */ + + +#if YYDEBUG +/*--------------------------------. +| Print this symbol on YYOUTPUT. | +`--------------------------------*/ -/* This is the most reliable way to avoid incompatibilities - in available built-in functions on various systems. */ +#if defined (__STDC__) || defined (__cplusplus) static void -__yy_memcpy (char *to, char *from, unsigned int count) +yysymprint (FILE *yyoutput, int yytype, YYSTYPE *yyvaluep) +#else +static void +yysymprint (yyoutput, yytype, yyvaluep) + FILE *yyoutput; + int yytype; + YYSTYPE *yyvaluep; +#endif { - register char *t = to; - register char *f = from; - register int i = count; + /* Pacify ``unused variable'' warnings. */ + (void) yyvaluep; - while (i-- > 0) - *t++ = *f++; + if (yytype < YYNTOKENS) + { + YYFPRINTF (yyoutput, "token %s (", yytname[yytype]); +# ifdef YYPRINT + YYPRINT (yyoutput, yytoknum[yytype], *yyvaluep); +# endif + } + else + YYFPRINTF (yyoutput, "nterm %s (", yytname[yytype]); + + switch (yytype) + { + default: + break; + } + YYFPRINTF (yyoutput, ")"); } +#endif /* ! YYDEBUG */ +/*-----------------------------------------------. +| Release the memory associated to this symbol. | +`-----------------------------------------------*/ + +#if defined (__STDC__) || defined (__cplusplus) +static void +yydestruct (int yytype, YYSTYPE *yyvaluep) +#else +static void +yydestruct (yytype, yyvaluep) + int yytype; + YYSTYPE *yyvaluep; #endif -#endif +{ + /* Pacify ``unused variable'' warnings. */ + (void) yyvaluep; + + switch (yytype) + { + + default: + break; + } +} -#line 217 "/usr/share/bison.simple" -/* The user can define YYPARSE_PARAM as the name of an argument to be passed - into yyparse. The argument should have type void *. - It should actually point to an object. - Grammar actions can access the variable by casting it - to the proper pointer type. */ +/* Prevent warnings from -Wmissing-prototypes. */ #ifdef YYPARSE_PARAM -#ifdef __cplusplus -#define YYPARSE_PARAM_ARG void *YYPARSE_PARAM -#define YYPARSE_PARAM_DECL -#else /* not __cplusplus */ -#define YYPARSE_PARAM_ARG YYPARSE_PARAM -#define YYPARSE_PARAM_DECL void *YYPARSE_PARAM; -#endif /* not __cplusplus */ -#else /* not YYPARSE_PARAM */ -#define YYPARSE_PARAM_ARG -#define YYPARSE_PARAM_DECL -#endif /* not YYPARSE_PARAM */ - -/* Prevent warning if -Wstrict-prototypes. */ -#ifdef __GNUC__ -#ifdef YYPARSE_PARAM -int yyparse (void *); -#else +# if defined (__STDC__) || defined (__cplusplus) +int yyparse (void *YYPARSE_PARAM); +# else +int yyparse (); +# endif +#else /* ! YYPARSE_PARAM */ +#if defined (__STDC__) || defined (__cplusplus) int yyparse (void); +#else +int yyparse (); #endif -#endif +#endif /* ! YYPARSE_PARAM */ + + + +/* The lookahead symbol. */ +int yychar; +/* The semantic value of the lookahead symbol. */ +YYSTYPE yylval; + +/* Number of syntax errors so far. */ +int yynerrs; + + + +/*----------. +| yyparse. | +`----------*/ + +#ifdef YYPARSE_PARAM +# if defined (__STDC__) || defined (__cplusplus) +int yyparse (void *YYPARSE_PARAM) +# else +int yyparse (YYPARSE_PARAM) + void *YYPARSE_PARAM; +# endif +#else /* ! YYPARSE_PARAM */ +#if defined (__STDC__) || defined (__cplusplus) int -yyparse(YYPARSE_PARAM_ARG) - YYPARSE_PARAM_DECL +yyparse (void) +#else +int +yyparse () + +#endif +#endif { + register int yystate; register int yyn; + int yyresult; + /* Number of tokens to shift before error messages enabled. */ + int yyerrstatus; + /* Lookahead token as an internal (translated) token number. */ + int yytoken = 0; + + /* Three stacks and their tools: + `yyss': related to states, + `yyvs': related to semantic values, + `yyls': related to locations. + + Refer to the stacks thru separate pointers, to allow yyoverflow + to reallocate them elsewhere. */ + + /* The state stack. */ + short yyssa[YYINITDEPTH]; + short *yyss = yyssa; register short *yyssp; - register YYSTYPE *yyvsp; - int yyerrstatus; /* number of tokens to shift before error messages enabled */ - int yychar1 = 0; /* lookahead token as an internal (translated) token number */ - short yyssa[YYINITDEPTH]; /* the state stack */ - YYSTYPE yyvsa[YYINITDEPTH]; /* the semantic value stack */ + /* The semantic value stack. */ + YYSTYPE yyvsa[YYINITDEPTH]; + YYSTYPE *yyvs = yyvsa; + register YYSTYPE *yyvsp; - short *yyss = yyssa; /* refer to the stacks thru separate pointers */ - YYSTYPE *yyvs = yyvsa; /* to allow yyoverflow to reallocate them elsewhere */ -#ifdef YYLSP_NEEDED - YYLTYPE yylsa[YYINITDEPTH]; /* the location stack */ - YYLTYPE *yyls = yylsa; - YYLTYPE *yylsp; -#define YYPOPSTACK (yyvsp--, yyssp--, yylsp--) -#else #define YYPOPSTACK (yyvsp--, yyssp--) -#endif - int yystacksize = YYINITDEPTH; - int yyfree_stacks = 0; + YYSIZE_T yystacksize = YYINITDEPTH; -#ifdef YYPURE - int yychar; - YYSTYPE yylval; - int yynerrs; -#ifdef YYLSP_NEEDED - YYLTYPE yylloc; -#endif -#endif + /* The variables used to return semantic value and location from the + action routines. */ + YYSTYPE yyval; - YYSTYPE yyval; /* the variable used to return */ - /* semantic values from the action */ - /* routines */ + /* When reducing, the number of symbols on the RHS of the reduced + rule. */ int yylen; -#if YYDEBUG != 0 - if (yydebug) - fprintf(stderr, "Starting parse\n"); -#endif + YYDPRINTF ((stderr, "Starting parse\n")); yystate = 0; yyerrstatus = 0; @@ -4451,110 +5372,96 @@ yyparse(YYPARSE_PARAM_ARG) so that they stay on the same level as the state stack. The wasted elements are never initialized. */ - yyssp = yyss - 1; + yyssp = yyss; yyvsp = yyvs; -#ifdef YYLSP_NEEDED - yylsp = yyls; -#endif -/* Push a new state, which is found in yystate . */ -/* In all cases, when you get here, the value and location stacks - have just been pushed. so pushing a state here evens the stacks. */ -yynewstate: + goto yysetstate; - *++yyssp = yystate; +/*------------------------------------------------------------. +| yynewstate -- Push a new state, which is found in yystate. | +`------------------------------------------------------------*/ + yynewstate: + /* In all cases, when you get here, the value and location stacks + have just been pushed. so pushing a state here evens the stacks. + */ + yyssp++; - if (yyssp >= yyss + yystacksize - 1) - { - /* Give user a chance to reallocate the stack */ - /* Use copies of these so that the &'s don't force the real ones into memory. */ - YYSTYPE *yyvs1 = yyvs; - short *yyss1 = yyss; -#ifdef YYLSP_NEEDED - YYLTYPE *yyls1 = yyls; -#endif + yysetstate: + *yyssp = yystate; + if (yyss + yystacksize - 1 <= yyssp) + { /* Get the current used size of the three stacks, in elements. */ - int size = yyssp - yyss + 1; + YYSIZE_T yysize = yyssp - yyss + 1; #ifdef yyoverflow - /* Each stack pointer address is followed by the size of - the data in use in that stack, in bytes. */ -#ifdef YYLSP_NEEDED - /* This used to be a conditional around just the two extra args, - but that might be undefined if yyoverflow is a macro. */ - yyoverflow("parser stack overflow", - &yyss1, size * sizeof (*yyssp), - &yyvs1, size * sizeof (*yyvsp), - &yyls1, size * sizeof (*yylsp), - &yystacksize); -#else - yyoverflow("parser stack overflow", - &yyss1, size * sizeof (*yyssp), - &yyvs1, size * sizeof (*yyvsp), - &yystacksize); -#endif + { + /* Give user a chance to reallocate the stack. Use copies of + these so that the &'s don't force the real ones into + memory. */ + YYSTYPE *yyvs1 = yyvs; + short *yyss1 = yyss; - yyss = yyss1; yyvs = yyvs1; -#ifdef YYLSP_NEEDED - yyls = yyls1; -#endif + + /* Each stack pointer address is followed by the size of the + data in use in that stack, in bytes. This used to be a + conditional around just the two extra args, but that might + be undefined if yyoverflow is a macro. */ + yyoverflow ("parser stack overflow", + &yyss1, yysize * sizeof (*yyssp), + &yyvs1, yysize * sizeof (*yyvsp), + + &yystacksize); + + yyss = yyss1; + yyvs = yyvs1; + } #else /* no yyoverflow */ +# ifndef YYSTACK_RELOCATE + goto yyoverflowlab; +# else /* Extend the stack our own way. */ - if (yystacksize >= YYMAXDEPTH) - { - yyerror("parser stack overflow"); - if (yyfree_stacks) - { - free (yyss); - free (yyvs); -#ifdef YYLSP_NEEDED - free (yyls); -#endif - } - return 2; - } + if (YYMAXDEPTH <= yystacksize) + goto yyoverflowlab; yystacksize *= 2; - if (yystacksize > YYMAXDEPTH) + if (YYMAXDEPTH < yystacksize) yystacksize = YYMAXDEPTH; -#ifndef YYSTACK_USE_ALLOCA - yyfree_stacks = 1; -#endif - yyss = (short *) YYSTACK_ALLOC (yystacksize * sizeof (*yyssp)); - __yy_memcpy ((char *)yyss, (char *)yyss1, - size * (unsigned int) sizeof (*yyssp)); - yyvs = (YYSTYPE *) YYSTACK_ALLOC (yystacksize * sizeof (*yyvsp)); - __yy_memcpy ((char *)yyvs, (char *)yyvs1, - size * (unsigned int) sizeof (*yyvsp)); -#ifdef YYLSP_NEEDED - yyls = (YYLTYPE *) YYSTACK_ALLOC (yystacksize * sizeof (*yylsp)); - __yy_memcpy ((char *)yyls, (char *)yyls1, - size * (unsigned int) sizeof (*yylsp)); -#endif + + { + short *yyss1 = yyss; + union yyalloc *yyptr = + (union yyalloc *) YYSTACK_ALLOC (YYSTACK_BYTES (yystacksize)); + if (! yyptr) + goto yyoverflowlab; + YYSTACK_RELOCATE (yyss); + YYSTACK_RELOCATE (yyvs); + +# undef YYSTACK_RELOCATE + if (yyss1 != yyssa) + YYSTACK_FREE (yyss1); + } +# endif #endif /* no yyoverflow */ - yyssp = yyss + size - 1; - yyvsp = yyvs + size - 1; -#ifdef YYLSP_NEEDED - yylsp = yyls + size - 1; -#endif + yyssp = yyss + yysize - 1; + yyvsp = yyvs + yysize - 1; -#if YYDEBUG != 0 - if (yydebug) - fprintf(stderr, "Stack size increased to %d\n", yystacksize); -#endif - if (yyssp >= yyss + yystacksize - 1) + YYDPRINTF ((stderr, "Stack size increased to %lu\n", + (unsigned long int) yystacksize)); + + if (yyss + yystacksize - 1 <= yyssp) YYABORT; } -#if YYDEBUG != 0 - if (yydebug) - fprintf(stderr, "Entering state %d\n", yystate); -#endif + YYDPRINTF ((stderr, "Entering state %d\n", yystate)); goto yybackup; - yybackup: + +/*-----------. +| yybackup. | +`-----------*/ +yybackup: /* Do appropriate processing given the current state. */ /* Read a lookahead token if we need one and don't already have one. */ @@ -4563,165 +5470,134 @@ yynewstate: /* First try to decide what to do without reference to lookahead token. */ yyn = yypact[yystate]; - if (yyn == YYFLAG) + if (yyn == YYPACT_NINF) goto yydefault; /* Not known => get a lookahead token if don't already have one. */ - /* yychar is either YYEMPTY or YYEOF - or a valid token in external form. */ - + /* YYCHAR is either YYEMPTY or YYEOF or a valid lookahead symbol. */ if (yychar == YYEMPTY) { -#if YYDEBUG != 0 - if (yydebug) - fprintf(stderr, "Reading a token: "); -#endif + YYDPRINTF ((stderr, "Reading a token: ")); yychar = YYLEX; } - /* Convert token to internal form (in yychar1) for indexing tables with */ - - if (yychar <= 0) /* This means end of input. */ + if (yychar <= YYEOF) { - yychar1 = 0; - yychar = YYEOF; /* Don't call YYLEX any more */ - -#if YYDEBUG != 0 - if (yydebug) - fprintf(stderr, "Now at end of input.\n"); -#endif + yychar = yytoken = YYEOF; + YYDPRINTF ((stderr, "Now at end of input.\n")); } else { - yychar1 = YYTRANSLATE(yychar); - -#if YYDEBUG != 0 - if (yydebug) - { - fprintf (stderr, "Next token is %d (%s", yychar, yytname[yychar1]); - /* Give the individual parser a way to print the precise meaning - of a token, for further debugging info. */ -#ifdef YYPRINT - YYPRINT (stderr, yychar, yylval); -#endif - fprintf (stderr, ")\n"); - } -#endif + yytoken = YYTRANSLATE (yychar); + YYDSYMPRINTF ("Next token is", yytoken, &yylval, &yylloc); } - yyn += yychar1; - if (yyn < 0 || yyn > YYLAST || yycheck[yyn] != yychar1) + /* If the proper action on seeing token YYTOKEN is to reduce or to + detect an error, take that action. */ + yyn += yytoken; + if (yyn < 0 || YYLAST < yyn || yycheck[yyn] != yytoken) goto yydefault; - yyn = yytable[yyn]; - - /* yyn is what to do for this token type in this state. - Negative => reduce, -yyn is rule number. - Positive => shift, yyn is new state. - New state is final state => don't bother to shift, - just return success. - 0, or most negative number => error. */ - - if (yyn < 0) + if (yyn <= 0) { - if (yyn == YYFLAG) + if (yyn == 0 || yyn == YYTABLE_NINF) goto yyerrlab; yyn = -yyn; goto yyreduce; } - else if (yyn == 0) - goto yyerrlab; if (yyn == YYFINAL) YYACCEPT; /* Shift the lookahead token. */ - -#if YYDEBUG != 0 - if (yydebug) - fprintf(stderr, "Shifting token %d (%s), ", yychar, yytname[yychar1]); -#endif + YYDPRINTF ((stderr, "Shifting token %s, ", yytname[yytoken])); /* Discard the token being shifted unless it is eof. */ if (yychar != YYEOF) yychar = YYEMPTY; *++yyvsp = yylval; -#ifdef YYLSP_NEEDED - *++yylsp = yylloc; -#endif - /* count tokens shifted since error; after three, turn off error status. */ - if (yyerrstatus) yyerrstatus--; + + /* Count tokens shifted since error; after three, turn off error + status. */ + if (yyerrstatus) + yyerrstatus--; yystate = yyn; goto yynewstate; -/* Do the default action for the current state. */ -yydefault: +/*-----------------------------------------------------------. +| yydefault -- do the default action for the current state. | +`-----------------------------------------------------------*/ +yydefault: yyn = yydefact[yystate]; if (yyn == 0) goto yyerrlab; + goto yyreduce; + -/* Do a reduction. yyn is the number of a rule to reduce with. */ +/*-----------------------------. +| yyreduce -- Do a reduction. | +`-----------------------------*/ yyreduce: + /* yyn is the number of a rule to reduce with. */ yylen = yyr2[yyn]; - if (yylen > 0) - yyval = yyvsp[1-yylen]; /* implement default value of the action */ -#if YYDEBUG != 0 - if (yydebug) - { - int i; - - fprintf (stderr, "Reducing via rule %d (line %d), ", - yyn, yyrline[yyn]); - - /* Print the symbols being reduced, and their result. */ - for (i = yyprhs[yyn]; yyrhs[i] > 0; i++) - fprintf (stderr, "%s ", yytname[yyrhs[i]]); - fprintf (stderr, " -> %s\n", yytname[yyr1[yyn]]); - } -#endif + /* If YYLEN is nonzero, implement the default value of the action: + `$$ = $1'. + Otherwise, the following line sets YYVAL to garbage. + This behavior is undocumented and Bison + users should not rely upon it. Assigning to YYVAL + unconditionally makes the parser a bit smaller, and it avoids a + GCC warning that YYVAL may be used uninitialized. */ + yyval = yyvsp[1-yylen]; - switch (yyn) { -case 4: + YY_REDUCE_PRINT (yyn); + switch (yyn) + { + case 5: #line 169 "Gmsh.y" -{ yyerrok; return 1; ; - break;} -case 5: + { yyerrok; return 1; ;} + break; + + case 6: #line 175 "Gmsh.y" -{ yyval.d = yyvsp[0].d; ; - break;} -case 6: + { yyval.d = yyvsp[0].d; ;} + break; + + case 7: #line 176 "Gmsh.y" -{ yyval.d = -yyvsp[0].d; ; - break;} -case 9: + { yyval.d = -yyvsp[0].d; ;} + break; + + case 10: #line 186 "Gmsh.y" -{ + { yymsg(INFO, "Reading STL solid"); STL_Surf = Create_Surface(NEWSURFACE(), MSH_SURF_STL); STL_Surf->STL = new STL_Data; return 1; - ; - break;} -case 10: + ;} + break; + + case 11: #line 200 "Gmsh.y" -{ + { STL_Surf->STL->Add_Facet(yyvsp[-12].d, yyvsp[-11].d, yyvsp[-10].d, yyvsp[-8].d, yyvsp[-7].d, yyvsp[-6].d, yyvsp[-4].d, yyvsp[-3].d, yyvsp[-2].d, CTX.geom.stl_create_elementary); return 1; - ; - break;} -case 11: + ;} + break; + + case 12: #line 207 "Gmsh.y" -{ + { if(CTX.geom.stl_create_elementary){ STL_Surf->STL->ReplaceDuplicate(); if(CTX.geom.stl_create_physical) @@ -4732,288 +5608,342 @@ case 11: } yymsg(INFO, "Read STL solid"); return 1; - ; - break;} -case 14: + ;} + break; + + case 15: #line 229 "Gmsh.y" -{ return 1; ; - break;} -case 15: + { return 1; ;} + break; + + case 16: #line 230 "Gmsh.y" -{ return 1; ; - break;} -case 16: + { return 1; ;} + break; + + case 17: #line 231 "Gmsh.y" -{ return 1; ; - break;} -case 17: + { return 1; ;} + break; + + case 18: #line 236 "Gmsh.y" -{ + { yymsg(INFO, "Reading Step Iso-10303-21 data"); Create_Step_Solid_BRep(); - ; - break;} -case 18: + ;} + break; + + case 19: #line 241 "Gmsh.y" -{ + { Resolve_BREP (); yymsg(INFO, "Read Step Iso-10303-21 data"); - ; - break;} -case 22: + ;} + break; + + case 23: #line 252 "Gmsh.y" -{ - ; - break;} -case 23: + { + ;} + break; + + case 24: #line 255 "Gmsh.y" -{ - ; - break;} -case 24: + { + ;} + break; + + case 25: #line 259 "Gmsh.y" -{ - ; - break;} -case 25: + { + ;} + break; + + case 26: #line 265 "Gmsh.y" -{ + { Add_Cartesian_Point((int)yyvsp[-8].d, yyvsp[-4].c, yyvsp[-2].v[0], yyvsp[-2].v[1], yyvsp[-2].v[2]); - ; - break;} -case 26: + ;} + break; + + case 27: #line 271 "Gmsh.y" -{ + { Add_BSpline_Curve_With_Knots ((int)yyvsp[-22].d, yyvsp[-18].c, (int) yyvsp[-16].d, yyvsp[-14].l, yyvsp[-6].l, yyvsp[-4].l, 0., 1.); - ; - break;} -case 27: + ;} + break; + + case 28: #line 278 "Gmsh.y" -{ + { Add_BSpline_Surface_With_Knots ((int)yyvsp[-30].d, yyvsp[-26].c, (int) yyvsp[-24].d, (int) yyvsp[-22].d, yyvsp[-20].l, yyvsp[-10].l, yyvsp[-8].l, yyvsp[-6].l, yyvsp[-4].l, 0., 1., 0., 1. ); - ; - break;} -case 28: + ;} + break; + + case 29: #line 284 "Gmsh.y" -{ + { Add_Edge_Curve ((int)yyvsp[-14].d, yyvsp[-10].c , (int)yyvsp[-8].d , (int)yyvsp[-6].d, (int)yyvsp[-4].d); - ; - break;} -case 29: + ;} + break; + + case 30: #line 288 "Gmsh.y" -{ + { Add_Face_Outer_Bound((int)yyvsp[-10].d, yyvsp[-6].c, (int)yyvsp[-4].d, yyvsp[-2].i, 1); - ; - break;} -case 30: + ;} + break; + + case 31: #line 292 "Gmsh.y" -{ + { // check the norm! Face_Bound : hole outside surface! yymsg(INFO, "Found a face bound"); Add_Face_Outer_Bound((int)yyvsp[-10].d, yyvsp[-6].c, (int)yyvsp[-4].d, yyvsp[-2].i, 0); - ; - break;} -case 31: + ;} + break; + + case 32: #line 299 "Gmsh.y" -{ + { Add_Oriented_Edge((int)yyvsp[-14].d, yyvsp[-10].c, (int)yyvsp[-4].d, yyvsp[-2].i); - ; - break;} -case 32: + ;} + break; + + case 33: #line 303 "Gmsh.y" -{ + { Add_Edge_Loop((int)yyvsp[-8].d, yyvsp[-4].c, yyvsp[-2].l); - ; - break;} -case 33: + ;} + break; + + case 34: #line 308 "Gmsh.y" -{ + { Add_Advanced_Face((int)yyvsp[-12].d, yyvsp[-8].c, yyvsp[-6].l, (int)yyvsp[-4].d, yyvsp[-2].i); - ; - break;} -case 34: + ;} + break; + + case 35: #line 312 "Gmsh.y" -{ + { Add_Vertex_Point((int)yyvsp[-8].d, yyvsp[-4].c, (int)yyvsp[-2].d); - ; - break;} -case 35: + ;} + break; + + case 36: #line 316 "Gmsh.y" -{ - ; - break;} -case 36: + { + ;} + break; + + case 37: #line 320 "Gmsh.y" -{ + { Add_Axis2_Placement3D ((int)yyvsp[-12].d, (int)yyvsp[-4].d, (int)yyvsp[-2].d, (int)yyvsp[-6].d); - ; - break;} -case 37: + ;} + break; + + case 38: #line 324 "Gmsh.y" -{ + { Add_Direction((int)yyvsp[-8].d , yyvsp[-4].c, yyvsp[-2].v[0], yyvsp[-2].v[1], yyvsp[-2].v[2]); - ; - break;} -case 38: + ;} + break; + + case 39: #line 328 "Gmsh.y" -{ + { Add_Plane((int)yyvsp[-8].d, yyvsp[-4].c, (int)yyvsp[-2].d); - ; - break;} -case 39: + ;} + break; + + case 40: #line 332 "Gmsh.y" -{ + { Add_Line ((int)yyvsp[-10].d, yyvsp[-6].c , (int) yyvsp[-4].d, (int)yyvsp[-2].d); - ; - break;} -case 40: + ;} + break; + + case 41: #line 336 "Gmsh.y" -{ + { yymsg(INFO, "Found a closed shell"); Add_Closed_Shell((int)yyvsp[-8].d, yyvsp[-4].c , yyvsp[-2].l); - ; - break;} -case 41: + ;} + break; + + case 42: #line 342 "Gmsh.y" -{ - ; - break;} -case 42: + { + ;} + break; + + case 43: #line 345 "Gmsh.y" -{ - ; - break;} -case 43: + { + ;} + break; + + case 44: #line 348 "Gmsh.y" -{ + { Add_Cylinder ((int)yyvsp[-10].d, yyvsp[-6].c , (int)yyvsp[-4].d, yyvsp[-2].d); - ; - break;} -case 44: + ;} + break; + + case 45: #line 352 "Gmsh.y" -{ + { Add_Cone ((int)yyvsp[-12].d, yyvsp[-8].c , (int)yyvsp[-6].d, yyvsp[-4].d, yyvsp[-2].d); - ; - break;} -case 45: + ;} + break; + + case 46: #line 356 "Gmsh.y" -{ + { Add_Torus ((int)yyvsp[-12].d, yyvsp[-8].c , (int)yyvsp[-6].d, yyvsp[-4].d, yyvsp[-2].d); - ; - break;} -case 46: + ;} + break; + + case 47: #line 360 "Gmsh.y" -{ + { Add_Circle((int) yyvsp[-10].d, yyvsp[-6].c, (int) yyvsp[-4].d, yyvsp[-2].d); - ; - break;} -case 47: + ;} + break; + + case 48: #line 364 "Gmsh.y" -{ + { Add_Ellipse((int) yyvsp[-12].d, yyvsp[-8].c, (int) yyvsp[-6].d, yyvsp[-4].d, yyvsp[-2].d); - ; - break;} -case 48: + ;} + break; + + case 49: #line 369 "Gmsh.y" -{ - ; - break;} -case 49: + { + ;} + break; + + case 50: #line 372 "Gmsh.y" -{ - ; - break;} -case 50: + { + ;} + break; + + case 51: #line 376 "Gmsh.y" -{ - ; - break;} -case 51: + { + ;} + break; + + case 52: #line 379 "Gmsh.y" -{ - ; - break;} -case 52: + { + ;} + break; + + case 53: #line 383 "Gmsh.y" -{ - ; - break;} -case 53: + { + ;} + break; + + case 54: #line 386 "Gmsh.y" -{ - ; - break;} -case 54: + { + ;} + break; + + case 55: #line 389 "Gmsh.y" -{ - ; - break;} -case 57: + { + ;} + break; + + case 58: #line 401 "Gmsh.y" -{ return 1; ; - break;} -case 58: + { return 1; ;} + break; + + case 59: #line 402 "Gmsh.y" -{ return 1; ; - break;} -case 59: + { return 1; ;} + break; + + case 60: #line 403 "Gmsh.y" -{ return 1; ; - break;} -case 60: + { return 1; ;} + break; + + case 61: #line 404 "Gmsh.y" -{ return 1; ; - break;} -case 61: + { return 1; ;} + break; + + case 62: #line 405 "Gmsh.y" -{ List_Delete(yyvsp[0].l); return 1; ; - break;} -case 62: + { List_Delete(yyvsp[0].l); return 1; ;} + break; + + case 63: #line 406 "Gmsh.y" -{ List_Delete(yyvsp[0].l); return 1; ; - break;} -case 63: + { List_Delete(yyvsp[0].l); return 1; ;} + break; + + case 64: #line 407 "Gmsh.y" -{ return 1; ; - break;} -case 64: + { return 1; ;} + break; + + case 65: #line 408 "Gmsh.y" -{ return 1; ; - break;} -case 65: + { return 1; ;} + break; + + case 66: #line 409 "Gmsh.y" -{ return 1; ; - break;} -case 66: + { return 1; ;} + break; + + case 67: #line 410 "Gmsh.y" -{ List_Delete(yyvsp[0].l); return 1; ; - break;} -case 67: + { List_Delete(yyvsp[0].l); return 1; ;} + break; + + case 68: #line 411 "Gmsh.y" -{ return 1; ; - break;} -case 68: + { return 1; ;} + break; + + case 69: #line 412 "Gmsh.y" -{ return 1; ; - break;} -case 69: + { return 1; ;} + break; + + case 70: #line 413 "Gmsh.y" -{ return 1; ; - break;} -case 70: + { return 1; ;} + break; + + case 71: #line 414 "Gmsh.y" -{ return 1; ; - break;} -case 71: + { return 1; ;} + break; + + case 72: #line 419 "Gmsh.y" -{ + { Msg(DIRECT, yyvsp[-2].c); - ; - break;} -case 72: + ;} + break; + + case 73: #line 423 "Gmsh.y" -{ + { char tmpstring[1024]; int i = PrintListOfDouble(yyvsp[-4].c, yyvsp[-2].l, tmpstring); if(i < 0) @@ -5023,186 +5953,216 @@ case 72: else Msg(DIRECT, tmpstring); List_Delete(yyvsp[-2].l); - ; - break;} -case 73: + ;} + break; + + case 74: #line 440 "Gmsh.y" -{ + { if(!strcmp(yyvsp[-5].c, "View")) EndView(View, 1, yyname, yyvsp[-4].c); - ; - break;} -case 74: + ;} + break; + + case 75: #line 444 "Gmsh.y" -{ + { if(!strcmp(yyvsp[-7].c, "View")) EndView(View, 1, yyname, yyvsp[-6].c); - ; - break;} -case 75: + ;} + break; + + case 76: #line 451 "Gmsh.y" -{ + { View = BeginView(1); - ; - break;} -case 102: -#line 484 "Gmsh.y" -{ List_Add(View->SP, &yyvsp[0].d); ; - break;} -case 103: -#line 486 "Gmsh.y" -{ List_Add(View->SP, &yyvsp[0].d); ; - break;} -case 104: -#line 491 "Gmsh.y" -{ + ;} + break; + + case 104: +#line 485 "Gmsh.y" + { List_Add(View->SP, &yyvsp[0].d); ;} + break; + + case 105: +#line 487 "Gmsh.y" + { List_Add(View->SP, &yyvsp[0].d); ;} + break; + + case 106: +#line 492 "Gmsh.y" + { List_Add(View->SP, &yyvsp[-5].d); List_Add(View->SP, &yyvsp[-3].d); List_Add(View->SP, &yyvsp[-1].d); - ; - break;} -case 105: -#line 496 "Gmsh.y" -{ + ;} + break; + + case 107: +#line 497 "Gmsh.y" + { View->NbSP++; - ; - break;} -case 106: -#line 503 "Gmsh.y" -{ List_Add(View->VP, &yyvsp[0].d); ; - break;} -case 107: -#line 505 "Gmsh.y" -{ List_Add(View->VP, &yyvsp[0].d); ; - break;} -case 108: -#line 510 "Gmsh.y" -{ + ;} + break; + + case 108: +#line 504 "Gmsh.y" + { List_Add(View->VP, &yyvsp[0].d); ;} + break; + + case 109: +#line 506 "Gmsh.y" + { List_Add(View->VP, &yyvsp[0].d); ;} + break; + + case 110: +#line 511 "Gmsh.y" + { List_Add(View->VP, &yyvsp[-5].d); List_Add(View->VP, &yyvsp[-3].d); List_Add(View->VP, &yyvsp[-1].d); ntmp = List_Nbr(View->VP); - ; - break;} -case 109: -#line 516 "Gmsh.y" -{ + ;} + break; + + case 111: +#line 517 "Gmsh.y" + { if((List_Nbr(View->VP) - ntmp) % 3) yymsg(GERROR, "Wrong number of values for vector point " "(%d is not a multiple of 3)", List_Nbr(View->VP) - ntmp); View->NbVP++; - ; - break;} -case 110: -#line 526 "Gmsh.y" -{ List_Add(View->TP, &yyvsp[0].d); ; - break;} -case 111: -#line 528 "Gmsh.y" -{ List_Add(View->TP, &yyvsp[0].d); ; - break;} -case 112: -#line 533 "Gmsh.y" -{ + ;} + break; + + case 112: +#line 527 "Gmsh.y" + { List_Add(View->TP, &yyvsp[0].d); ;} + break; + + case 113: +#line 529 "Gmsh.y" + { List_Add(View->TP, &yyvsp[0].d); ;} + break; + + case 114: +#line 534 "Gmsh.y" + { List_Add(View->TP, &yyvsp[-5].d); List_Add(View->TP, &yyvsp[-3].d); List_Add(View->TP, &yyvsp[-1].d); ntmp = List_Nbr(View->TP); - ; - break;} -case 113: -#line 539 "Gmsh.y" -{ + ;} + break; + + case 115: +#line 540 "Gmsh.y" + { if((List_Nbr(View->TP) - ntmp) % 9) yymsg(GERROR, "Wrong number of values for tensor point " "(%d is not a multiple of 9)", List_Nbr(View->TP) - ntmp); View->NbTP++; - ; - break;} -case 114: -#line 549 "Gmsh.y" -{ List_Add(View->SL, &yyvsp[0].d); ; - break;} -case 115: -#line 551 "Gmsh.y" -{ List_Add(View->SL, &yyvsp[0].d); ; - break;} -case 116: -#line 557 "Gmsh.y" -{ + ;} + break; + + case 116: +#line 550 "Gmsh.y" + { List_Add(View->SL, &yyvsp[0].d); ;} + break; + + case 117: +#line 552 "Gmsh.y" + { List_Add(View->SL, &yyvsp[0].d); ;} + break; + + case 118: +#line 558 "Gmsh.y" + { List_Add(View->SL, &yyvsp[-11].d); List_Add(View->SL, &yyvsp[-5].d); List_Add(View->SL, &yyvsp[-9].d); List_Add(View->SL, &yyvsp[-3].d); List_Add(View->SL, &yyvsp[-7].d); List_Add(View->SL, &yyvsp[-1].d); ntmp = List_Nbr(View->SL); - ; - break;} -case 117: -#line 564 "Gmsh.y" -{ + ;} + break; + + case 119: +#line 565 "Gmsh.y" + { if((List_Nbr(View->SL) - ntmp) % 2) yymsg(GERROR, "Wrong number of values for scalar line " "(%d is not a multiple of 2)", List_Nbr(View->SL) - ntmp); View->NbSL++; - ; - break;} -case 118: -#line 574 "Gmsh.y" -{ List_Add(View->VL, &yyvsp[0].d); ; - break;} -case 119: -#line 576 "Gmsh.y" -{ List_Add(View->VL, &yyvsp[0].d); ; - break;} -case 120: -#line 582 "Gmsh.y" -{ + ;} + break; + + case 120: +#line 575 "Gmsh.y" + { List_Add(View->VL, &yyvsp[0].d); ;} + break; + + case 121: +#line 577 "Gmsh.y" + { List_Add(View->VL, &yyvsp[0].d); ;} + break; + + case 122: +#line 583 "Gmsh.y" + { List_Add(View->VL, &yyvsp[-11].d); List_Add(View->VL, &yyvsp[-5].d); List_Add(View->VL, &yyvsp[-9].d); List_Add(View->VL, &yyvsp[-3].d); List_Add(View->VL, &yyvsp[-7].d); List_Add(View->VL, &yyvsp[-1].d); ntmp = List_Nbr(View->VL); - ; - break;} -case 121: -#line 589 "Gmsh.y" -{ + ;} + break; + + case 123: +#line 590 "Gmsh.y" + { if((List_Nbr(View->VL) - ntmp) % 6) yymsg(GERROR, "Wrong number of values for vector line " "(%d is not a multiple of 6)", List_Nbr(View->VL) - ntmp); View->NbVL++; - ; - break;} -case 122: -#line 599 "Gmsh.y" -{ List_Add(View->TL, &yyvsp[0].d); ; - break;} -case 123: -#line 601 "Gmsh.y" -{ List_Add(View->TL, &yyvsp[0].d); ; - break;} -case 124: -#line 607 "Gmsh.y" -{ + ;} + break; + + case 124: +#line 600 "Gmsh.y" + { List_Add(View->TL, &yyvsp[0].d); ;} + break; + + case 125: +#line 602 "Gmsh.y" + { List_Add(View->TL, &yyvsp[0].d); ;} + break; + + case 126: +#line 608 "Gmsh.y" + { List_Add(View->TL, &yyvsp[-11].d); List_Add(View->TL, &yyvsp[-5].d); List_Add(View->TL, &yyvsp[-9].d); List_Add(View->TL, &yyvsp[-3].d); List_Add(View->TL, &yyvsp[-7].d); List_Add(View->TL, &yyvsp[-1].d); ntmp = List_Nbr(View->TL); - ; - break;} -case 125: -#line 614 "Gmsh.y" -{ + ;} + break; + + case 127: +#line 615 "Gmsh.y" + { if((List_Nbr(View->TL) - ntmp) % 18) yymsg(GERROR, "Wrong number of values for tensor line " "(%d is not a multiple of 18)", List_Nbr(View->TL) - ntmp); View->NbTL++; - ; - break;} -case 126: -#line 624 "Gmsh.y" -{ List_Add(View->ST, &yyvsp[0].d); ; - break;} -case 127: -#line 626 "Gmsh.y" -{ List_Add(View->ST, &yyvsp[0].d); ; - break;} -case 128: -#line 633 "Gmsh.y" -{ + ;} + break; + + case 128: +#line 625 "Gmsh.y" + { List_Add(View->ST, &yyvsp[0].d); ;} + break; + + case 129: +#line 627 "Gmsh.y" + { List_Add(View->ST, &yyvsp[0].d); ;} + break; + + case 130: +#line 634 "Gmsh.y" + { List_Add(View->ST, &yyvsp[-17].d); List_Add(View->ST, &yyvsp[-11].d); List_Add(View->ST, &yyvsp[-5].d); List_Add(View->ST, &yyvsp[-15].d); List_Add(View->ST, &yyvsp[-9].d); @@ -5210,28 +6170,32 @@ case 128: List_Add(View->ST, &yyvsp[-13].d); List_Add(View->ST, &yyvsp[-7].d); List_Add(View->ST, &yyvsp[-1].d); ntmp = List_Nbr(View->ST); - ; - break;} -case 129: -#line 643 "Gmsh.y" -{ + ;} + break; + + case 131: +#line 644 "Gmsh.y" + { if((List_Nbr(View->ST) - ntmp) % 3) yymsg(GERROR, "Wrong number of values for scalar triangle " "(%d is not a multiple of 3)", List_Nbr(View->ST) - ntmp); View->NbST++; - ; - break;} -case 130: -#line 653 "Gmsh.y" -{ List_Add(View->VT, &yyvsp[0].d); ; - break;} -case 131: -#line 655 "Gmsh.y" -{ List_Add(View->VT, &yyvsp[0].d); ; - break;} -case 132: -#line 662 "Gmsh.y" -{ + ;} + break; + + case 132: +#line 654 "Gmsh.y" + { List_Add(View->VT, &yyvsp[0].d); ;} + break; + + case 133: +#line 656 "Gmsh.y" + { List_Add(View->VT, &yyvsp[0].d); ;} + break; + + case 134: +#line 663 "Gmsh.y" + { List_Add(View->VT, &yyvsp[-17].d); List_Add(View->VT, &yyvsp[-11].d); List_Add(View->VT, &yyvsp[-5].d); List_Add(View->VT, &yyvsp[-15].d); List_Add(View->VT, &yyvsp[-9].d); @@ -5239,28 +6203,32 @@ case 132: List_Add(View->VT, &yyvsp[-13].d); List_Add(View->VT, &yyvsp[-7].d); List_Add(View->VT, &yyvsp[-1].d); ntmp = List_Nbr(View->VT); - ; - break;} -case 133: -#line 672 "Gmsh.y" -{ + ;} + break; + + case 135: +#line 673 "Gmsh.y" + { if((List_Nbr(View->VT) - ntmp) % 9) yymsg(GERROR, "Wrong number of values for vector triangle " "(%d is not a multiple of 9)", List_Nbr(View->VT) - ntmp); View->NbVT++; - ; - break;} -case 134: -#line 682 "Gmsh.y" -{ List_Add(View->TT, &yyvsp[0].d); ; - break;} -case 135: -#line 684 "Gmsh.y" -{ List_Add(View->TT, &yyvsp[0].d); ; - break;} -case 136: -#line 691 "Gmsh.y" -{ + ;} + break; + + case 136: +#line 683 "Gmsh.y" + { List_Add(View->TT, &yyvsp[0].d); ;} + break; + + case 137: +#line 685 "Gmsh.y" + { List_Add(View->TT, &yyvsp[0].d); ;} + break; + + case 138: +#line 692 "Gmsh.y" + { List_Add(View->TT, &yyvsp[-17].d); List_Add(View->TT, &yyvsp[-11].d); List_Add(View->TT, &yyvsp[-5].d); List_Add(View->TT, &yyvsp[-15].d); List_Add(View->TT, &yyvsp[-9].d); @@ -5268,28 +6236,32 @@ case 136: List_Add(View->TT, &yyvsp[-13].d); List_Add(View->TT, &yyvsp[-7].d); List_Add(View->TT, &yyvsp[-1].d); ntmp = List_Nbr(View->TT); - ; - break;} -case 137: -#line 701 "Gmsh.y" -{ + ;} + break; + + case 139: +#line 702 "Gmsh.y" + { if((List_Nbr(View->TT) - ntmp) % 27) yymsg(GERROR, "Wrong number of values for tensor triangle " "(%d is not a multiple of 27)", List_Nbr(View->TT) - ntmp); View->NbTT++; - ; - break;} -case 138: -#line 711 "Gmsh.y" -{ List_Add(View->SQ, &yyvsp[0].d); ; - break;} -case 139: -#line 713 "Gmsh.y" -{ List_Add(View->SQ, &yyvsp[0].d); ; - break;} -case 140: -#line 721 "Gmsh.y" -{ + ;} + break; + + case 140: +#line 712 "Gmsh.y" + { List_Add(View->SQ, &yyvsp[0].d); ;} + break; + + case 141: +#line 714 "Gmsh.y" + { List_Add(View->SQ, &yyvsp[0].d); ;} + break; + + case 142: +#line 722 "Gmsh.y" + { List_Add(View->SQ, &yyvsp[-23].d); List_Add(View->SQ, &yyvsp[-17].d); List_Add(View->SQ, &yyvsp[-11].d); List_Add(View->SQ, &yyvsp[-5].d); List_Add(View->SQ, &yyvsp[-21].d); List_Add(View->SQ, &yyvsp[-15].d); @@ -5297,28 +6269,32 @@ case 140: List_Add(View->SQ, &yyvsp[-19].d); List_Add(View->SQ, &yyvsp[-13].d); List_Add(View->SQ, &yyvsp[-7].d); List_Add(View->SQ, &yyvsp[-1].d); ntmp = List_Nbr(View->SQ); - ; - break;} -case 141: -#line 731 "Gmsh.y" -{ + ;} + break; + + case 143: +#line 732 "Gmsh.y" + { if((List_Nbr(View->SQ) - ntmp) % 4) yymsg(GERROR, "Wrong number of values for scalar quadrangle " "(%d is not a multiple of 4)", List_Nbr(View->SQ) - ntmp); View->NbSQ++; - ; - break;} -case 142: -#line 741 "Gmsh.y" -{ List_Add(View->VQ, &yyvsp[0].d); ; - break;} -case 143: -#line 743 "Gmsh.y" -{ List_Add(View->VQ, &yyvsp[0].d); ; - break;} -case 144: -#line 751 "Gmsh.y" -{ + ;} + break; + + case 144: +#line 742 "Gmsh.y" + { List_Add(View->VQ, &yyvsp[0].d); ;} + break; + + case 145: +#line 744 "Gmsh.y" + { List_Add(View->VQ, &yyvsp[0].d); ;} + break; + + case 146: +#line 752 "Gmsh.y" + { List_Add(View->VQ, &yyvsp[-23].d); List_Add(View->VQ, &yyvsp[-17].d); List_Add(View->VQ, &yyvsp[-11].d); List_Add(View->VQ, &yyvsp[-5].d); List_Add(View->VQ, &yyvsp[-21].d); List_Add(View->VQ, &yyvsp[-15].d); @@ -5326,28 +6302,32 @@ case 144: List_Add(View->VQ, &yyvsp[-19].d); List_Add(View->VQ, &yyvsp[-13].d); List_Add(View->VQ, &yyvsp[-7].d); List_Add(View->VQ, &yyvsp[-1].d); ntmp = List_Nbr(View->VQ); - ; - break;} -case 145: -#line 761 "Gmsh.y" -{ + ;} + break; + + case 147: +#line 762 "Gmsh.y" + { if((List_Nbr(View->VQ) - ntmp) % 12) yymsg(GERROR, "Wrong number of values for vector quadrangle " "(%d is not a multiple of 12)", List_Nbr(View->VQ) - ntmp); View->NbVQ++; - ; - break;} -case 146: -#line 771 "Gmsh.y" -{ List_Add(View->TQ, &yyvsp[0].d); ; - break;} -case 147: -#line 773 "Gmsh.y" -{ List_Add(View->TQ, &yyvsp[0].d); ; - break;} -case 148: -#line 781 "Gmsh.y" -{ + ;} + break; + + case 148: +#line 772 "Gmsh.y" + { List_Add(View->TQ, &yyvsp[0].d); ;} + break; + + case 149: +#line 774 "Gmsh.y" + { List_Add(View->TQ, &yyvsp[0].d); ;} + break; + + case 150: +#line 782 "Gmsh.y" + { List_Add(View->TQ, &yyvsp[-23].d); List_Add(View->TQ, &yyvsp[-17].d); List_Add(View->TQ, &yyvsp[-11].d); List_Add(View->TQ, &yyvsp[-5].d); List_Add(View->TQ, &yyvsp[-21].d); List_Add(View->TQ, &yyvsp[-15].d); @@ -5355,28 +6335,32 @@ case 148: List_Add(View->TQ, &yyvsp[-19].d); List_Add(View->TQ, &yyvsp[-13].d); List_Add(View->TQ, &yyvsp[-7].d); List_Add(View->TQ, &yyvsp[-1].d); ntmp = List_Nbr(View->TQ); - ; - break;} -case 149: -#line 791 "Gmsh.y" -{ + ;} + break; + + case 151: +#line 792 "Gmsh.y" + { if((List_Nbr(View->TQ) - ntmp) % 36) yymsg(GERROR, "Wrong number of values for tensor quadrangle " "(%d is not a multiple of 36)", List_Nbr(View->TQ) - ntmp); View->NbTQ++; - ; - break;} -case 150: -#line 801 "Gmsh.y" -{ List_Add(View->SS, &yyvsp[0].d); ; - break;} -case 151: -#line 803 "Gmsh.y" -{ List_Add(View->SS, &yyvsp[0].d); ; - break;} -case 152: -#line 811 "Gmsh.y" -{ + ;} + break; + + case 152: +#line 802 "Gmsh.y" + { List_Add(View->SS, &yyvsp[0].d); ;} + break; + + case 153: +#line 804 "Gmsh.y" + { List_Add(View->SS, &yyvsp[0].d); ;} + break; + + case 154: +#line 812 "Gmsh.y" + { List_Add(View->SS, &yyvsp[-23].d); List_Add(View->SS, &yyvsp[-17].d); List_Add(View->SS, &yyvsp[-11].d); List_Add(View->SS, &yyvsp[-5].d); List_Add(View->SS, &yyvsp[-21].d); List_Add(View->SS, &yyvsp[-15].d); @@ -5384,28 +6368,32 @@ case 152: List_Add(View->SS, &yyvsp[-19].d); List_Add(View->SS, &yyvsp[-13].d); List_Add(View->SS, &yyvsp[-7].d); List_Add(View->SS, &yyvsp[-1].d); ntmp = List_Nbr(View->SS); - ; - break;} -case 153: -#line 821 "Gmsh.y" -{ + ;} + break; + + case 155: +#line 822 "Gmsh.y" + { if((List_Nbr(View->SS) - ntmp) % 4) yymsg(GERROR, "Wrong number of values for scalar tetrahedron " "(%d is not a multiple of 4)", List_Nbr(View->SS) - ntmp); View->NbSS++; - ; - break;} -case 154: -#line 831 "Gmsh.y" -{ List_Add(View->VS, &yyvsp[0].d); ; - break;} -case 155: -#line 833 "Gmsh.y" -{ List_Add(View->VS, &yyvsp[0].d); ; - break;} -case 156: -#line 841 "Gmsh.y" -{ + ;} + break; + + case 156: +#line 832 "Gmsh.y" + { List_Add(View->VS, &yyvsp[0].d); ;} + break; + + case 157: +#line 834 "Gmsh.y" + { List_Add(View->VS, &yyvsp[0].d); ;} + break; + + case 158: +#line 842 "Gmsh.y" + { List_Add(View->VS, &yyvsp[-23].d); List_Add(View->VS, &yyvsp[-17].d); List_Add(View->VS, &yyvsp[-11].d); List_Add(View->VS, &yyvsp[-5].d); List_Add(View->VS, &yyvsp[-21].d); List_Add(View->VS, &yyvsp[-15].d); @@ -5413,28 +6401,32 @@ case 156: List_Add(View->VS, &yyvsp[-19].d); List_Add(View->VS, &yyvsp[-13].d); List_Add(View->VS, &yyvsp[-7].d); List_Add(View->VS, &yyvsp[-1].d); ntmp = List_Nbr(View->VS); - ; - break;} -case 157: -#line 851 "Gmsh.y" -{ + ;} + break; + + case 159: +#line 852 "Gmsh.y" + { if((List_Nbr(View->VS) - ntmp) % 12) yymsg(GERROR, "Wrong number of values for vector tetrahedron " "(%d is not a multiple of 12)", List_Nbr(View->VS) - ntmp); View->NbVS++; - ; - break;} -case 158: -#line 861 "Gmsh.y" -{ List_Add(View->TS, &yyvsp[0].d); ; - break;} -case 159: -#line 863 "Gmsh.y" -{ List_Add(View->TS, &yyvsp[0].d); ; - break;} -case 160: -#line 871 "Gmsh.y" -{ + ;} + break; + + case 160: +#line 862 "Gmsh.y" + { List_Add(View->TS, &yyvsp[0].d); ;} + break; + + case 161: +#line 864 "Gmsh.y" + { List_Add(View->TS, &yyvsp[0].d); ;} + break; + + case 162: +#line 872 "Gmsh.y" + { List_Add(View->TS, &yyvsp[-23].d); List_Add(View->TS, &yyvsp[-17].d); List_Add(View->TS, &yyvsp[-11].d); List_Add(View->TS, &yyvsp[-5].d); List_Add(View->TS, &yyvsp[-21].d); List_Add(View->TS, &yyvsp[-15].d); @@ -5442,28 +6434,32 @@ case 160: List_Add(View->TS, &yyvsp[-19].d); List_Add(View->TS, &yyvsp[-13].d); List_Add(View->TS, &yyvsp[-7].d); List_Add(View->TS, &yyvsp[-1].d); ntmp = List_Nbr(View->TS); - ; - break;} -case 161: -#line 881 "Gmsh.y" -{ + ;} + break; + + case 163: +#line 882 "Gmsh.y" + { if((List_Nbr(View->TS) - ntmp) % 36) yymsg(GERROR, "Wrong number of values for tensor tetrahedron " "(%d is not a multiple of 36)", List_Nbr(View->TS) - ntmp); View->NbTS++; - ; - break;} -case 162: -#line 891 "Gmsh.y" -{ List_Add(View->SH, &yyvsp[0].d); ; - break;} -case 163: -#line 893 "Gmsh.y" -{ List_Add(View->SH, &yyvsp[0].d); ; - break;} -case 164: -#line 905 "Gmsh.y" -{ + ;} + break; + + case 164: +#line 892 "Gmsh.y" + { List_Add(View->SH, &yyvsp[0].d); ;} + break; + + case 165: +#line 894 "Gmsh.y" + { List_Add(View->SH, &yyvsp[0].d); ;} + break; + + case 166: +#line 906 "Gmsh.y" + { List_Add(View->SH, &yyvsp[-47].d); List_Add(View->SH, &yyvsp[-41].d); List_Add(View->SH, &yyvsp[-35].d); List_Add(View->SH, &yyvsp[-29].d); List_Add(View->SH, &yyvsp[-23].d); List_Add(View->SH, &yyvsp[-17].d); @@ -5477,28 +6473,32 @@ case 164: List_Add(View->SH, &yyvsp[-19].d); List_Add(View->SH, &yyvsp[-13].d); List_Add(View->SH, &yyvsp[-7].d); List_Add(View->SH, &yyvsp[-1].d); ntmp = List_Nbr(View->SH); - ; - break;} -case 165: -#line 921 "Gmsh.y" -{ + ;} + break; + + case 167: +#line 922 "Gmsh.y" + { if((List_Nbr(View->SH) - ntmp) % 8) yymsg(GERROR, "Wrong number of values for scalar hexahedron " "(%d is not a multiple of 8)", List_Nbr(View->SH) - ntmp); View->NbSH++; - ; - break;} -case 166: -#line 931 "Gmsh.y" -{ List_Add(View->VH, &yyvsp[0].d); ; - break;} -case 167: -#line 933 "Gmsh.y" -{ List_Add(View->VH, &yyvsp[0].d); ; - break;} -case 168: -#line 945 "Gmsh.y" -{ + ;} + break; + + case 168: +#line 932 "Gmsh.y" + { List_Add(View->VH, &yyvsp[0].d); ;} + break; + + case 169: +#line 934 "Gmsh.y" + { List_Add(View->VH, &yyvsp[0].d); ;} + break; + + case 170: +#line 946 "Gmsh.y" + { List_Add(View->VH, &yyvsp[-47].d); List_Add(View->VH, &yyvsp[-41].d); List_Add(View->VH, &yyvsp[-35].d); List_Add(View->VH, &yyvsp[-29].d); List_Add(View->VH, &yyvsp[-23].d); List_Add(View->VH, &yyvsp[-17].d); @@ -5512,28 +6512,32 @@ case 168: List_Add(View->VH, &yyvsp[-19].d); List_Add(View->VH, &yyvsp[-13].d); List_Add(View->VH, &yyvsp[-7].d); List_Add(View->VH, &yyvsp[-1].d); ntmp = List_Nbr(View->VH); - ; - break;} -case 169: -#line 961 "Gmsh.y" -{ + ;} + break; + + case 171: +#line 962 "Gmsh.y" + { if((List_Nbr(View->VH) - ntmp) % 24) yymsg(GERROR, "Wrong number of values for vector hexahedron " "(%d is not a multiple of 24)", List_Nbr(View->VH) - ntmp); View->NbVH++; - ; - break;} -case 170: -#line 971 "Gmsh.y" -{ List_Add(View->TH, &yyvsp[0].d); ; - break;} -case 171: -#line 973 "Gmsh.y" -{ List_Add(View->TH, &yyvsp[0].d); ; - break;} -case 172: -#line 985 "Gmsh.y" -{ + ;} + break; + + case 172: +#line 972 "Gmsh.y" + { List_Add(View->TH, &yyvsp[0].d); ;} + break; + + case 173: +#line 974 "Gmsh.y" + { List_Add(View->TH, &yyvsp[0].d); ;} + break; + + case 174: +#line 986 "Gmsh.y" + { List_Add(View->TH, &yyvsp[-47].d); List_Add(View->TH, &yyvsp[-41].d); List_Add(View->TH, &yyvsp[-35].d); List_Add(View->TH, &yyvsp[-29].d); List_Add(View->TH, &yyvsp[-23].d); List_Add(View->TH, &yyvsp[-17].d); @@ -5547,28 +6551,32 @@ case 172: List_Add(View->TH, &yyvsp[-19].d); List_Add(View->TH, &yyvsp[-13].d); List_Add(View->TH, &yyvsp[-7].d); List_Add(View->TH, &yyvsp[-1].d); ntmp = List_Nbr(View->TH); - ; - break;} -case 173: -#line 1001 "Gmsh.y" -{ + ;} + break; + + case 175: +#line 1002 "Gmsh.y" + { if((List_Nbr(View->TH) - ntmp) % 72) yymsg(GERROR, "Wrong number of values for tensor hexahedron " "(%d is not a multiple of 72)", List_Nbr(View->TH) - ntmp); View->NbTH++; - ; - break;} -case 174: -#line 1011 "Gmsh.y" -{ List_Add(View->SI, &yyvsp[0].d); ; - break;} -case 175: -#line 1013 "Gmsh.y" -{ List_Add(View->SI, &yyvsp[0].d); ; - break;} -case 176: -#line 1023 "Gmsh.y" -{ + ;} + break; + + case 176: +#line 1012 "Gmsh.y" + { List_Add(View->SI, &yyvsp[0].d); ;} + break; + + case 177: +#line 1014 "Gmsh.y" + { List_Add(View->SI, &yyvsp[0].d); ;} + break; + + case 178: +#line 1024 "Gmsh.y" + { List_Add(View->SI, &yyvsp[-35].d); List_Add(View->SI, &yyvsp[-29].d); List_Add(View->SI, &yyvsp[-23].d); List_Add(View->SI, &yyvsp[-17].d); List_Add(View->SI, &yyvsp[-11].d); List_Add(View->SI, &yyvsp[-5].d); @@ -5579,28 +6587,32 @@ case 176: List_Add(View->SI, &yyvsp[-19].d); List_Add(View->SI, &yyvsp[-13].d); List_Add(View->SI, &yyvsp[-7].d); List_Add(View->SI, &yyvsp[-1].d); ntmp = List_Nbr(View->SI); - ; - break;} -case 177: -#line 1036 "Gmsh.y" -{ + ;} + break; + + case 179: +#line 1037 "Gmsh.y" + { if((List_Nbr(View->SI) - ntmp) % 6) yymsg(GERROR, "Wrong number of values for scalar prism " "(%d is not a multiple of 6)", List_Nbr(View->SI) - ntmp); View->NbSI++; - ; - break;} -case 178: -#line 1046 "Gmsh.y" -{ List_Add(View->VI, &yyvsp[0].d); ; - break;} -case 179: -#line 1048 "Gmsh.y" -{ List_Add(View->VI, &yyvsp[0].d); ; - break;} -case 180: -#line 1058 "Gmsh.y" -{ + ;} + break; + + case 180: +#line 1047 "Gmsh.y" + { List_Add(View->VI, &yyvsp[0].d); ;} + break; + + case 181: +#line 1049 "Gmsh.y" + { List_Add(View->VI, &yyvsp[0].d); ;} + break; + + case 182: +#line 1059 "Gmsh.y" + { List_Add(View->VI, &yyvsp[-35].d); List_Add(View->VI, &yyvsp[-29].d); List_Add(View->VI, &yyvsp[-23].d); List_Add(View->VI, &yyvsp[-17].d); List_Add(View->VI, &yyvsp[-11].d); List_Add(View->VI, &yyvsp[-5].d); @@ -5611,28 +6623,32 @@ case 180: List_Add(View->VI, &yyvsp[-19].d); List_Add(View->VI, &yyvsp[-13].d); List_Add(View->VI, &yyvsp[-7].d); List_Add(View->VI, &yyvsp[-1].d); ntmp = List_Nbr(View->VI); - ; - break;} -case 181: -#line 1071 "Gmsh.y" -{ + ;} + break; + + case 183: +#line 1072 "Gmsh.y" + { if((List_Nbr(View->VI) - ntmp) % 18) yymsg(GERROR, "Wrong number of values for vector prism " "(%d is not a multiple of 18)", List_Nbr(View->VI) - ntmp); View->NbVI++; - ; - break;} -case 182: -#line 1081 "Gmsh.y" -{ List_Add(View->TI, &yyvsp[0].d); ; - break;} -case 183: -#line 1083 "Gmsh.y" -{ List_Add(View->TI, &yyvsp[0].d); ; - break;} -case 184: -#line 1093 "Gmsh.y" -{ + ;} + break; + + case 184: +#line 1082 "Gmsh.y" + { List_Add(View->TI, &yyvsp[0].d); ;} + break; + + case 185: +#line 1084 "Gmsh.y" + { List_Add(View->TI, &yyvsp[0].d); ;} + break; + + case 186: +#line 1094 "Gmsh.y" + { List_Add(View->TI, &yyvsp[-35].d); List_Add(View->TI, &yyvsp[-29].d); List_Add(View->TI, &yyvsp[-23].d); List_Add(View->TI, &yyvsp[-17].d); List_Add(View->TI, &yyvsp[-11].d); List_Add(View->TI, &yyvsp[-5].d); @@ -5643,28 +6659,32 @@ case 184: List_Add(View->TI, &yyvsp[-19].d); List_Add(View->TI, &yyvsp[-13].d); List_Add(View->TI, &yyvsp[-7].d); List_Add(View->TI, &yyvsp[-1].d); ntmp = List_Nbr(View->TI); - ; - break;} -case 185: -#line 1106 "Gmsh.y" -{ + ;} + break; + + case 187: +#line 1107 "Gmsh.y" + { if((List_Nbr(View->TI) - ntmp) % 54) yymsg(GERROR, "Wrong number of values for tensor prism " "(%d is not a multiple of 54)", List_Nbr(View->TI) - ntmp); View->NbTI++; - ; - break;} -case 186: -#line 1116 "Gmsh.y" -{ List_Add(View->SY, &yyvsp[0].d); ; - break;} -case 187: -#line 1118 "Gmsh.y" -{ List_Add(View->SY, &yyvsp[0].d); ; - break;} -case 188: -#line 1127 "Gmsh.y" -{ + ;} + break; + + case 188: +#line 1117 "Gmsh.y" + { List_Add(View->SY, &yyvsp[0].d); ;} + break; + + case 189: +#line 1119 "Gmsh.y" + { List_Add(View->SY, &yyvsp[0].d); ;} + break; + + case 190: +#line 1128 "Gmsh.y" + { List_Add(View->SY, &yyvsp[-29].d); List_Add(View->SY, &yyvsp[-23].d); List_Add(View->SY, &yyvsp[-17].d); List_Add(View->SY, &yyvsp[-11].d); List_Add(View->SY, &yyvsp[-5].d); @@ -5675,28 +6695,32 @@ case 188: List_Add(View->SY, &yyvsp[-13].d); List_Add(View->SY, &yyvsp[-7].d); List_Add(View->SY, &yyvsp[-1].d); ntmp = List_Nbr(View->SY); - ; - break;} -case 189: -#line 1140 "Gmsh.y" -{ + ;} + break; + + case 191: +#line 1141 "Gmsh.y" + { if((List_Nbr(View->SY) - ntmp) % 5) yymsg(GERROR, "Wrong number of values for scalar pyramid " "(%d is not a multiple of 5)", List_Nbr(View->SY) - ntmp); View->NbSY++; - ; - break;} -case 190: -#line 1150 "Gmsh.y" -{ List_Add(View->VY, &yyvsp[0].d); ; - break;} -case 191: -#line 1152 "Gmsh.y" -{ List_Add(View->VY, &yyvsp[0].d); ; - break;} -case 192: -#line 1161 "Gmsh.y" -{ + ;} + break; + + case 192: +#line 1151 "Gmsh.y" + { List_Add(View->VY, &yyvsp[0].d); ;} + break; + + case 193: +#line 1153 "Gmsh.y" + { List_Add(View->VY, &yyvsp[0].d); ;} + break; + + case 194: +#line 1162 "Gmsh.y" + { List_Add(View->VY, &yyvsp[-29].d); List_Add(View->VY, &yyvsp[-23].d); List_Add(View->VY, &yyvsp[-17].d); List_Add(View->VY, &yyvsp[-11].d); List_Add(View->VY, &yyvsp[-5].d); @@ -5707,28 +6731,32 @@ case 192: List_Add(View->VY, &yyvsp[-13].d); List_Add(View->VY, &yyvsp[-7].d); List_Add(View->VY, &yyvsp[-1].d); ntmp = List_Nbr(View->VY); - ; - break;} -case 193: -#line 1174 "Gmsh.y" -{ + ;} + break; + + case 195: +#line 1175 "Gmsh.y" + { if((List_Nbr(View->VY) - ntmp) % 15) yymsg(GERROR, "Wrong number of values for vector pyramid " "(%d is not a multiple of 15)", List_Nbr(View->VY) - ntmp); View->NbVY++; - ; - break;} -case 194: -#line 1184 "Gmsh.y" -{ List_Add(View->TY, &yyvsp[0].d); ; - break;} -case 195: -#line 1186 "Gmsh.y" -{ List_Add(View->TY, &yyvsp[0].d); ; - break;} -case 196: -#line 1195 "Gmsh.y" -{ + ;} + break; + + case 196: +#line 1185 "Gmsh.y" + { List_Add(View->TY, &yyvsp[0].d); ;} + break; + + case 197: +#line 1187 "Gmsh.y" + { List_Add(View->TY, &yyvsp[0].d); ;} + break; + + case 198: +#line 1196 "Gmsh.y" + { List_Add(View->TY, &yyvsp[-29].d); List_Add(View->TY, &yyvsp[-23].d); List_Add(View->TY, &yyvsp[-17].d); List_Add(View->TY, &yyvsp[-11].d); List_Add(View->TY, &yyvsp[-5].d); @@ -5739,106 +6767,130 @@ case 196: List_Add(View->TY, &yyvsp[-13].d); List_Add(View->TY, &yyvsp[-7].d); List_Add(View->TY, &yyvsp[-1].d); ntmp = List_Nbr(View->TY); - ; - break;} -case 197: -#line 1208 "Gmsh.y" -{ + ;} + break; + + case 199: +#line 1209 "Gmsh.y" + { if((List_Nbr(View->TY) - ntmp) % 45) yymsg(GERROR, "Wrong number of values for tensor pyramid " "(%d is not a multiple of 45)", List_Nbr(View->TY) - ntmp); View->NbTY++; - ; - break;} -case 198: -#line 1218 "Gmsh.y" -{ + ;} + break; + + case 200: +#line 1219 "Gmsh.y" + { for(int i = 0; i < (int)strlen(yyvsp[0].c)+1; i++) List_Add(View->T2C, &yyvsp[0].c[i]); Free(yyvsp[0].c); - ; - break;} -case 199: -#line 1223 "Gmsh.y" -{ + ;} + break; + + case 201: +#line 1224 "Gmsh.y" + { for(int i = 0; i < (int)strlen(yyvsp[0].c)+1; i++) List_Add(View->T2C, &yyvsp[0].c[i]); Free(yyvsp[0].c); - ; - break;} -case 200: -#line 1231 "Gmsh.y" -{ + ;} + break; + + case 202: +#line 1232 "Gmsh.y" + { List_Add(View->T2D, &yyvsp[-5].d); List_Add(View->T2D, &yyvsp[-3].d); List_Add(View->T2D, &yyvsp[-1].d); double d = List_Nbr(View->T2C); List_Add(View->T2D, &d); - ; - break;} -case 201: -#line 1238 "Gmsh.y" -{ + ;} + break; + + case 203: +#line 1239 "Gmsh.y" + { View->NbT2++; - ; - break;} -case 202: -#line 1245 "Gmsh.y" -{ + ;} + break; + + case 204: +#line 1246 "Gmsh.y" + { for(int i = 0; i < (int)strlen(yyvsp[0].c)+1; i++) List_Add(View->T3C, &yyvsp[0].c[i]); Free(yyvsp[0].c); - ; - break;} -case 203: -#line 1250 "Gmsh.y" -{ + ;} + break; + + case 205: +#line 1251 "Gmsh.y" + { for(int i = 0; i < (int)strlen(yyvsp[0].c)+1; i++) List_Add(View->T3C, &yyvsp[0].c[i]); Free(yyvsp[0].c); - ; - break;} -case 204: -#line 1258 "Gmsh.y" -{ + ;} + break; + + case 206: +#line 1259 "Gmsh.y" + { List_Add(View->T3D, &yyvsp[-7].d); List_Add(View->T3D, &yyvsp[-5].d); List_Add(View->T3D, &yyvsp[-3].d); List_Add(View->T3D, &yyvsp[-1].d); double d = List_Nbr(View->T3C); List_Add(View->T3D, &d); - ; - break;} -case 205: -#line 1265 "Gmsh.y" -{ + ;} + break; + + case 207: +#line 1266 "Gmsh.y" + { View->NbT3++; - ; - break;} -case 206: -#line 1274 "Gmsh.y" -{ yyval.i = 0; ; - break;} -case 207: -#line 1275 "Gmsh.y" -{ yyval.i = 1; ; - break;} -case 208: -#line 1276 "Gmsh.y" -{ yyval.i = 2; ; - break;} -case 209: -#line 1277 "Gmsh.y" -{ yyval.i = 3; ; - break;} -case 210: -#line 1278 "Gmsh.y" -{ yyval.i = 4; ; - break;} -case 211: + ;} + break; + + case 208: +#line 1273 "Gmsh.y" + { + View -> adaptive = new Adaptive_Post_View ( View , yyvsp[-1].l ); + ;} + break; + + case 209: +#line 1281 "Gmsh.y" + { yyval.i = 0; ;} + break; + + case 210: #line 1282 "Gmsh.y" -{ yyval.i = 1; ; - break;} -case 212: + { yyval.i = 1; ;} + break; + + case 211: #line 1283 "Gmsh.y" -{ yyval.i = -1; ; - break;} -case 213: -#line 1291 "Gmsh.y" -{ + { yyval.i = 2; ;} + break; + + case 212: +#line 1284 "Gmsh.y" + { yyval.i = 3; ;} + break; + + case 213: +#line 1285 "Gmsh.y" + { yyval.i = 4; ;} + break; + + case 214: +#line 1289 "Gmsh.y" + { yyval.i = 1; ;} + break; + + case 215: +#line 1290 "Gmsh.y" + { yyval.i = -1; ;} + break; + + case 216: +#line 1298 "Gmsh.y" + { Symbol TheSymbol; TheSymbol.Name = yyvsp[-3].c; Symbol *pSymbol; @@ -5864,11 +6916,12 @@ case 213: break; } } - ; - break;} -case 214: -#line 1319 "Gmsh.y" -{ + ;} + break; + + case 217: +#line 1326 "Gmsh.y" + { Symbol TheSymbol; TheSymbol.Name = yyvsp[-6].c; Symbol *pSymbol; @@ -5902,11 +6955,12 @@ case 214: yymsg(GERROR, "Uninitialized variable '%s[%d]'", yyvsp[-6].c, (int)yyvsp[-4].d); } } - ; - break;} -case 215: -#line 1355 "Gmsh.y" -{ + ;} + break; + + case 218: +#line 1362 "Gmsh.y" + { if(List_Nbr(yyvsp[-5].l) != List_Nbr(yyvsp[-1].l)) yymsg(GERROR, "Incompatible array dimensions in affectation"); else{ @@ -5953,11 +7007,12 @@ case 215: } List_Delete(yyvsp[-5].l); List_Delete(yyvsp[-1].l); - ; - break;} -case 216: -#line 1404 "Gmsh.y" -{ + ;} + break; + + case 219: +#line 1411 "Gmsh.y" + { Symbol TheSymbol; TheSymbol.Name = yyvsp[-5].c; Symbol *pSymbol; @@ -5971,11 +7026,12 @@ case 216: List_Copy(yyvsp[-1].l, pSymbol->val); } List_Delete(yyvsp[-1].l); - ; - break;} -case 217: -#line 1420 "Gmsh.y" -{ + ;} + break; + + case 220: +#line 1427 "Gmsh.y" + { Symbol TheSymbol; TheSymbol.Name = yyvsp[-2].c; Symbol *pSymbol; @@ -5983,11 +7039,12 @@ case 217: yymsg(GERROR, "Unknown variable '%s'", yyvsp[-2].c); else *(double*)List_Pointer_Fast(pSymbol->val, 0) += yyvsp[-1].i; - ; - break;} -case 218: -#line 1430 "Gmsh.y" -{ + ;} + break; + + case 221: +#line 1437 "Gmsh.y" + { Symbol TheSymbol; TheSymbol.Name = yyvsp[-5].c; Symbol *pSymbol; @@ -6000,11 +7057,12 @@ case 218: else yymsg(GERROR, "Uninitialized variable '%s[%d]'", yyvsp[-5].c, (int)yyvsp[-3].d); } - ; - break;} -case 219: -#line 1448 "Gmsh.y" -{ + ;} + break; + + case 222: +#line 1455 "Gmsh.y" + { char* (*pStrOpt)(int num, int action, char *value); StringXString *pStrCat; if(!(pStrCat = Get_StringOptionCategory(yyvsp[-5].c))) @@ -6015,11 +7073,12 @@ case 219: else pStrOpt(0, GMSH_SET|GMSH_GUI, yyvsp[-1].c); } - ; - break;} -case 220: -#line 1461 "Gmsh.y" -{ + ;} + break; + + case 223: +#line 1468 "Gmsh.y" + { char* (*pStrOpt)(int num, int action, char *value); StringXString *pStrCat; if(!(pStrCat = Get_StringOptionCategory(yyvsp[-8].c))) @@ -6030,11 +7089,12 @@ case 220: else pStrOpt((int)yyvsp[-6].d, GMSH_SET|GMSH_GUI, yyvsp[-1].c); } - ; - break;} -case 221: -#line 1477 "Gmsh.y" -{ + ;} + break; + + case 224: +#line 1484 "Gmsh.y" + { double (*pNumOpt)(int num, int action, double value); StringXNumber *pNumCat; if(!(pNumCat = Get_NumberOptionCategory(yyvsp[-5].c))) @@ -6057,11 +7117,12 @@ case 221: pNumOpt(0, GMSH_SET|GMSH_GUI, d); } } - ; - break;} -case 222: -#line 1502 "Gmsh.y" -{ + ;} + break; + + case 225: +#line 1509 "Gmsh.y" + { double (*pNumOpt)(int num, int action, double value); StringXNumber *pNumCat; if(!(pNumCat = Get_NumberOptionCategory(yyvsp[-8].c))) @@ -6085,11 +7146,12 @@ case 222: pNumOpt((int)yyvsp[-6].d, GMSH_SET|GMSH_GUI, d); } } - ; - break;} -case 223: -#line 1528 "Gmsh.y" -{ + ;} + break; + + case 226: +#line 1535 "Gmsh.y" + { double (*pNumOpt)(int num, int action, double value); StringXNumber *pNumCat; if(!(pNumCat = Get_NumberOptionCategory(yyvsp[-4].c))) @@ -6100,11 +7162,12 @@ case 223: else pNumOpt(0, GMSH_SET|GMSH_GUI, pNumOpt(0, GMSH_GET, 0)+yyvsp[-1].i); } - ; - break;} -case 224: -#line 1541 "Gmsh.y" -{ + ;} + break; + + case 227: +#line 1548 "Gmsh.y" + { double (*pNumOpt)(int num, int action, double value); StringXNumber *pNumCat; if(!(pNumCat = Get_NumberOptionCategory(yyvsp[-7].c))) @@ -6115,11 +7178,12 @@ case 224: else pNumOpt((int)yyvsp[-5].d, GMSH_SET|GMSH_GUI, pNumOpt((int)yyvsp[-5].d, GMSH_GET, 0)+yyvsp[-1].i); } - ; - break;} -case 225: -#line 1557 "Gmsh.y" -{ + ;} + break; + + case 228: +#line 1564 "Gmsh.y" + { unsigned int (*pColOpt)(int num, int action, unsigned int value); StringXColor *pColCat; if(!(pColCat = Get_ColorOptionCategory(yyvsp[-7].c))) @@ -6130,11 +7194,12 @@ case 225: else pColOpt(0, GMSH_SET|GMSH_GUI, yyvsp[-1].u); } - ; - break;} -case 226: -#line 1570 "Gmsh.y" -{ + ;} + break; + + case 229: +#line 1577 "Gmsh.y" + { unsigned int (*pColOpt)(int num, int action, unsigned int value); StringXColor *pColCat; if(!(pColCat = Get_ColorOptionCategory(yyvsp[-10].c))) @@ -6145,11 +7210,12 @@ case 226: else pColOpt((int)yyvsp[-8].d, GMSH_SET|GMSH_GUI, yyvsp[-1].u); } - ; - break;} -case 227: -#line 1586 "Gmsh.y" -{ + ;} + break; + + case 230: +#line 1593 "Gmsh.y" + { GmshColorTable *ct = Get_ColorTable(0); if(!ct) yymsg(GERROR, "View[%d] does not exist", 0); @@ -6166,11 +7232,12 @@ case 227: } } List_Delete(yyvsp[-1].l); - ; - break;} -case 228: -#line 1605 "Gmsh.y" -{ + ;} + break; + + case 231: +#line 1612 "Gmsh.y" + { GmshColorTable *ct = Get_ColorTable((int)yyvsp[-6].d); if(!ct) yymsg(GERROR, "View[%d] does not exist", (int)yyvsp[-6].d); @@ -6187,33 +7254,36 @@ case 228: } } List_Delete(yyvsp[-1].l); - ; - break;} -case 229: -#line 1627 "Gmsh.y" -{ + ;} + break; + + case 232: +#line 1634 "Gmsh.y" + { try { GMSH_PluginManager::instance()->setPluginOption(yyvsp[-6].c, yyvsp[-3].c, yyvsp[-1].d); } catch (...) { yymsg(GERROR, "Unknown option '%s' or plugin '%s'", yyvsp[-3].c, yyvsp[-6].c); } - ; - break;} -case 230: -#line 1636 "Gmsh.y" -{ + ;} + break; + + case 233: +#line 1643 "Gmsh.y" + { try { GMSH_PluginManager::instance()->setPluginOption(yyvsp[-6].c, yyvsp[-3].c, yyvsp[-1].c); } catch (...) { yymsg(GERROR, "Unknown option '%s' or plugin '%s'", yyvsp[-3].c, yyvsp[-6].c); } - ; - break;} -case 231: -#line 1654 "Gmsh.y" -{ + ;} + break; + + case 234: +#line 1661 "Gmsh.y" + { int num = (int)yyvsp[-4].d; if(FindPoint(num, THEM)){ yymsg(GERROR, "Point %d already exists", num); @@ -6227,11 +7297,12 @@ case 231: } yyval.s.Type = MSH_POINT; yyval.s.Num = num; - ; - break;} -case 232: -#line 1670 "Gmsh.y" -{ + ;} + break; + + case 235: +#line 1677 "Gmsh.y" + { int num = (int)yyvsp[-4].d; if(FindPhysicalGroup(num, MSH_PHYSICAL_POINT, THEM)){ yymsg(GERROR, "Physical point %d already exists", num); @@ -6245,11 +7316,12 @@ case 232: List_Delete(yyvsp[-1].l); yyval.s.Type = MSH_PHYSICAL_POINT; yyval.s.Num = num; - ; - break;} -case 233: -#line 1686 "Gmsh.y" -{ + ;} + break; + + case 236: +#line 1693 "Gmsh.y" + { for(int i = 0; i < List_Nbr(yyvsp[-9].l); i++){ double p; List_Read(yyvsp[-9].l, i, &p); @@ -6266,11 +7338,12 @@ case 233: // dummy values yyval.s.Type = 0; yyval.s.Num = 0; - ; - break;} -case 234: -#line 1705 "Gmsh.y" -{ + ;} + break; + + case 237: +#line 1712 "Gmsh.y" + { for(int i = 0; i < List_Nbr(yyvsp[-3].l); i++){ double d; List_Read(yyvsp[-3].l, i, &d); @@ -6284,11 +7357,12 @@ case 234: // dummy values yyval.s.Type = 0; yyval.s.Num = 0; - ; - break;} -case 235: -#line 1724 "Gmsh.y" -{ + ;} + break; + + case 238: +#line 1731 "Gmsh.y" + { int num = (int)yyvsp[-4].d; if(FindCurve(num, THEM)){ yymsg(GERROR, "Curve %d already exists", num); @@ -6304,11 +7378,12 @@ case 235: List_Delete(yyvsp[-1].l); yyval.s.Type = MSH_SEGM_LINE; yyval.s.Num = num; - ; - break;} -case 236: -#line 1742 "Gmsh.y" -{ + ;} + break; + + case 239: +#line 1749 "Gmsh.y" + { int num = (int)yyvsp[-4].d; if(FindCurve(num, THEM)){ yymsg(GERROR, "Curve %d already exists", num); @@ -6324,11 +7399,12 @@ case 236: List_Delete(yyvsp[-1].l); yyval.s.Type = MSH_SEGM_SPLN; yyval.s.Num = num; - ; - break;} -case 237: -#line 1760 "Gmsh.y" -{ + ;} + break; + + case 240: +#line 1767 "Gmsh.y" + { int num = (int)yyvsp[-4].d; if(FindCurve(num, THEM)){ yymsg(GERROR, "Curve %d already exists", num); @@ -6344,11 +7420,12 @@ case 237: List_Delete(yyvsp[-1].l); yyval.s.Type = MSH_SEGM_CIRC; yyval.s.Num = num; - ; - break;} -case 238: -#line 1778 "Gmsh.y" -{ + ;} + break; + + case 241: +#line 1785 "Gmsh.y" + { int num = (int)yyvsp[-6].d; if(FindCurve(num, THEM)){ yymsg(GERROR, "Curve %d already exists", num); @@ -6372,11 +7449,12 @@ case 238: List_Delete(yyvsp[-3].l); yyval.s.Type = MSH_SEGM_CIRC; yyval.s.Num = num; - ; - break;} -case 239: -#line 1804 "Gmsh.y" -{ + ;} + break; + + case 242: +#line 1811 "Gmsh.y" + { int num = (int)yyvsp[-4].d; if(FindCurve(num, THEM)){ yymsg(GERROR, "Curve %d already exists", num); @@ -6392,11 +7470,12 @@ case 239: List_Delete(yyvsp[-1].l); yyval.s.Type = MSH_SEGM_ELLI; yyval.s.Num = num; - ; - break;} -case 240: -#line 1822 "Gmsh.y" -{ + ;} + break; + + case 243: +#line 1829 "Gmsh.y" + { int num = (int)yyvsp[-6].d; if(FindCurve(num, THEM)){ yymsg(GERROR, "Curve %d already exists", num); @@ -6420,11 +7499,12 @@ case 240: List_Delete(yyvsp[-3].l); yyval.s.Type = MSH_SEGM_ELLI; yyval.s.Num = num; - ; - break;} -case 241: -#line 1849 "Gmsh.y" -{ + ;} + break; + + case 244: +#line 1856 "Gmsh.y" + { int num = (int)yyvsp[-14].d; if(FindCurve(num, THEM)){ yymsg(GERROR, "Curve %d already exists", num); @@ -6440,11 +7520,12 @@ case 241: } yyval.s.Type = MSH_SEGM_PARAMETRIC; yyval.s.Num = num; - ; - break;} -case 242: -#line 1867 "Gmsh.y" -{ + ;} + break; + + case 245: +#line 1874 "Gmsh.y" + { int num = (int)yyvsp[-4].d; if(List_Nbr(yyvsp[-1].l) < 4){ yymsg(GERROR, "Too few control points for BSpline %d (%d < 4)", num, @@ -6466,11 +7547,12 @@ case 242: List_Delete(yyvsp[-1].l); yyval.s.Type = MSH_SEGM_BSPLN; yyval.s.Num = num; - ; - break;} -case 243: -#line 1891 "Gmsh.y" -{ + ;} + break; + + case 246: +#line 1898 "Gmsh.y" + { int num = (int)yyvsp[-4].d; if(List_Nbr(yyvsp[-1].l) < 4){ yymsg(GERROR, "Too few control points for Bezier curve %d (%d < 4)", num, @@ -6492,11 +7574,12 @@ case 243: List_Delete(yyvsp[-1].l); yyval.s.Type = MSH_SEGM_BEZIER; yyval.s.Num = num; - ; - break;} -case 244: -#line 1915 "Gmsh.y" -{ + ;} + break; + + case 247: +#line 1922 "Gmsh.y" + { int num = (int)yyvsp[-8].d; if(List_Nbr(yyvsp[-5].l) + (int)yyvsp[-1].d + 1 != List_Nbr(yyvsp[-3].l)){ yymsg(GERROR, "Wrong definition of Nurbs Curve %d: " @@ -6520,11 +7603,12 @@ case 244: List_Delete(yyvsp[-3].l); yyval.s.Type = MSH_SEGM_NURBS; yyval.s.Num = num; - ; - break;} -case 245: -#line 1941 "Gmsh.y" -{ + ;} + break; + + case 248: +#line 1948 "Gmsh.y" + { int num = (int)yyvsp[-4].d; if(FindEdgeLoop(num, THEM)){ yymsg(GERROR, "Line loop %d already exists", num); @@ -6539,11 +7623,12 @@ case 245: List_Delete(yyvsp[-1].l); yyval.s.Type = MSH_SEGM_LOOP; yyval.s.Num = num; - ; - break;} -case 246: -#line 1958 "Gmsh.y" -{ + ;} + break; + + case 249: +#line 1965 "Gmsh.y" + { for(int i = 0; i < List_Nbr(yyvsp[-9].l); i++){ double p; List_Read(yyvsp[-9].l, i, &p); @@ -6559,11 +7644,12 @@ case 246: // dummy values yyval.s.Type = 0; yyval.s.Num = 0; - ; - break;} -case 247: -#line 1976 "Gmsh.y" -{ + ;} + break; + + case 250: +#line 1983 "Gmsh.y" + { int num = (int)yyvsp[-4].d; if(FindPhysicalGroup(num, MSH_PHYSICAL_LINE, THEM)){ yymsg(GERROR, "Physical line %d already exists", num); @@ -6577,11 +7663,12 @@ case 247: List_Delete(yyvsp[-1].l); yyval.s.Type = MSH_PHYSICAL_LINE; yyval.s.Num = num; - ; - break;} -case 248: -#line 1995 "Gmsh.y" -{ + ;} + break; + + case 251: +#line 2002 "Gmsh.y" + { int num = (int)yyvsp[-4].d; if(FindSurface(num, THEM)){ yymsg(GERROR, "Surface %d already exists", num); @@ -6598,11 +7685,12 @@ case 248: List_Delete(yyvsp[-1].l); yyval.s.Type = MSH_SURF_PLAN; yyval.s.Num = num; - ; - break;} -case 249: -#line 2014 "Gmsh.y" -{ + ;} + break; + + case 252: +#line 2021 "Gmsh.y" + { int num = (int)yyvsp[-4].d, type = 0; if(FindSurface(num, THEM)){ yymsg(GERROR, "Surface %d already exists", num); @@ -6639,11 +7727,12 @@ case 249: List_Delete(yyvsp[-1].l); yyval.s.Type = type; yyval.s.Num = num; - ; - break;} -case 250: -#line 2053 "Gmsh.y" -{ + ;} + break; + + case 253: +#line 2060 "Gmsh.y" + { int num = (int)yyvsp[-8].d; Surface *support = FindSurface((int)yyvsp[-4].d, THEM); if(!support){ @@ -6666,11 +7755,12 @@ case 250: List_Delete(yyvsp[-2].l); yyval.s.Type = MSH_SURF_TRIMMED; yyval.s.Num = num; - ; - break;} -case 251: -#line 2079 "Gmsh.y" -{ + ;} + break; + + case 254: +#line 2086 "Gmsh.y" + { int num = (int)yyvsp[-10].d, type = 0; Surface *s = FindSurface(num, THEM); if(!s) { @@ -6687,11 +7777,12 @@ case 251: //List_Delete($13); yyval.s.Type = type; yyval.s.Num = (int)yyvsp[-10].d; - ; - break;} -case 252: -#line 2101 "Gmsh.y" -{ + ;} + break; + + case 255: +#line 2108 "Gmsh.y" + { int num = (int)yyvsp[-10].d, type = 0; Surface *s = FindSurface(num, THEM); if(!s) { @@ -6704,11 +7795,12 @@ case 252: } yyval.s.Type = type; yyval.s.Num = (int)yyvsp[-10].d; - ; - break;} -case 253: -#line 2118 "Gmsh.y" -{ + ;} + break; + + case 256: +#line 2125 "Gmsh.y" + { int num = (int)yyvsp[-16].d; if(FindSurface(num, THEM)){ yymsg(GERROR, "Surface %d already exists", num); @@ -6723,11 +7815,12 @@ case 253: List_Delete(yyvsp[-8].l); yyval.s.Type = MSH_SURF_NURBS; yyval.s.Num = num; - ; - break;} -case 254: -#line 2137 "Gmsh.y" -{ + ;} + break; + + case 257: +#line 2144 "Gmsh.y" + { int num = (int)yyvsp[-16].d; if(FindSurface(num, THEM)){ yymsg(GERROR, "Surface %d already exists", num); @@ -6742,11 +7835,12 @@ case 254: List_Delete(yyvsp[-8].l); yyval.s.Type = MSH_SURF_NURBS; yyval.s.Num = num; - ; - break;} -case 255: -#line 2154 "Gmsh.y" -{ + ;} + break; + + case 258: +#line 2161 "Gmsh.y" + { int num = (int)yyvsp[-4].d; if(FindSurfaceLoop(num, THEM)){ yymsg(GERROR, "Surface loop %d already exists", num); @@ -6760,11 +7854,12 @@ case 255: List_Delete(yyvsp[-1].l); yyval.s.Type = MSH_SURF_LOOP; yyval.s.Num = num; - ; - break;} -case 256: -#line 2170 "Gmsh.y" -{ + ;} + break; + + case 259: +#line 2177 "Gmsh.y" + { int num = (int)yyvsp[-4].d; if(FindPhysicalGroup(num, MSH_PHYSICAL_SURFACE, THEM)){ yymsg(GERROR, "Physical surface %d already exists", num); @@ -6778,11 +7873,12 @@ case 256: List_Delete(yyvsp[-1].l); yyval.s.Type = MSH_PHYSICAL_SURFACE; yyval.s.Num = num; - ; - break;} -case 257: -#line 2189 "Gmsh.y" -{ + ;} + break; + + case 260: +#line 2196 "Gmsh.y" + { int num = (int)yyvsp[-4].d; if(FindVolume(num, THEM)){ yymsg(GERROR, "Volume %d already exists", num); @@ -6797,11 +7893,12 @@ case 257: List_Delete(yyvsp[-1].l); yyval.s.Type = MSH_VOLUME; yyval.s.Num = num; - ; - break;} -case 258: -#line 2206 "Gmsh.y" -{ + ;} + break; + + case 261: +#line 2213 "Gmsh.y" + { int num = (int)yyvsp[-4].d; if(FindVolume(num, THEM)){ yymsg(GERROR, "Volume %d already exists", num); @@ -6816,11 +7913,12 @@ case 258: List_Delete(yyvsp[-1].l); yyval.s.Type = MSH_VOLUME; yyval.s.Num = num; - ; - break;} -case 259: -#line 2223 "Gmsh.y" -{ + ;} + break; + + case 262: +#line 2230 "Gmsh.y" + { int num = (int)yyvsp[-4].d; if(FindPhysicalGroup(num, MSH_PHYSICAL_VOLUME, THEM)){ yymsg(GERROR, "Physical volume %d already exists", num); @@ -6834,63 +7932,73 @@ case 259: List_Delete(yyvsp[-1].l); yyval.s.Type = MSH_PHYSICAL_VOLUME; yyval.s.Num = num; - ; - break;} -case 260: -#line 2244 "Gmsh.y" -{ + ;} + break; + + case 263: +#line 2251 "Gmsh.y" + { TranslateShapes(yyvsp[-3].v[0], yyvsp[-3].v[1], yyvsp[-3].v[2], yyvsp[-1].l, 1); yyval.l = yyvsp[-1].l; - ; - break;} -case 261: -#line 2249 "Gmsh.y" -{ + ;} + break; + + case 264: +#line 2256 "Gmsh.y" + { RotateShapes(yyvsp[-8].v[0], yyvsp[-8].v[1], yyvsp[-8].v[2], yyvsp[-6].v[0], yyvsp[-6].v[1], yyvsp[-6].v[2], yyvsp[-4].d, yyvsp[-1].l, 1); yyval.l = yyvsp[-1].l; - ; - break;} -case 262: -#line 2254 "Gmsh.y" -{ + ;} + break; + + case 265: +#line 2261 "Gmsh.y" + { SymmetryShapes(yyvsp[-3].v[0], yyvsp[-3].v[1], yyvsp[-3].v[2], yyvsp[-3].v[3], yyvsp[-1].l, 1); yyval.l = yyvsp[-1].l; - ; - break;} -case 263: -#line 2259 "Gmsh.y" -{ + ;} + break; + + case 266: +#line 2266 "Gmsh.y" + { DilatShapes(yyvsp[-6].v[0], yyvsp[-6].v[1], yyvsp[-6].v[2], yyvsp[-4].d, yyvsp[-1].l, 1); yyval.l = yyvsp[-1].l; - ; - break;} -case 264: -#line 2266 "Gmsh.y" -{ yyval.l = yyvsp[0].l; ; - break;} -case 265: -#line 2267 "Gmsh.y" -{ yyval.l = yyvsp[0].l; ; - break;} -case 266: -#line 2268 "Gmsh.y" -{ yyval.l = yyvsp[0].l; ; - break;} -case 267: + ;} + break; + + case 267: #line 2273 "Gmsh.y" -{ + { yyval.l = yyvsp[0].l; ;} + break; + + case 268: +#line 2274 "Gmsh.y" + { yyval.l = yyvsp[0].l; ;} + break; + + case 269: +#line 2275 "Gmsh.y" + { yyval.l = yyvsp[0].l; ;} + break; + + case 270: +#line 2280 "Gmsh.y" + { yyval.l = List_Create(3, 3, sizeof(Shape)); - ; - break;} -case 268: -#line 2277 "Gmsh.y" -{ + ;} + break; + + case 271: +#line 2284 "Gmsh.y" + { List_Add(yyval.l, &yyvsp[0].s); - ; - break;} -case 269: -#line 2281 "Gmsh.y" -{ + ;} + break; + + case 272: +#line 2288 "Gmsh.y" + { for(int i = 0; i < List_Nbr(yyvsp[-2].l); i++){ double d; List_Read(yyvsp[-2].l, i, &d); @@ -6904,11 +8012,12 @@ case 269: List_Add(yyval.l, &TheShape); } } - ; - break;} -case 270: -#line 2297 "Gmsh.y" -{ + ;} + break; + + case 273: +#line 2304 "Gmsh.y" + { for(int i = 0; i < List_Nbr(yyvsp[-2].l); i++){ double d; List_Read(yyvsp[-2].l, i, &d); @@ -6922,11 +8031,12 @@ case 270: List_Add(yyval.l, &TheShape); } } - ; - break;} -case 271: -#line 2313 "Gmsh.y" -{ + ;} + break; + + case 274: +#line 2320 "Gmsh.y" + { for(int i = 0; i < List_Nbr(yyvsp[-2].l); i++){ double d; List_Read(yyvsp[-2].l, i, &d); @@ -6940,11 +8050,12 @@ case 271: List_Add(yyval.l, &TheShape); } } - ; - break;} -case 272: -#line 2329 "Gmsh.y" -{ + ;} + break; + + case 275: +#line 2336 "Gmsh.y" + { for(int i = 0; i < List_Nbr(yyvsp[-2].l); i++){ double d; List_Read(yyvsp[-2].l, i, &d); @@ -6958,11 +8069,12 @@ case 272: List_Add(yyval.l, &TheShape); } } - ; - break;} -case 273: -#line 2350 "Gmsh.y" -{ + ;} + break; + + case 276: +#line 2357 "Gmsh.y" + { yyval.l = List_Create(3, 3, sizeof(Shape)); for(int i = 0; i < List_Nbr(yyvsp[-1].l); i++){ Shape TheShape; @@ -6973,29 +8085,32 @@ case 273: List_Add(yyval.l, &TheShape); } List_Delete(yyvsp[-1].l); - ; - break;} -case 274: -#line 2363 "Gmsh.y" -{ + ;} + break; + + case 277: +#line 2370 "Gmsh.y" + { if(!strcmp(yyvsp[-4].c, "View")) DuplicateView((int)yyvsp[-2].d, 0); yyval.l = NULL; - ; - break;} -case 275: -#line 2374 "Gmsh.y" -{ + ;} + break; + + case 278: +#line 2381 "Gmsh.y" + { for(int i = 0; i < List_Nbr(yyvsp[-1].l); i++){ Shape TheShape; List_Read(yyvsp[-1].l, i, &TheShape); DeleteShape(TheShape.Type, TheShape.Num); } List_Delete(yyvsp[-1].l); - ; - break;} -case 276: -#line 2383 "Gmsh.y" -{ + ;} + break; + + case 279: +#line 2390 "Gmsh.y" + { if(!strcmp(yyvsp[-4].c, "View")){ RemoveViewByIndex((int)yyvsp[-2].d); #if defined(HAVE_FLTK) @@ -7003,45 +8118,50 @@ case 276: UpdateViewsInGUI(); #endif } - ; - break;} -case 277: -#line 2393 "Gmsh.y" -{ + ;} + break; + + case 280: +#line 2400 "Gmsh.y" + { if(!strcmp(yyvsp[-1].c, "Meshes") || !strcmp(yyvsp[-1].c, "All")) Init_Mesh(THEM); - ; - break;} -case 278: -#line 2403 "Gmsh.y" -{ + ;} + break; + + case 281: +#line 2410 "Gmsh.y" + { for(int i = 0; i < List_Nbr(yyvsp[-1].l); i++){ Shape TheShape; List_Read(yyvsp[-1].l, i, &TheShape); ColorShape(TheShape.Type, TheShape.Num, yyvsp[-3].u); } List_Delete(yyvsp[-1].l); - ; - break;} -case 279: -#line 2417 "Gmsh.y" -{ + ;} + break; + + case 282: +#line 2424 "Gmsh.y" + { int m = (CTX.visibility_mode == 2) ? VIS_MESH : ((CTX.visibility_mode == 1) ? VIS_GEOM : VIS_GEOM|VIS_MESH); for(int i = 2; i < 6; i++) SetVisibilityByNumber(yyvsp[-1].c, i, m); - ; - break;} -case 280: -#line 2424 "Gmsh.y" -{ + ;} + break; + + case 283: +#line 2431 "Gmsh.y" + { for(int i = 2; i < 6; i++) SetVisibilityByNumber(yyvsp[-1].c, i, 0); - ; - break;} -case 281: -#line 2429 "Gmsh.y" -{ + ;} + break; + + case 284: +#line 2436 "Gmsh.y" + { int m = (CTX.visibility_mode == 2) ? VIS_MESH : ((CTX.visibility_mode == 1) ? VIS_GEOM : VIS_GEOM|VIS_MESH); for(int i = 0; i < List_Nbr(yyvsp[-1].l); i++){ @@ -7050,22 +8170,24 @@ case 281: VisibilityShape(TheShape.Type, TheShape.Num, m); } List_Delete(yyvsp[-1].l); - ; - break;} -case 282: -#line 2440 "Gmsh.y" -{ + ;} + break; + + case 285: +#line 2447 "Gmsh.y" + { for(int i = 0; i < List_Nbr(yyvsp[-1].l); i++){ Shape TheShape; List_Read(yyvsp[-1].l, i, &TheShape); VisibilityShape(TheShape.Type, TheShape.Num, 0); } List_Delete(yyvsp[-1].l); - ; - break;} -case 283: -#line 2454 "Gmsh.y" -{ + ;} + break; + + case 286: +#line 2461 "Gmsh.y" + { if(!strcmp(yyvsp[-2].c, "Include")){ char tmpstring[1024]; FixRelativePath(yyvsp[-1].c, tmpstring); @@ -7106,11 +8228,12 @@ case 283: else{ yymsg(GERROR, "Unknown command '%s'", yyvsp[-2].c); } - ; - break;} -case 284: -#line 2497 "Gmsh.y" -{ + ;} + break; + + case 287: +#line 2504 "Gmsh.y" + { if(!strcmp(yyvsp[-6].c, "Save") && !strcmp(yyvsp[-5].c, "View")){ Post_View *v = (Post_View *)List_Pointer_Test(CTX.post.list, (int)yyvsp[-3].d); if(v){ @@ -7122,11 +8245,12 @@ case 284: else{ yymsg(GERROR, "Unknown command '%s'", yyvsp[-6].c); } - ; - break;} -case 285: -#line 2511 "Gmsh.y" -{ + ;} + break; + + case 288: +#line 2518 "Gmsh.y" + { if(!strcmp(yyvsp[-2].c, "Sleep")){ long sleep_time = GetTime(); while(1){ @@ -7139,22 +8263,24 @@ case 285: else{ yymsg(GERROR, "Unknown command '%s'", yyvsp[-2].c); } - ; - break;} -case 286: -#line 2526 "Gmsh.y" -{ + ;} + break; + + case 289: +#line 2533 "Gmsh.y" + { try { GMSH_PluginManager::instance()->action(yyvsp[-4].c, yyvsp[-1].c, 0); } catch(...) { yymsg(GERROR, "Unknown action '%s' or plugin '%s'", yyvsp[-1].c, yyvsp[-4].c); } - ; - break;} -case 287: -#line 2535 "Gmsh.y" -{ + ;} + break; + + case 290: +#line 2542 "Gmsh.y" + { // for backward compatibility if(!strcmp(yyvsp[-1].c, "Views")) CombineViews(0, 1, CTX.post.combine_remove_orig); @@ -7162,38 +8288,43 @@ case 287: CombineViews(1, 2, CTX.post.combine_remove_orig); else yymsg(GERROR, "Unknown 'Combine' command"); - ; - break;} -case 288: -#line 2545 "Gmsh.y" -{ + ;} + break; + + case 291: +#line 2552 "Gmsh.y" + { exit(0); - ; - break;} -case 289: -#line 2549 "Gmsh.y" -{ + ;} + break; + + case 292: +#line 2556 "Gmsh.y" + { SetBoundingBox(); - ; - break;} -case 290: -#line 2553 "Gmsh.y" -{ + ;} + break; + + case 293: +#line 2560 "Gmsh.y" + { SetBoundingBox(yyvsp[-12].d, yyvsp[-10].d, yyvsp[-8].d, yyvsp[-6].d, yyvsp[-4].d, yyvsp[-2].d); - ; - break;} -case 291: -#line 2557 "Gmsh.y" -{ + ;} + break; + + case 294: +#line 2564 "Gmsh.y" + { #if defined(HAVE_FLTK) if(!CTX.batch) // we're in interactive mode Draw(); #endif - ; - break;} -case 292: -#line 2570 "Gmsh.y" -{ + ;} + break; + + case 295: +#line 2577 "Gmsh.y" + { LoopControlVariablesTab[ImbricatedLoop][0] = yyvsp[-3].d; LoopControlVariablesTab[ImbricatedLoop][1] = yyvsp[-1].d; LoopControlVariablesTab[ImbricatedLoop][2] = 1.0; @@ -7205,11 +8336,12 @@ case 292: yymsg(GERROR, "Reached maximum number of imbricated loops"); ImbricatedLoop = MAX_RECUR_LOOPS-1; } - ; - break;} -case 293: -#line 2584 "Gmsh.y" -{ + ;} + break; + + case 296: +#line 2591 "Gmsh.y" + { LoopControlVariablesTab[ImbricatedLoop][0] = yyvsp[-5].d; LoopControlVariablesTab[ImbricatedLoop][1] = yyvsp[-3].d; LoopControlVariablesTab[ImbricatedLoop][2] = yyvsp[-1].d; @@ -7221,11 +8353,12 @@ case 293: yymsg(GERROR, "Reached maximum number of imbricated loops"); ImbricatedLoop = MAX_RECUR_LOOPS-1; } - ; - break;} -case 294: -#line 2598 "Gmsh.y" -{ + ;} + break; + + case 297: +#line 2605 "Gmsh.y" + { LoopControlVariablesTab[ImbricatedLoop][0] = yyvsp[-3].d; LoopControlVariablesTab[ImbricatedLoop][1] = yyvsp[-1].d; LoopControlVariablesTab[ImbricatedLoop][2] = 1.0; @@ -7248,11 +8381,12 @@ case 294: yymsg(GERROR, "Reached maximum number of imbricated loops"); ImbricatedLoop = MAX_RECUR_LOOPS-1; } - ; - break;} -case 295: -#line 2623 "Gmsh.y" -{ + ;} + break; + + case 298: +#line 2630 "Gmsh.y" + { LoopControlVariablesTab[ImbricatedLoop][0] = yyvsp[-5].d; LoopControlVariablesTab[ImbricatedLoop][1] = yyvsp[-3].d; LoopControlVariablesTab[ImbricatedLoop][2] = yyvsp[-1].d; @@ -7275,11 +8409,12 @@ case 295: yymsg(GERROR, "Reached maximum number of imbricated loops"); ImbricatedLoop = MAX_RECUR_LOOPS-1; } - ; - break;} -case 296: -#line 2648 "Gmsh.y" -{ + ;} + break; + + case 299: +#line 2655 "Gmsh.y" + { if(LoopControlVariablesTab[ImbricatedLoop-1][1] > LoopControlVariablesTab[ImbricatedLoop-1][0]){ LoopControlVariablesTab[ImbricatedLoop-1][0] += @@ -7304,44 +8439,50 @@ case 296: ImbricatedLoop = 0; } } - ; - break;} -case 297: -#line 2675 "Gmsh.y" -{ + ;} + break; + + case 300: +#line 2682 "Gmsh.y" + { if(!FunctionManager::Instance()->createFunction(yyvsp[0].c, yyin, yyname, yylineno)) yymsg(GERROR, "Redefinition of function %s", yyvsp[0].c); skip_until(NULL, "Return"); - ; - break;} -case 298: -#line 2681 "Gmsh.y" -{ + ;} + break; + + case 301: +#line 2688 "Gmsh.y" + { if(!FunctionManager::Instance()->leaveFunction(&yyin, yyname, yylineno)) yymsg(GERROR, "Error while exiting function"); - ; - break;} -case 299: -#line 2686 "Gmsh.y" -{ + ;} + break; + + case 302: +#line 2693 "Gmsh.y" + { if(!FunctionManager::Instance()->enterFunction(yyvsp[-1].c, &yyin, yyname, yylineno)) yymsg(GERROR, "Unknown function %s", yyvsp[-1].c); - ; - break;} -case 300: -#line 2691 "Gmsh.y" -{ + ;} + break; + + case 303: +#line 2698 "Gmsh.y" + { if(!yyvsp[-1].d) skip_until("If", "EndIf"); - ; - break;} -case 301: -#line 2695 "Gmsh.y" -{ - ; - break;} -case 302: -#line 2706 "Gmsh.y" -{ + ;} + break; + + case 304: +#line 2702 "Gmsh.y" + { + ;} + break; + + case 305: +#line 2713 "Gmsh.y" + { Curve *pc, *prc; Shape TheShape; TheShape.Num = Extrude_ProtudePoint(TRANSLATE, (int)yyvsp[-4].d, yyvsp[-2].v[0], yyvsp[-2].v[1], yyvsp[-2].v[2], @@ -7355,11 +8496,12 @@ case 302: TheShape.Type = pc->Typ; List_Add(yyval.l, &TheShape); } - ; - break;} -case 303: -#line 2722 "Gmsh.y" -{ + ;} + break; + + case 306: +#line 2729 "Gmsh.y" + { Curve *pc, *prc; Shape TheShape; TheShape.Num = Extrude_ProtudePoint(ROTATE, (int)yyvsp[-8].d, 0., 0., 0., @@ -7373,11 +8515,12 @@ case 303: TheShape.Type = pc->Typ; List_Add(yyval.l, &TheShape); } - ; - break;} -case 304: -#line 2738 "Gmsh.y" -{ + ;} + break; + + case 307: +#line 2745 "Gmsh.y" + { Curve *pc, *prc; Shape TheShape; TheShape.Num = Extrude_ProtudePoint(TRANSLATE_ROTATE, (int)yyvsp[-10].d, yyvsp[-8].v[0], yyvsp[-8].v[1], yyvsp[-8].v[2], @@ -7391,18 +8534,20 @@ case 304: TheShape.Type = pc->Typ; List_Add(yyval.l, &TheShape); } - ; - break;} -case 305: -#line 2754 "Gmsh.y" -{ + ;} + break; + + case 308: +#line 2761 "Gmsh.y" + { extr.mesh.ExtrudeMesh = false; extr.mesh.Recombine = false; - ; - break;} -case 306: -#line 2759 "Gmsh.y" -{ + ;} + break; + + case 309: +#line 2766 "Gmsh.y" + { Curve *pc, *prc; Shape TheShape; TheShape.Num = Extrude_ProtudePoint(TRANSLATE, (int)yyvsp[-8].d, yyvsp[-6].v[0], yyvsp[-6].v[1], yyvsp[-6].v[2], @@ -7416,18 +8561,20 @@ case 306: TheShape.Type = pc->Typ; List_Add(yyval.l, &TheShape); } - ; - break;} -case 307: -#line 2775 "Gmsh.y" -{ + ;} + break; + + case 310: +#line 2782 "Gmsh.y" + { extr.mesh.ExtrudeMesh = false; extr.mesh.Recombine = false; - ; - break;} -case 308: -#line 2780 "Gmsh.y" -{ + ;} + break; + + case 311: +#line 2787 "Gmsh.y" + { Curve *pc, *prc; Shape TheShape; TheShape.Num = Extrude_ProtudePoint(ROTATE, (int)yyvsp[-12].d, 0., 0., 0., @@ -7441,18 +8588,20 @@ case 308: TheShape.Type = pc->Typ; List_Add(yyval.l, &TheShape); } - ; - break;} -case 309: -#line 2796 "Gmsh.y" -{ + ;} + break; + + case 312: +#line 2803 "Gmsh.y" + { extr.mesh.ExtrudeMesh = false; extr.mesh.Recombine = false; - ; - break;} -case 310: -#line 2801 "Gmsh.y" -{ + ;} + break; + + case 313: +#line 2808 "Gmsh.y" + { Curve *pc, *prc; Shape TheShape; TheShape.Num = Extrude_ProtudePoint(TRANSLATE_ROTATE, (int)yyvsp[-14].d, yyvsp[-12].v[0], yyvsp[-12].v[1], yyvsp[-12].v[2], @@ -7466,11 +8615,12 @@ case 310: TheShape.Type = pc->Typ; List_Add(yyval.l, &TheShape); } - ; - break;} -case 311: -#line 2819 "Gmsh.y" -{ + ;} + break; + + case 314: +#line 2826 "Gmsh.y" + { Surface *ps; Shape TheShape; TheShape.Num = Extrude_ProtudeCurve(TRANSLATE, (int)yyvsp[-4].d, yyvsp[-2].v[0], yyvsp[-2].v[1], yyvsp[-2].v[2], @@ -7491,11 +8641,12 @@ case 311: TheShape.Type = ps->Typ; List_Add(yyval.l, &TheShape); } - ; - break;} -case 312: -#line 2842 "Gmsh.y" -{ + ;} + break; + + case 315: +#line 2849 "Gmsh.y" + { Surface *ps; Shape TheShape; TheShape.Num = Extrude_ProtudeCurve(ROTATE, (int)yyvsp[-8].d, 0., 0., 0., @@ -7516,11 +8667,12 @@ case 312: TheShape.Type = ps->Typ; List_Add(yyval.l, &TheShape); } - ; - break;} -case 313: -#line 2865 "Gmsh.y" -{ + ;} + break; + + case 316: +#line 2872 "Gmsh.y" + { Surface *ps; Shape TheShape; TheShape.Num = Extrude_ProtudeCurve(TRANSLATE_ROTATE, (int)yyvsp[-10].d, yyvsp[-8].v[0], yyvsp[-8].v[1], yyvsp[-8].v[2], @@ -7541,18 +8693,20 @@ case 313: TheShape.Type = ps->Typ; List_Add(yyval.l, &TheShape); } - ; - break;} -case 314: -#line 2888 "Gmsh.y" -{ + ;} + break; + + case 317: +#line 2895 "Gmsh.y" + { extr.mesh.ExtrudeMesh = false; extr.mesh.Recombine = false; - ; - break;} -case 315: -#line 2893 "Gmsh.y" -{ + ;} + break; + + case 318: +#line 2900 "Gmsh.y" + { Surface *ps; Shape TheShape; TheShape.Num = Extrude_ProtudeCurve(TRANSLATE, (int)yyvsp[-8].d, yyvsp[-6].v[0], yyvsp[-6].v[1], yyvsp[-6].v[2], @@ -7573,18 +8727,20 @@ case 315: TheShape.Type = ps->Typ; List_Add(yyval.l, &TheShape); } - ; - break;} -case 316: -#line 2916 "Gmsh.y" -{ + ;} + break; + + case 319: +#line 2923 "Gmsh.y" + { extr.mesh.ExtrudeMesh = false; extr.mesh.Recombine = false; - ; - break;} -case 317: -#line 2921 "Gmsh.y" -{ + ;} + break; + + case 320: +#line 2928 "Gmsh.y" + { Surface *ps; Shape TheShape; TheShape.Num = Extrude_ProtudeCurve(ROTATE, (int)yyvsp[-12].d, 0., 0., 0., @@ -7605,18 +8761,20 @@ case 317: TheShape.Type = ps->Typ; List_Add(yyval.l, &TheShape); } - ; - break;} -case 318: -#line 2944 "Gmsh.y" -{ + ;} + break; + + case 321: +#line 2951 "Gmsh.y" + { extr.mesh.ExtrudeMesh = false; extr.mesh.Recombine = false; - ; - break;} -case 319: -#line 2949 "Gmsh.y" -{ + ;} + break; + + case 322: +#line 2956 "Gmsh.y" + { Surface *ps; Shape TheShape; TheShape.Num = Extrude_ProtudeCurve(TRANSLATE_ROTATE, (int)yyvsp[-14].d, yyvsp[-12].v[0], yyvsp[-12].v[1], yyvsp[-12].v[2], @@ -7637,11 +8795,12 @@ case 319: TheShape.Type = ps->Typ; List_Add(yyval.l, &TheShape); } - ; - break;} -case 320: -#line 2975 "Gmsh.y" -{ + ;} + break; + + case 323: +#line 2982 "Gmsh.y" + { Volume *pv; Shape TheShape; TheShape.Num = Extrude_ProtudeSurface(TRANSLATE, (int)yyvsp[-4].d, yyvsp[-2].v[0], yyvsp[-2].v[1], yyvsp[-2].v[2], @@ -7662,11 +8821,12 @@ case 320: TheShape.Type = pv->Typ; List_Add(yyval.l, &TheShape); } - ; - break;} -case 321: -#line 2998 "Gmsh.y" -{ + ;} + break; + + case 324: +#line 3005 "Gmsh.y" + { Volume *pv; Shape TheShape; TheShape.Num = Extrude_ProtudeSurface(ROTATE, (int)yyvsp[-8].d, 0., 0., 0., @@ -7687,11 +8847,12 @@ case 321: TheShape.Type = pv->Typ; List_Add(yyval.l, &TheShape); } - ; - break;} -case 322: -#line 3021 "Gmsh.y" -{ + ;} + break; + + case 325: +#line 3028 "Gmsh.y" + { Volume *pv; Shape TheShape; TheShape.Num = Extrude_ProtudeSurface(TRANSLATE_ROTATE, (int)yyvsp[-10].d, yyvsp[-8].v[0], yyvsp[-8].v[1], yyvsp[-8].v[2], @@ -7712,18 +8873,20 @@ case 322: TheShape.Type = pv->Typ; List_Add(yyval.l, &TheShape); } - ; - break;} -case 323: -#line 3044 "Gmsh.y" -{ + ;} + break; + + case 326: +#line 3051 "Gmsh.y" + { extr.mesh.ExtrudeMesh = false; extr.mesh.Recombine = false; - ; - break;} -case 324: -#line 3049 "Gmsh.y" -{ + ;} + break; + + case 327: +#line 3056 "Gmsh.y" + { Volume *pv; Shape TheShape; TheShape.Num = Extrude_ProtudeSurface(TRANSLATE, (int)yyvsp[-8].d, yyvsp[-6].v[0], yyvsp[-6].v[1], yyvsp[-6].v[2], @@ -7744,18 +8907,20 @@ case 324: TheShape.Type = pv->Typ; List_Add(yyval.l, &TheShape); } - ; - break;} -case 325: -#line 3072 "Gmsh.y" -{ + ;} + break; + + case 328: +#line 3079 "Gmsh.y" + { extr.mesh.ExtrudeMesh = false; extr.mesh.Recombine = false; - ; - break;} -case 326: -#line 3078 "Gmsh.y" -{ + ;} + break; + + case 329: +#line 3085 "Gmsh.y" + { Volume *pv; Shape TheShape; TheShape.Num = Extrude_ProtudeSurface(ROTATE, (int)yyvsp[-12].d, 0., 0., 0., @@ -7776,18 +8941,20 @@ case 326: TheShape.Type = pv->Typ; List_Add(yyval.l, &TheShape); } - ; - break;} -case 327: -#line 3101 "Gmsh.y" -{ + ;} + break; + + case 330: +#line 3108 "Gmsh.y" + { extr.mesh.ExtrudeMesh = false; extr.mesh.Recombine = false; - ; - break;} -case 328: -#line 3107 "Gmsh.y" -{ + ;} + break; + + case 331: +#line 3114 "Gmsh.y" + { Volume *pv; Shape TheShape; TheShape.Num = Extrude_ProtudeSurface(TRANSLATE_ROTATE, (int)yyvsp[-14].d, yyvsp[-12].v[0], yyvsp[-12].v[1], yyvsp[-12].v[2], @@ -7808,21 +8975,24 @@ case 328: TheShape.Type = pv->Typ; List_Add(yyval.l, &TheShape); } - ; - break;} -case 329: -#line 3133 "Gmsh.y" -{ - ; - break;} -case 330: -#line 3136 "Gmsh.y" -{ - ; - break;} -case 331: -#line 3142 "Gmsh.y" -{ + ;} + break; + + case 332: +#line 3140 "Gmsh.y" + { + ;} + break; + + case 333: +#line 3143 "Gmsh.y" + { + ;} + break; + + case 334: +#line 3149 "Gmsh.y" + { double d; extr.mesh.ExtrudeMesh = true; extr.mesh.NbLayer = List_Nbr(yyvsp[-6].l); @@ -7846,11 +9016,12 @@ case 331: List_Delete(yyvsp[-6].l); List_Delete(yyvsp[-4].l); List_Delete(yyvsp[-2].l); - ; - break;} -case 332: -#line 3168 "Gmsh.y" -{ + ;} + break; + + case 335: +#line 3175 "Gmsh.y" + { double d; extr.mesh.ExtrudeMesh = true; extr.mesh.NbLayer = List_Nbr(yyvsp[-4].l); @@ -7872,17 +9043,19 @@ case 332: } List_Delete(yyvsp[-4].l); List_Delete(yyvsp[-2].l); - ; - break;} -case 333: -#line 3192 "Gmsh.y" -{ + ;} + break; + + case 336: +#line 3199 "Gmsh.y" + { extr.mesh.Recombine = true; - ; - break;} -case 334: -#line 3201 "Gmsh.y" -{ + ;} + break; + + case 337: +#line 3208 "Gmsh.y" + { for(int i = 0; i < List_Nbr(yyvsp[-3].l); i++){ double d; List_Read(yyvsp[-3].l, i, &d); @@ -7898,11 +9071,12 @@ case 334: } } List_Delete(yyvsp[-3].l); - ; - break;} -case 335: -#line 3219 "Gmsh.y" -{ + ;} + break; + + case 338: +#line 3226 "Gmsh.y" + { for(int i = 0; i < List_Nbr(yyvsp[-6].l); i++){ double d; List_Read(yyvsp[-6].l, i, &d); @@ -7918,11 +9092,12 @@ case 335: } } List_Delete(yyvsp[-6].l); - ; - break;} -case 336: -#line 3237 "Gmsh.y" -{ + ;} + break; + + case 339: +#line 3244 "Gmsh.y" + { for(int i = 0; i < List_Nbr(yyvsp[-6].l); i++){ double d; List_Read(yyvsp[-6].l, i, &d); @@ -7938,11 +9113,12 @@ case 336: } } List_Delete(yyvsp[-6].l); - ; - break;} -case 337: -#line 3255 "Gmsh.y" -{ + ;} + break; + + case 340: +#line 3262 "Gmsh.y" + { Surface *s = FindSurface((int)yyvsp[-4].d, THEM); if(!s) yymsg(WARNING, "Unknown surface %d", (int)yyvsp[-4].d); @@ -7967,11 +9143,12 @@ case 337: } } List_Delete(yyvsp[-1].l); - ; - break;} -case 338: -#line 3282 "Gmsh.y" -{ + ;} + break; + + case 341: +#line 3289 "Gmsh.y" + { Surface *s = FindSurface((int)yyvsp[-4].d, THEM); if(!s) yymsg(WARNING, "Unknown surface %d", (int)yyvsp[-4].d); @@ -7995,11 +9172,12 @@ case 338: } } List_Delete(yyvsp[-1].l); - ; - break;} -case 339: -#line 3308 "Gmsh.y" -{ + ;} + break; + + case 342: +#line 3315 "Gmsh.y" + { Volume *v = FindVolume((int)yyvsp[-4].d, THEM); if(!v) yymsg(WARNING, "Unknown volume %d", (int)yyvsp[-4].d); @@ -8023,11 +9201,12 @@ case 339: } } List_Delete(yyvsp[-1].l); - ; - break;} -case 340: -#line 3334 "Gmsh.y" -{ + ;} + break; + + case 343: +#line 3341 "Gmsh.y" + { for(int i = 0; i < List_Nbr(yyvsp[-3].l); i++){ double d; List_Read(yyvsp[-3].l, i, &d); @@ -8039,11 +9218,12 @@ case 340: } } List_Delete(yyvsp[-3].l); - ; - break;} -case 341: -#line 3348 "Gmsh.y" -{ + ;} + break; + + case 344: +#line 3355 "Gmsh.y" + { for(int i = 0; i < List_Nbr(yyvsp[-1].l); i++){ double d; List_Read(yyvsp[-1].l, i, &d); @@ -8054,312 +9234,386 @@ case 341: } } List_Delete(yyvsp[-1].l); - ; - break;} -case 342: -#line 3367 "Gmsh.y" -{ + ;} + break; + + case 345: +#line 3374 "Gmsh.y" + { ReplaceAllDuplicates(THEM); - ; - break;} -case 343: -#line 3371 "Gmsh.y" -{ + ;} + break; + + case 346: +#line 3378 "Gmsh.y" + { IntersectAllSegmentsTogether(); - ; - break;} -case 344: -#line 3380 "Gmsh.y" -{yyval.i = 1;; - break;} -case 345: -#line 3381 "Gmsh.y" -{yyval.i = 0;; - break;} -case 346: -#line 3382 "Gmsh.y" -{yyval.i = -1;; - break;} -case 347: -#line 3383 "Gmsh.y" -{yyval.i = -1;; - break;} -case 348: -#line 3384 "Gmsh.y" -{yyval.i = -1;; - break;} -case 349: + ;} + break; + + case 347: +#line 3387 "Gmsh.y" + {yyval.i = 1;;} + break; + + case 348: #line 3388 "Gmsh.y" -{ yyval.d = yyvsp[0].d; ; - break;} -case 350: + {yyval.i = 0;;} + break; + + case 349: #line 3389 "Gmsh.y" -{ yyval.d = yyvsp[-1].d; ; - break;} -case 351: + {yyval.i = -1;;} + break; + + case 350: #line 3390 "Gmsh.y" -{ yyval.d = -yyvsp[0].d; ; - break;} -case 352: + {yyval.i = -1;;} + break; + + case 351: #line 3391 "Gmsh.y" -{ yyval.d = yyvsp[0].d; ; - break;} -case 353: -#line 3392 "Gmsh.y" -{ yyval.d = !yyvsp[0].d; ; - break;} -case 354: -#line 3393 "Gmsh.y" -{ yyval.d = yyvsp[-2].d - yyvsp[0].d; ; - break;} -case 355: -#line 3394 "Gmsh.y" -{ yyval.d = yyvsp[-2].d + yyvsp[0].d; ; - break;} -case 356: + {yyval.i = -1;;} + break; + + case 352: #line 3395 "Gmsh.y" -{ yyval.d = yyvsp[-2].d * yyvsp[0].d; ; - break;} -case 357: + { yyval.d = yyvsp[0].d; ;} + break; + + case 353: +#line 3396 "Gmsh.y" + { yyval.d = yyvsp[-1].d; ;} + break; + + case 354: #line 3397 "Gmsh.y" -{ + { yyval.d = -yyvsp[0].d; ;} + break; + + case 355: +#line 3398 "Gmsh.y" + { yyval.d = yyvsp[0].d; ;} + break; + + case 356: +#line 3399 "Gmsh.y" + { yyval.d = !yyvsp[0].d; ;} + break; + + case 357: +#line 3400 "Gmsh.y" + { yyval.d = yyvsp[-2].d - yyvsp[0].d; ;} + break; + + case 358: +#line 3401 "Gmsh.y" + { yyval.d = yyvsp[-2].d + yyvsp[0].d; ;} + break; + + case 359: +#line 3402 "Gmsh.y" + { yyval.d = yyvsp[-2].d * yyvsp[0].d; ;} + break; + + case 360: +#line 3404 "Gmsh.y" + { if(!yyvsp[0].d) yymsg(GERROR, "Division by zero in '%g / %g'", yyvsp[-2].d, yyvsp[0].d); else yyval.d = yyvsp[-2].d / yyvsp[0].d; - ; - break;} -case 358: -#line 3403 "Gmsh.y" -{ yyval.d = (int)yyvsp[-2].d % (int)yyvsp[0].d; ; - break;} -case 359: -#line 3404 "Gmsh.y" -{ yyval.d = pow(yyvsp[-2].d, yyvsp[0].d); ; - break;} -case 360: -#line 3405 "Gmsh.y" -{ yyval.d = yyvsp[-2].d < yyvsp[0].d; ; - break;} -case 361: -#line 3406 "Gmsh.y" -{ yyval.d = yyvsp[-2].d > yyvsp[0].d; ; - break;} -case 362: -#line 3407 "Gmsh.y" -{ yyval.d = yyvsp[-2].d <= yyvsp[0].d; ; - break;} -case 363: -#line 3408 "Gmsh.y" -{ yyval.d = yyvsp[-2].d >= yyvsp[0].d; ; - break;} -case 364: -#line 3409 "Gmsh.y" -{ yyval.d = yyvsp[-2].d == yyvsp[0].d; ; - break;} -case 365: + ;} + break; + + case 361: #line 3410 "Gmsh.y" -{ yyval.d = yyvsp[-2].d != yyvsp[0].d; ; - break;} -case 366: + { yyval.d = (int)yyvsp[-2].d % (int)yyvsp[0].d; ;} + break; + + case 362: #line 3411 "Gmsh.y" -{ yyval.d = yyvsp[-2].d && yyvsp[0].d; ; - break;} -case 367: + { yyval.d = pow(yyvsp[-2].d, yyvsp[0].d); ;} + break; + + case 363: #line 3412 "Gmsh.y" -{ yyval.d = yyvsp[-2].d || yyvsp[0].d; ; - break;} -case 368: + { yyval.d = yyvsp[-2].d < yyvsp[0].d; ;} + break; + + case 364: #line 3413 "Gmsh.y" -{ yyval.d = yyvsp[-4].d? yyvsp[-2].d : yyvsp[0].d; ; - break;} -case 369: + { yyval.d = yyvsp[-2].d > yyvsp[0].d; ;} + break; + + case 365: #line 3414 "Gmsh.y" -{ yyval.d = exp(yyvsp[-1].d); ; - break;} -case 370: + { yyval.d = yyvsp[-2].d <= yyvsp[0].d; ;} + break; + + case 366: #line 3415 "Gmsh.y" -{ yyval.d = log(yyvsp[-1].d); ; - break;} -case 371: + { yyval.d = yyvsp[-2].d >= yyvsp[0].d; ;} + break; + + case 367: #line 3416 "Gmsh.y" -{ yyval.d = log10(yyvsp[-1].d); ; - break;} -case 372: + { yyval.d = yyvsp[-2].d == yyvsp[0].d; ;} + break; + + case 368: #line 3417 "Gmsh.y" -{ yyval.d = sqrt(yyvsp[-1].d); ; - break;} -case 373: + { yyval.d = yyvsp[-2].d != yyvsp[0].d; ;} + break; + + case 369: #line 3418 "Gmsh.y" -{ yyval.d = sin(yyvsp[-1].d); ; - break;} -case 374: + { yyval.d = yyvsp[-2].d && yyvsp[0].d; ;} + break; + + case 370: #line 3419 "Gmsh.y" -{ yyval.d = asin(yyvsp[-1].d); ; - break;} -case 375: + { yyval.d = yyvsp[-2].d || yyvsp[0].d; ;} + break; + + case 371: #line 3420 "Gmsh.y" -{ yyval.d = cos(yyvsp[-1].d); ; - break;} -case 376: + { yyval.d = yyvsp[-4].d? yyvsp[-2].d : yyvsp[0].d; ;} + break; + + case 372: #line 3421 "Gmsh.y" -{ yyval.d = acos(yyvsp[-1].d); ; - break;} -case 377: + { yyval.d = exp(yyvsp[-1].d); ;} + break; + + case 373: #line 3422 "Gmsh.y" -{ yyval.d = tan(yyvsp[-1].d); ; - break;} -case 378: + { yyval.d = log(yyvsp[-1].d); ;} + break; + + case 374: #line 3423 "Gmsh.y" -{ yyval.d = atan(yyvsp[-1].d); ; - break;} -case 379: + { yyval.d = log10(yyvsp[-1].d); ;} + break; + + case 375: #line 3424 "Gmsh.y" -{ yyval.d = atan2(yyvsp[-3].d, yyvsp[-1].d);; - break;} -case 380: + { yyval.d = sqrt(yyvsp[-1].d); ;} + break; + + case 376: #line 3425 "Gmsh.y" -{ yyval.d = sinh(yyvsp[-1].d); ; - break;} -case 381: + { yyval.d = sin(yyvsp[-1].d); ;} + break; + + case 377: #line 3426 "Gmsh.y" -{ yyval.d = cosh(yyvsp[-1].d); ; - break;} -case 382: + { yyval.d = asin(yyvsp[-1].d); ;} + break; + + case 378: #line 3427 "Gmsh.y" -{ yyval.d = tanh(yyvsp[-1].d); ; - break;} -case 383: + { yyval.d = cos(yyvsp[-1].d); ;} + break; + + case 379: #line 3428 "Gmsh.y" -{ yyval.d = fabs(yyvsp[-1].d); ; - break;} -case 384: + { yyval.d = acos(yyvsp[-1].d); ;} + break; + + case 380: #line 3429 "Gmsh.y" -{ yyval.d = floor(yyvsp[-1].d); ; - break;} -case 385: + { yyval.d = tan(yyvsp[-1].d); ;} + break; + + case 381: #line 3430 "Gmsh.y" -{ yyval.d = ceil(yyvsp[-1].d); ; - break;} -case 386: + { yyval.d = atan(yyvsp[-1].d); ;} + break; + + case 382: #line 3431 "Gmsh.y" -{ yyval.d = fmod(yyvsp[-3].d, yyvsp[-1].d); ; - break;} -case 387: + { yyval.d = atan2(yyvsp[-3].d, yyvsp[-1].d);;} + break; + + case 383: #line 3432 "Gmsh.y" -{ yyval.d = fmod(yyvsp[-3].d, yyvsp[-1].d); ; - break;} -case 388: + { yyval.d = sinh(yyvsp[-1].d); ;} + break; + + case 384: #line 3433 "Gmsh.y" -{ yyval.d = sqrt(yyvsp[-3].d*yyvsp[-3].d+yyvsp[-1].d*yyvsp[-1].d); ; - break;} -case 389: + { yyval.d = cosh(yyvsp[-1].d); ;} + break; + + case 385: #line 3434 "Gmsh.y" -{ yyval.d = yyvsp[-1].d*(double)rand()/(double)RAND_MAX; ; - break;} -case 390: + { yyval.d = tanh(yyvsp[-1].d); ;} + break; + + case 386: +#line 3435 "Gmsh.y" + { yyval.d = fabs(yyvsp[-1].d); ;} + break; + + case 387: #line 3436 "Gmsh.y" -{ yyval.d = exp(yyvsp[-1].d); ; - break;} -case 391: + { yyval.d = floor(yyvsp[-1].d); ;} + break; + + case 388: #line 3437 "Gmsh.y" -{ yyval.d = log(yyvsp[-1].d); ; - break;} -case 392: + { yyval.d = ceil(yyvsp[-1].d); ;} + break; + + case 389: #line 3438 "Gmsh.y" -{ yyval.d = log10(yyvsp[-1].d); ; - break;} -case 393: + { yyval.d = fmod(yyvsp[-3].d, yyvsp[-1].d); ;} + break; + + case 390: #line 3439 "Gmsh.y" -{ yyval.d = sqrt(yyvsp[-1].d); ; - break;} -case 394: + { yyval.d = fmod(yyvsp[-3].d, yyvsp[-1].d); ;} + break; + + case 391: #line 3440 "Gmsh.y" -{ yyval.d = sin(yyvsp[-1].d); ; - break;} -case 395: + { yyval.d = sqrt(yyvsp[-3].d*yyvsp[-3].d+yyvsp[-1].d*yyvsp[-1].d); ;} + break; + + case 392: #line 3441 "Gmsh.y" -{ yyval.d = asin(yyvsp[-1].d); ; - break;} -case 396: -#line 3442 "Gmsh.y" -{ yyval.d = cos(yyvsp[-1].d); ; - break;} -case 397: + { yyval.d = yyvsp[-1].d*(double)rand()/(double)RAND_MAX; ;} + break; + + case 393: #line 3443 "Gmsh.y" -{ yyval.d = acos(yyvsp[-1].d); ; - break;} -case 398: + { yyval.d = exp(yyvsp[-1].d); ;} + break; + + case 394: #line 3444 "Gmsh.y" -{ yyval.d = tan(yyvsp[-1].d); ; - break;} -case 399: + { yyval.d = log(yyvsp[-1].d); ;} + break; + + case 395: #line 3445 "Gmsh.y" -{ yyval.d = atan(yyvsp[-1].d); ; - break;} -case 400: + { yyval.d = log10(yyvsp[-1].d); ;} + break; + + case 396: #line 3446 "Gmsh.y" -{ yyval.d = atan2(yyvsp[-3].d, yyvsp[-1].d);; - break;} -case 401: + { yyval.d = sqrt(yyvsp[-1].d); ;} + break; + + case 397: #line 3447 "Gmsh.y" -{ yyval.d = sinh(yyvsp[-1].d); ; - break;} -case 402: + { yyval.d = sin(yyvsp[-1].d); ;} + break; + + case 398: #line 3448 "Gmsh.y" -{ yyval.d = cosh(yyvsp[-1].d); ; - break;} -case 403: + { yyval.d = asin(yyvsp[-1].d); ;} + break; + + case 399: #line 3449 "Gmsh.y" -{ yyval.d = tanh(yyvsp[-1].d); ; - break;} -case 404: + { yyval.d = cos(yyvsp[-1].d); ;} + break; + + case 400: #line 3450 "Gmsh.y" -{ yyval.d = fabs(yyvsp[-1].d); ; - break;} -case 405: + { yyval.d = acos(yyvsp[-1].d); ;} + break; + + case 401: #line 3451 "Gmsh.y" -{ yyval.d = floor(yyvsp[-1].d); ; - break;} -case 406: + { yyval.d = tan(yyvsp[-1].d); ;} + break; + + case 402: #line 3452 "Gmsh.y" -{ yyval.d = ceil(yyvsp[-1].d); ; - break;} -case 407: + { yyval.d = atan(yyvsp[-1].d); ;} + break; + + case 403: #line 3453 "Gmsh.y" -{ yyval.d = fmod(yyvsp[-3].d, yyvsp[-1].d); ; - break;} -case 408: + { yyval.d = atan2(yyvsp[-3].d, yyvsp[-1].d);;} + break; + + case 404: #line 3454 "Gmsh.y" -{ yyval.d = fmod(yyvsp[-3].d, yyvsp[-1].d); ; - break;} -case 409: + { yyval.d = sinh(yyvsp[-1].d); ;} + break; + + case 405: #line 3455 "Gmsh.y" -{ yyval.d = sqrt(yyvsp[-3].d*yyvsp[-3].d+yyvsp[-1].d*yyvsp[-1].d); ; - break;} -case 410: + { yyval.d = cosh(yyvsp[-1].d); ;} + break; + + case 406: #line 3456 "Gmsh.y" -{ yyval.d = yyvsp[-1].d*(double)rand()/(double)RAND_MAX; ; - break;} -case 411: -#line 3465 "Gmsh.y" -{ yyval.d = yyvsp[0].d; ; - break;} -case 412: -#line 3466 "Gmsh.y" -{ yyval.d = 3.141592653589793; ; - break;} -case 413: -#line 3467 "Gmsh.y" -{ yyval.d = ParUtil::Instance()->rank(); ; - break;} -case 414: -#line 3468 "Gmsh.y" -{ yyval.d = ParUtil::Instance()->size(); ; - break;} -case 415: + { yyval.d = tanh(yyvsp[-1].d); ;} + break; + + case 407: +#line 3457 "Gmsh.y" + { yyval.d = fabs(yyvsp[-1].d); ;} + break; + + case 408: +#line 3458 "Gmsh.y" + { yyval.d = floor(yyvsp[-1].d); ;} + break; + + case 409: +#line 3459 "Gmsh.y" + { yyval.d = ceil(yyvsp[-1].d); ;} + break; + + case 410: +#line 3460 "Gmsh.y" + { yyval.d = fmod(yyvsp[-3].d, yyvsp[-1].d); ;} + break; + + case 411: +#line 3461 "Gmsh.y" + { yyval.d = fmod(yyvsp[-3].d, yyvsp[-1].d); ;} + break; + + case 412: +#line 3462 "Gmsh.y" + { yyval.d = sqrt(yyvsp[-3].d*yyvsp[-3].d+yyvsp[-1].d*yyvsp[-1].d); ;} + break; + + case 413: +#line 3463 "Gmsh.y" + { yyval.d = yyvsp[-1].d*(double)rand()/(double)RAND_MAX; ;} + break; + + case 414: +#line 3472 "Gmsh.y" + { yyval.d = yyvsp[0].d; ;} + break; + + case 415: #line 3473 "Gmsh.y" -{ + { yyval.d = 3.141592653589793; ;} + break; + + case 416: +#line 3474 "Gmsh.y" + { yyval.d = ParUtil::Instance()->rank(); ;} + break; + + case 417: +#line 3475 "Gmsh.y" + { yyval.d = ParUtil::Instance()->size(); ;} + break; + + case 418: +#line 3480 "Gmsh.y" + { Symbol TheSymbol; TheSymbol.Name = yyvsp[0].c; Symbol *pSymbol; @@ -8369,11 +9623,12 @@ case 415: } else yyval.d = *(double*)List_Pointer_Fast(pSymbol->val, 0); - ; - break;} -case 416: -#line 3485 "Gmsh.y" -{ + ;} + break; + + case 419: +#line 3492 "Gmsh.y" + { Symbol TheSymbol; TheSymbol.Name = yyvsp[-3].c; Symbol *pSymbol; @@ -8390,11 +9645,12 @@ case 416: yyval.d = 0.; } } - ; - break;} -case 417: -#line 3504 "Gmsh.y" -{ + ;} + break; + + case 420: +#line 3511 "Gmsh.y" + { Symbol TheSymbol; TheSymbol.Name = yyvsp[-2].c; Symbol *pSymbol; @@ -8405,11 +9661,12 @@ case 417: else{ yyval.d = List_Nbr(pSymbol->val); } - ; - break;} -case 418: -#line 3517 "Gmsh.y" -{ + ;} + break; + + case 421: +#line 3524 "Gmsh.y" + { Symbol TheSymbol; TheSymbol.Name = yyvsp[-1].c; Symbol *pSymbol; @@ -8419,11 +9676,12 @@ case 418: } else yyval.d = (*(double*)List_Pointer_Fast(pSymbol->val, 0) += yyvsp[0].i); - ; - break;} -case 419: -#line 3529 "Gmsh.y" -{ + ;} + break; + + case 422: +#line 3536 "Gmsh.y" + { Symbol TheSymbol; TheSymbol.Name = yyvsp[-4].c; Symbol *pSymbol; @@ -8440,11 +9698,12 @@ case 419: yyval.d = 0.; } } - ; - break;} -case 420: -#line 3551 "Gmsh.y" -{ + ;} + break; + + case 423: +#line 3558 "Gmsh.y" + { double (*pNumOpt)(int num, int action, double value); StringXNumber *pNumCat; if(!(pNumCat = Get_NumberOptionCategory(yyvsp[-2].c))){ @@ -8459,11 +9718,12 @@ case 420: else yyval.d = pNumOpt(0, GMSH_GET, 0); } - ; - break;} -case 421: -#line 3568 "Gmsh.y" -{ + ;} + break; + + case 424: +#line 3575 "Gmsh.y" + { double (*pNumOpt)(int num, int action, double value); StringXNumber *pNumCat; if(!(pNumCat = Get_NumberOptionCategory(yyvsp[-5].c))){ @@ -8478,11 +9738,12 @@ case 421: else yyval.d = pNumOpt((int)yyvsp[-3].d, GMSH_GET, 0); } - ; - break;} -case 422: -#line 3585 "Gmsh.y" -{ + ;} + break; + + case 425: +#line 3592 "Gmsh.y" + { double (*pNumOpt)(int num, int action, double value); StringXNumber *pNumCat; if(!(pNumCat = Get_NumberOptionCategory(yyvsp[-3].c))){ @@ -8497,11 +9758,12 @@ case 422: else yyval.d = pNumOpt(0, GMSH_SET|GMSH_GUI, pNumOpt(0, GMSH_GET, 0)+yyvsp[0].i); } - ; - break;} -case 423: -#line 3602 "Gmsh.y" -{ + ;} + break; + + case 426: +#line 3609 "Gmsh.y" + { double (*pNumOpt)(int num, int action, double value); StringXNumber *pNumCat; if(!(pNumCat = Get_NumberOptionCategory(yyvsp[-6].c))){ @@ -8516,153 +9778,177 @@ case 423: else yyval.d = pNumOpt((int)yyvsp[-4].d, GMSH_SET|GMSH_GUI, pNumOpt((int)yyvsp[-4].d, GMSH_GET, 0)+yyvsp[0].i); } - ; - break;} -case 424: -#line 3622 "Gmsh.y" -{ + ;} + break; + + case 427: +#line 3629 "Gmsh.y" + { memcpy(yyval.v, yyvsp[0].v, 5*sizeof(double)); - ; - break;} -case 425: -#line 3626 "Gmsh.y" -{ + ;} + break; + + case 428: +#line 3633 "Gmsh.y" + { for(int i = 0; i < 5; i++) yyval.v[i] = -yyvsp[0].v[i]; - ; - break;} -case 426: -#line 3630 "Gmsh.y" -{ + ;} + break; + + case 429: +#line 3637 "Gmsh.y" + { for(int i = 0; i < 5; i++) yyval.v[i] = yyvsp[0].v[i]; - ; - break;} -case 427: -#line 3634 "Gmsh.y" -{ + ;} + break; + + case 430: +#line 3641 "Gmsh.y" + { for(int i = 0; i < 5; i++) yyval.v[i] = yyvsp[-2].v[i] - yyvsp[0].v[i]; - ; - break;} -case 428: -#line 3638 "Gmsh.y" -{ - for(int i = 0; i < 5; i++) yyval.v[i] = yyvsp[-2].v[i] + yyvsp[0].v[i]; - ; - break;} -case 429: + ;} + break; + + case 431: #line 3645 "Gmsh.y" -{ + { + for(int i = 0; i < 5; i++) yyval.v[i] = yyvsp[-2].v[i] + yyvsp[0].v[i]; + ;} + break; + + case 432: +#line 3652 "Gmsh.y" + { yyval.v[0] = yyvsp[-9].d; yyval.v[1] = yyvsp[-7].d; yyval.v[2] = yyvsp[-5].d; yyval.v[3] = yyvsp[-3].d; yyval.v[4] = yyvsp[-1].d; - ; - break;} -case 430: -#line 3649 "Gmsh.y" -{ + ;} + break; + + case 433: +#line 3656 "Gmsh.y" + { yyval.v[0] = yyvsp[-7].d; yyval.v[1] = yyvsp[-5].d; yyval.v[2] = yyvsp[-3].d; yyval.v[3] = yyvsp[-1].d; yyval.v[4] = 1.0; - ; - break;} -case 431: -#line 3653 "Gmsh.y" -{ - yyval.v[0] = yyvsp[-5].d; yyval.v[1] = yyvsp[-3].d; yyval.v[2] = yyvsp[-1].d; yyval.v[3] = 0.0; yyval.v[4] = 1.0; - ; - break;} -case 432: -#line 3657 "Gmsh.y" -{ + ;} + break; + + case 434: +#line 3660 "Gmsh.y" + { yyval.v[0] = yyvsp[-5].d; yyval.v[1] = yyvsp[-3].d; yyval.v[2] = yyvsp[-1].d; yyval.v[3] = 0.0; yyval.v[4] = 1.0; - ; - break;} -case 433: + ;} + break; + + case 435: #line 3664 "Gmsh.y" -{ - ; - break;} -case 434: -#line 3667 "Gmsh.y" -{ - ; - break;} -case 435: -#line 3673 "Gmsh.y" -{ - ; - break;} -case 436: -#line 3676 "Gmsh.y" -{ - ; - break;} -case 437: -#line 3682 "Gmsh.y" -{ - ; - break;} -case 438: -#line 3685 "Gmsh.y" -{ - yyval.l = yyvsp[-1].l; - ; - break;} -case 439: + { + yyval.v[0] = yyvsp[-5].d; yyval.v[1] = yyvsp[-3].d; yyval.v[2] = yyvsp[-1].d; yyval.v[3] = 0.0; yyval.v[4] = 1.0; + ;} + break; + + case 436: +#line 3671 "Gmsh.y" + { + ;} + break; + + case 437: +#line 3674 "Gmsh.y" + { + ;} + break; + + case 438: +#line 3680 "Gmsh.y" + { + ;} + break; + + case 439: +#line 3683 "Gmsh.y" + { + ;} + break; + + case 440: #line 3689 "Gmsh.y" -{ + { + ;} + break; + + case 441: +#line 3692 "Gmsh.y" + { yyval.l = yyvsp[-1].l; - ; - break;} -case 440: + ;} + break; + + case 442: #line 3696 "Gmsh.y" -{ + { + yyval.l = yyvsp[-1].l; + ;} + break; + + case 443: +#line 3703 "Gmsh.y" + { yyval.l = List_Create(2, 1, sizeof(List_T*)); List_Add(yyval.l, &(yyvsp[0].l)); - ; - break;} -case 441: -#line 3701 "Gmsh.y" -{ + ;} + break; + + case 444: +#line 3708 "Gmsh.y" + { List_Add(yyval.l, &(yyvsp[0].l)); - ; - break;} -case 442: -#line 3709 "Gmsh.y" -{ + ;} + break; + + case 445: +#line 3716 "Gmsh.y" + { yyval.l = List_Create(2, 1, sizeof(double)); List_Add(yyval.l, &(yyvsp[0].d)); - ; - break;} -case 443: -#line 3714 "Gmsh.y" -{ + ;} + break; + + case 446: +#line 3721 "Gmsh.y" + { yyval.l = yyvsp[0].l; - ; - break;} -case 444: -#line 3718 "Gmsh.y" -{ + ;} + break; + + case 447: +#line 3725 "Gmsh.y" + { yyval.l = yyvsp[-1].l; - ; - break;} -case 445: -#line 3722 "Gmsh.y" -{ + ;} + break; + + case 448: +#line 3729 "Gmsh.y" + { yyval.l = yyvsp[-1].l; double *pd; for(int i = 0; i < List_Nbr(yyval.l); i++){ pd = (double*)List_Pointer(yyval.l, i); (*pd) = - (*pd); } - ; - break;} -case 446: -#line 3734 "Gmsh.y" -{ + ;} + break; + + case 449: +#line 3741 "Gmsh.y" + { yyval.l = List_Create(2, 1, sizeof(double)); for(double d = yyvsp[-2].d; (yyvsp[-2].d < yyvsp[0].d) ? (d <= yyvsp[0].d) : (d >= yyvsp[0].d); (yyvsp[-2].d < yyvsp[0].d) ? (d += 1.) : (d -= 1.)) List_Add(yyval.l, &d); - ; - break;} -case 447: -#line 3740 "Gmsh.y" -{ + ;} + break; + + case 450: +#line 3747 "Gmsh.y" + { yyval.l = List_Create(2, 1, sizeof(double)); if(!yyvsp[0].d || (yyvsp[-4].d < yyvsp[-2].d && yyvsp[0].d < 0) || (yyvsp[-4].d > yyvsp[-2].d && yyvsp[0].d > 0)){ yymsg(GERROR, "Wrong increment in '%g:%g:%g'", yyvsp[-4].d, yyvsp[-2].d, yyvsp[0].d); @@ -8671,11 +9957,12 @@ case 447: else for(double d = yyvsp[-4].d; (yyvsp[0].d > 0) ? (d <= yyvsp[-2].d) : (d >= yyvsp[-2].d); d += yyvsp[0].d) List_Add(yyval.l, &d); - ; - break;} -case 448: -#line 3751 "Gmsh.y" -{ + ;} + break; + + case 451: +#line 3758 "Gmsh.y" + { // Returns the coordinates of a point and fills a list with it. // This allows to ensure e.g. that relative point positions are // always conserved @@ -8693,11 +9980,12 @@ case 448: List_Add(yyval.l, &v->Pos.Y); List_Add(yyval.l, &v->Pos.Z); } - ; - break;} -case 449: -#line 3771 "Gmsh.y" -{ + ;} + break; + + case 452: +#line 3778 "Gmsh.y" + { yyval.l = List_Create(List_Nbr(yyvsp[0].l), 1, sizeof(double)); for(int i = 0; i < List_Nbr(yyvsp[0].l); i++){ Shape *s = (Shape*) List_Pointer(yyvsp[0].l, i); @@ -8705,11 +9993,12 @@ case 449: List_Add(yyval.l, &d); } List_Delete(yyvsp[0].l); - ; - break;} -case 450: -#line 3781 "Gmsh.y" -{ + ;} + break; + + case 453: +#line 3788 "Gmsh.y" + { yyval.l = List_Create(List_Nbr(yyvsp[0].l), 1, sizeof(double)); for(int i = 0; i < List_Nbr(yyvsp[0].l); i++){ Shape *s = (Shape*) List_Pointer(yyvsp[0].l, i); @@ -8717,11 +10006,12 @@ case 450: List_Add(yyval.l, &d); } List_Delete(yyvsp[0].l); - ; - break;} -case 451: -#line 3791 "Gmsh.y" -{ + ;} + break; + + case 454: +#line 3798 "Gmsh.y" + { // FIXME: The syntax for this is ugly: we get double semi-colons // at the end of the line yyval.l = List_Create(List_Nbr(yyvsp[0].l), 1, sizeof(double)); @@ -8731,11 +10021,12 @@ case 451: List_Add(yyval.l, &d); } List_Delete(yyvsp[0].l); - ; - break;} -case 452: -#line 3803 "Gmsh.y" -{ + ;} + break; + + case 455: +#line 3810 "Gmsh.y" + { yyval.l = List_Create(2, 1, sizeof(double)); Symbol TheSymbol; TheSymbol.Name = yyvsp[-2].c; @@ -8749,11 +10040,12 @@ case 452: for(int i = 0; i < List_Nbr(pSymbol->val); i++) List_Add(yyval.l, (double*)List_Pointer_Fast(pSymbol->val, i)); } - ; - break;} -case 453: -#line 3819 "Gmsh.y" -{ + ;} + break; + + case 456: +#line 3826 "Gmsh.y" + { yyval.l = List_Create(2, 1, sizeof(double)); Symbol TheSymbol; TheSymbol.Name = yyvsp[-2].c; @@ -8769,11 +10061,12 @@ case 453: List_Add(yyval.l, &d); } } - ; - break;} -case 454: -#line 3837 "Gmsh.y" -{ + ;} + break; + + case 457: +#line 3844 "Gmsh.y" + { yyval.l = List_Create(2, 1, sizeof(double)); Symbol TheSymbol; TheSymbol.Name = yyvsp[-5].c; @@ -8794,11 +10087,12 @@ case 454: } } List_Delete(yyvsp[-2].l); - ; - break;} -case 455: -#line 3860 "Gmsh.y" -{ + ;} + break; + + case 458: +#line 3867 "Gmsh.y" + { yyval.l = List_Create(2, 1, sizeof(double)); Symbol TheSymbol; TheSymbol.Name = yyvsp[-5].c; @@ -8821,61 +10115,69 @@ case 455: } } List_Delete(yyvsp[-2].l); - ; - break;} -case 456: -#line 3888 "Gmsh.y" -{ + ;} + break; + + case 459: +#line 3895 "Gmsh.y" + { yyval.l = List_Create(2, 1, sizeof(double)); List_Add(yyval.l, &(yyvsp[0].d)); - ; - break;} -case 457: -#line 3893 "Gmsh.y" -{ + ;} + break; + + case 460: +#line 3900 "Gmsh.y" + { yyval.l = yyvsp[0].l; - ; - break;} -case 458: -#line 3897 "Gmsh.y" -{ + ;} + break; + + case 461: +#line 3904 "Gmsh.y" + { List_Add(yyval.l, &(yyvsp[0].d)); - ; - break;} -case 459: -#line 3901 "Gmsh.y" -{ + ;} + break; + + case 462: +#line 3908 "Gmsh.y" + { for(int i = 0; i < List_Nbr(yyvsp[0].l); i++){ double d; List_Read(yyvsp[0].l, i, &d); List_Add(yyval.l, &d); } List_Delete(yyvsp[0].l); - ; - break;} -case 460: -#line 3914 "Gmsh.y" -{ + ;} + break; + + case 463: +#line 3921 "Gmsh.y" + { yyval.u = PACK_COLOR((int)yyvsp[-7].d, (int)yyvsp[-5].d, (int)yyvsp[-3].d, (int)yyvsp[-1].d); - ; - break;} -case 461: -#line 3918 "Gmsh.y" -{ + ;} + break; + + case 464: +#line 3925 "Gmsh.y" + { yyval.u = PACK_COLOR((int)yyvsp[-5].d, (int)yyvsp[-3].d, (int)yyvsp[-1].d, 255); - ; - break;} -case 462: -#line 3930 "Gmsh.y" -{ + ;} + break; + + case 465: +#line 3937 "Gmsh.y" + { int flag; yyval.u = Get_ColorForString(ColorString, -1, yyvsp[0].c, &flag); if(flag) yymsg(GERROR, "Unknown color '%s'", yyvsp[0].c); - ; - break;} -case 463: -#line 3936 "Gmsh.y" -{ + ;} + break; + + case 466: +#line 3943 "Gmsh.y" + { unsigned int (*pColOpt)(int num, int action, unsigned int value); StringXColor *pColCat; if(!(pColCat = Get_ColorOptionCategory(yyvsp[-4].c))){ @@ -8891,17 +10193,19 @@ case 463: yyval.u = pColOpt(0, GMSH_GET, 0); } } - ; - break;} -case 464: -#line 3957 "Gmsh.y" -{ + ;} + break; + + case 467: +#line 3964 "Gmsh.y" + { yyval.l = yyvsp[-1].l; - ; - break;} -case 465: -#line 3961 "Gmsh.y" -{ + ;} + break; + + case 468: +#line 3968 "Gmsh.y" + { yyval.l = List_Create(256, 10, sizeof(unsigned int)); GmshColorTable *ct = Get_ColorTable((int)yyvsp[-3].d); if(!ct) @@ -8910,40 +10214,45 @@ case 465: for(int i = 0; i < ct->size; i++) List_Add(yyval.l, &ct->table[i]); } - ; - break;} -case 466: -#line 3975 "Gmsh.y" -{ + ;} + break; + + case 469: +#line 3982 "Gmsh.y" + { yyval.l = List_Create(256, 10, sizeof(unsigned int)); List_Add(yyval.l, &(yyvsp[0].u)); - ; - break;} -case 467: -#line 3980 "Gmsh.y" -{ - List_Add(yyval.l, &(yyvsp[0].u)); - ; - break;} -case 468: + ;} + break; + + case 470: #line 3987 "Gmsh.y" -{ + { + List_Add(yyval.l, &(yyvsp[0].u)); + ;} + break; + + case 471: +#line 3994 "Gmsh.y" + { yyval.c = yyvsp[0].c; - ; - break;} -case 469: -#line 3991 "Gmsh.y" -{ + ;} + break; + + case 472: +#line 3998 "Gmsh.y" + { yyval.c = (char *)Malloc((strlen(yyvsp[-3].c)+strlen(yyvsp[-1].c)+1)*sizeof(char)); strcpy(yyval.c, yyvsp[-3].c); strcat(yyval.c, yyvsp[-1].c); Free(yyvsp[-3].c); Free(yyvsp[-1].c); - ; - break;} -case 470: -#line 3999 "Gmsh.y" -{ + ;} + break; + + case 473: +#line 4006 "Gmsh.y" + { yyval.c = (char *)Malloc((strlen(yyvsp[-1].c)+1)*sizeof(char)); int i; for(i = strlen(yyvsp[-1].c)-1; i >= 0; i--){ @@ -8955,17 +10264,19 @@ case 470: } if(i <= 0) strcpy(yyval.c, yyvsp[-1].c); Free(yyvsp[-1].c); - ; - break;} -case 471: -#line 4013 "Gmsh.y" -{ + ;} + break; + + case 474: +#line 4020 "Gmsh.y" + { yyval.c = yyvsp[-1].c; - ; - break;} -case 472: -#line 4017 "Gmsh.y" -{ + ;} + break; + + case 475: +#line 4024 "Gmsh.y" + { char tmpstring[1024]; int i = PrintListOfDouble(yyvsp[-3].c, yyvsp[-1].l, tmpstring); if(i < 0){ @@ -8982,11 +10293,12 @@ case 472: Free(yyvsp[-3].c); } List_Delete(yyvsp[-1].l); - ; - break;} -case 473: -#line 4036 "Gmsh.y" -{ + ;} + break; + + case 476: +#line 4043 "Gmsh.y" + { char* (*pStrOpt)(int num, int action, char *value); StringXString *pStrCat; if(!(pStrCat = Get_StringOptionCategory(yyvsp[-3].c))) @@ -9000,11 +10312,12 @@ case 473: strcpy(yyval.c, str); } } - ; - break;} -case 474: -#line 4052 "Gmsh.y" -{ + ;} + break; + + case 477: +#line 4059 "Gmsh.y" + { char* (*pStrOpt)(int num, int action, char *value); StringXString *pStrCat; if(!(pStrCat = Get_StringOptionCategory(yyvsp[-6].c))) @@ -9018,231 +10331,220 @@ case 474: strcpy(yyval.c, str); } } - ; - break;} -} - /* the action file gets copied in in place of this dollarsign */ -#line 543 "/usr/share/bison.simple" + ;} + break; + + + } + +/* Line 999 of yacc.c. */ +#line 10342 "Gmsh.tab.cpp" yyvsp -= yylen; yyssp -= yylen; -#ifdef YYLSP_NEEDED - yylsp -= yylen; -#endif -#if YYDEBUG != 0 - if (yydebug) - { - short *ssp1 = yyss - 1; - fprintf (stderr, "state stack now"); - while (ssp1 != yyssp) - fprintf (stderr, " %d", *++ssp1); - fprintf (stderr, "\n"); - } -#endif + + YY_STACK_PRINT (yyss, yyssp); *++yyvsp = yyval; -#ifdef YYLSP_NEEDED - yylsp++; - if (yylen == 0) - { - yylsp->first_line = yylloc.first_line; - yylsp->first_column = yylloc.first_column; - yylsp->last_line = (yylsp-1)->last_line; - yylsp->last_column = (yylsp-1)->last_column; - yylsp->text = 0; - } - else - { - yylsp->last_line = (yylsp+yylen-1)->last_line; - yylsp->last_column = (yylsp+yylen-1)->last_column; - } -#endif - /* Now "shift" the result of the reduction. - Determine what state that goes to, - based on the state we popped back to - and the rule number reduced by. */ + /* Now `shift' the result of the reduction. Determine what state + that goes to, based on the state we popped back to and the rule + number reduced by. */ yyn = yyr1[yyn]; - yystate = yypgoto[yyn - YYNTBASE] + *yyssp; - if (yystate >= 0 && yystate <= YYLAST && yycheck[yystate] == *yyssp) + yystate = yypgoto[yyn - YYNTOKENS] + *yyssp; + if (0 <= yystate && yystate <= YYLAST && yycheck[yystate] == *yyssp) yystate = yytable[yystate]; else - yystate = yydefgoto[yyn - YYNTBASE]; + yystate = yydefgoto[yyn - YYNTOKENS]; goto yynewstate; -yyerrlab: /* here on detecting error */ - if (! yyerrstatus) - /* If not already recovering from an error, report this error. */ +/*------------------------------------. +| yyerrlab -- here on detecting error | +`------------------------------------*/ +yyerrlab: + /* If not already recovering from an error, report this error. */ + if (!yyerrstatus) { ++yynerrs; - -#ifdef YYERROR_VERBOSE +#if YYERROR_VERBOSE yyn = yypact[yystate]; - if (yyn > YYFLAG && yyn < YYLAST) + if (YYPACT_NINF < yyn && yyn < YYLAST) { - int size = 0; - char *msg; - int x, count; - - count = 0; - /* Start X at -yyn if nec to avoid negative indexes in yycheck. */ - for (x = (yyn < 0 ? -yyn : 0); - x < (sizeof(yytname) / sizeof(char *)); x++) - if (yycheck[x + yyn] == x) - size += strlen(yytname[x]) + 15, count++; - msg = (char *) malloc(size + 15); - if (msg != 0) + YYSIZE_T yysize = 0; + int yytype = YYTRANSLATE (yychar); + const char* yyprefix; + char *yymsg; + int yyx; + + /* Start YYX at -YYN if negative to avoid negative indexes in + YYCHECK. */ + int yyxbegin = yyn < 0 ? -yyn : 0; + + /* Stay within bounds of both yycheck and yytname. */ + int yychecklim = YYLAST - yyn; + int yyxend = yychecklim < YYNTOKENS ? yychecklim : YYNTOKENS; + int yycount = 0; + + yyprefix = ", expecting "; + for (yyx = yyxbegin; yyx < yyxend; ++yyx) + if (yycheck[yyx + yyn] == yyx && yyx != YYTERROR) + { + yysize += yystrlen (yyprefix) + yystrlen (yytname [yyx]); + yycount += 1; + if (yycount == 5) + { + yysize = 0; + break; + } + } + yysize += (sizeof ("syntax error, unexpected ") + + yystrlen (yytname[yytype])); + yymsg = (char *) YYSTACK_ALLOC (yysize); + if (yymsg != 0) { - strcpy(msg, "parse error"); + char *yyp = yystpcpy (yymsg, "syntax error, unexpected "); + yyp = yystpcpy (yyp, yytname[yytype]); - if (count < 5) + if (yycount < 5) { - count = 0; - for (x = (yyn < 0 ? -yyn : 0); - x < (sizeof(yytname) / sizeof(char *)); x++) - if (yycheck[x + yyn] == x) + yyprefix = ", expecting "; + for (yyx = yyxbegin; yyx < yyxend; ++yyx) + if (yycheck[yyx + yyn] == yyx && yyx != YYTERROR) { - strcat(msg, count == 0 ? ", expecting `" : " or `"); - strcat(msg, yytname[x]); - strcat(msg, "'"); - count++; + yyp = yystpcpy (yyp, yyprefix); + yyp = yystpcpy (yyp, yytname[yyx]); + yyprefix = " or "; } } - yyerror(msg); - free(msg); + yyerror (yymsg); + YYSTACK_FREE (yymsg); } else - yyerror ("parse error; also virtual memory exceeded"); + yyerror ("syntax error; also virtual memory exhausted"); } else #endif /* YYERROR_VERBOSE */ - yyerror("parse error"); + yyerror ("syntax error"); } - goto yyerrlab1; -yyerrlab1: /* here on error raised explicitly by an action */ + if (yyerrstatus == 3) { - /* if just tried and failed to reuse lookahead token after an error, discard it. */ + /* If just tried and failed to reuse lookahead token after an + error, discard it. */ - /* return failure if at end of input */ + /* Return failure if at end of input. */ if (yychar == YYEOF) - YYABORT; - -#if YYDEBUG != 0 - if (yydebug) - fprintf(stderr, "Discarding token %d (%s).\n", yychar, yytname[yychar1]); -#endif + { + /* Pop the error token. */ + YYPOPSTACK; + /* Pop the rest of the stack. */ + while (yyss < yyssp) + { + YYDSYMPRINTF ("Error: popping", yystos[*yyssp], yyvsp, yylsp); + yydestruct (yystos[*yyssp], yyvsp); + YYPOPSTACK; + } + YYABORT; + } + YYDSYMPRINTF ("Error: discarding", yytoken, &yylval, &yylloc); + yydestruct (yytoken, &yylval); yychar = YYEMPTY; - } - - /* Else will try to reuse lookahead token - after shifting the error token. */ - - yyerrstatus = 3; /* Each real token shifted decrements this */ - goto yyerrhandle; - -yyerrdefault: /* current state does not do anything special for the error token. */ + } -#if 0 - /* This is wrong; only states that explicitly want error tokens - should shift them. */ - yyn = yydefact[yystate]; /* If its default is to accept any token, ok. Otherwise pop it.*/ - if (yyn) goto yydefault; -#endif + /* Else will try to reuse lookahead token after shifting the error + token. */ + goto yyerrlab1; -yyerrpop: /* pop the current state because it cannot handle the error token */ - if (yyssp == yyss) YYABORT; - yyvsp--; - yystate = *--yyssp; -#ifdef YYLSP_NEEDED - yylsp--; -#endif +/*----------------------------------------------------. +| yyerrlab1 -- error raised explicitly by an action. | +`----------------------------------------------------*/ +yyerrlab1: + yyerrstatus = 3; /* Each real token shifted decrements this. */ -#if YYDEBUG != 0 - if (yydebug) + for (;;) { - short *ssp1 = yyss - 1; - fprintf (stderr, "Error: state stack now"); - while (ssp1 != yyssp) - fprintf (stderr, " %d", *++ssp1); - fprintf (stderr, "\n"); - } -#endif - -yyerrhandle: + yyn = yypact[yystate]; + if (yyn != YYPACT_NINF) + { + yyn += YYTERROR; + if (0 <= yyn && yyn <= YYLAST && yycheck[yyn] == YYTERROR) + { + yyn = yytable[yyn]; + if (0 < yyn) + break; + } + } - yyn = yypact[yystate]; - if (yyn == YYFLAG) - goto yyerrdefault; + /* Pop the current state because it cannot handle the error token. */ + if (yyssp == yyss) + YYABORT; - yyn += YYTERROR; - if (yyn < 0 || yyn > YYLAST || yycheck[yyn] != YYTERROR) - goto yyerrdefault; + YYDSYMPRINTF ("Error: popping", yystos[*yyssp], yyvsp, yylsp); + yydestruct (yystos[yystate], yyvsp); + yyvsp--; + yystate = *--yyssp; - yyn = yytable[yyn]; - if (yyn < 0) - { - if (yyn == YYFLAG) - goto yyerrpop; - yyn = -yyn; - goto yyreduce; + YY_STACK_PRINT (yyss, yyssp); } - else if (yyn == 0) - goto yyerrpop; if (yyn == YYFINAL) YYACCEPT; -#if YYDEBUG != 0 - if (yydebug) - fprintf(stderr, "Shifting error token, "); -#endif + YYDPRINTF ((stderr, "Shifting error token, ")); *++yyvsp = yylval; -#ifdef YYLSP_NEEDED - *++yylsp = yylloc; -#endif + yystate = yyn; goto yynewstate; - yyacceptlab: - /* YYACCEPT comes here. */ - if (yyfree_stacks) - { - free (yyss); - free (yyvs); -#ifdef YYLSP_NEEDED - free (yyls); + +/*-------------------------------------. +| yyacceptlab -- YYACCEPT comes here. | +`-------------------------------------*/ +yyacceptlab: + yyresult = 0; + goto yyreturn; + +/*-----------------------------------. +| yyabortlab -- YYABORT comes here. | +`-----------------------------------*/ +yyabortlab: + yyresult = 1; + goto yyreturn; + +#ifndef yyoverflow +/*----------------------------------------------. +| yyoverflowlab -- parser overflow comes here. | +`----------------------------------------------*/ +yyoverflowlab: + yyerror ("parser stack overflow"); + yyresult = 2; + /* Fall through. */ #endif - } - return 0; - yyabortlab: - /* YYABORT comes here. */ - if (yyfree_stacks) - { - free (yyss); - free (yyvs); -#ifdef YYLSP_NEEDED - free (yyls); +yyreturn: +#ifndef yyoverflow + if (yyss != yyssa) + YYSTACK_FREE (yyss); #endif - } - return 1; + return yyresult; } -#line 4069 "Gmsh.y" + + +#line 4076 "Gmsh.y" void DeleteSymbol(void *a, void *b){ @@ -9315,3 +10617,4 @@ void yymsg(int type, char *fmt, ...){ if(type == GERROR) yyerrorstate++; } + diff --git a/Parser/Gmsh.tab.hpp b/Parser/Gmsh.tab.hpp index 2e8693fb6be0ac9a5bedcc5e1ed4923fe60d7b40..1e5cf7e27cd7c48b5741feef39f1d4e5422730af 100644 --- a/Parser/Gmsh.tab.hpp +++ b/Parser/Gmsh.tab.hpp @@ -1,4 +1,415 @@ -typedef union { +/* A Bison parser, made by GNU Bison 1.875b. */ + +/* Skeleton parser for Yacc-like parsing with Bison, + Copyright (C) 1984, 1989, 1990, 2000, 2001, 2002, 2003 Free Software Foundation, Inc. + + This program is free software; you can redistribute it and/or modify + it under the terms of the GNU General Public License as published by + the Free Software Foundation; either version 2, or (at your option) + any later version. + + This program is distributed in the hope that it will be useful, + but WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the + GNU General Public License for more details. + + You should have received a copy of the GNU General Public License + along with this program; if not, write to the Free Software + Foundation, Inc., 59 Temple Place - Suite 330, + Boston, MA 02111-1307, USA. */ + +/* As a special exception, when this file is copied by Bison into a + Bison output file, you may use that output file without restriction. + This special exception was added by the Free Software Foundation + in version 1.24 of Bison. */ + +/* Tokens. */ +#ifndef YYTOKENTYPE +# define YYTOKENTYPE + /* Put the tokens into the symbol table, so that GDB and other debuggers + know about them. */ + enum yytokentype { + tDOUBLE = 258, + tSTRING = 259, + tBIGSTR = 260, + tEND = 261, + tAFFECT = 262, + tDOTS = 263, + tPi = 264, + tMPI_Rank = 265, + tMPI_Size = 266, + tExp = 267, + tLog = 268, + tLog10 = 269, + tSqrt = 270, + tSin = 271, + tAsin = 272, + tCos = 273, + tAcos = 274, + tTan = 275, + tRand = 276, + tAtan = 277, + tAtan2 = 278, + tSinh = 279, + tCosh = 280, + tTanh = 281, + tFabs = 282, + tFloor = 283, + tCeil = 284, + tFmod = 285, + tModulo = 286, + tHypot = 287, + tPrintf = 288, + tSprintf = 289, + tStrCat = 290, + tStrPrefix = 291, + tBoundingBox = 292, + tDraw = 293, + tPoint = 294, + tCircle = 295, + tEllipse = 296, + tLine = 297, + tSurface = 298, + tSpline = 299, + tVolume = 300, + tCharacteristic = 301, + tLength = 302, + tParametric = 303, + tElliptic = 304, + tPlane = 305, + tRuled = 306, + tTriangulation = 307, + tTransfinite = 308, + tComplex = 309, + tPhysical = 310, + tUsing = 311, + tBump = 312, + tProgression = 313, + tPlugin = 314, + tRotate = 315, + tTranslate = 316, + tSymmetry = 317, + tDilate = 318, + tExtrude = 319, + tDuplicata = 320, + tLoop = 321, + tRecombine = 322, + tDelete = 323, + tCoherence = 324, + tIntersect = 325, + tAttractor = 326, + tLayers = 327, + tScalarPoint = 328, + tVectorPoint = 329, + tTensorPoint = 330, + tScalarLine = 331, + tVectorLine = 332, + tTensorLine = 333, + tScalarTriangle = 334, + tVectorTriangle = 335, + tTensorTriangle = 336, + tScalarQuadrangle = 337, + tVectorQuadrangle = 338, + tTensorQuadrangle = 339, + tScalarTetrahedron = 340, + tVectorTetrahedron = 341, + tTensorTetrahedron = 342, + tScalarHexahedron = 343, + tVectorHexahedron = 344, + tTensorHexahedron = 345, + tScalarPrism = 346, + tVectorPrism = 347, + tTensorPrism = 348, + tScalarPyramid = 349, + tVectorPyramid = 350, + tTensorPyramid = 351, + tText2D = 352, + tText3D = 353, + tInterpolationMatrix = 354, + tCombine = 355, + tBSpline = 356, + tBezier = 357, + tNurbs = 358, + tOrder = 359, + tWith = 360, + tBounds = 361, + tKnots = 362, + tColor = 363, + tColorTable = 364, + tFor = 365, + tIn = 366, + tEndFor = 367, + tIf = 368, + tEndIf = 369, + tExit = 370, + tReturn = 371, + tCall = 372, + tFunction = 373, + tTrimmed = 374, + tShow = 375, + tHide = 376, + tB_SPLINE_SURFACE_WITH_KNOTS = 377, + tB_SPLINE_CURVE_WITH_KNOTS = 378, + tCARTESIAN_POINT = 379, + tTRUE = 380, + tFALSE = 381, + tUNSPECIFIED = 382, + tU = 383, + tV = 384, + tEDGE_CURVE = 385, + tVERTEX_POINT = 386, + tORIENTED_EDGE = 387, + tPLANE = 388, + tFACE_OUTER_BOUND = 389, + tEDGE_LOOP = 390, + tADVANCED_FACE = 391, + tVECTOR = 392, + tDIRECTION = 393, + tAXIS2_PLACEMENT_3D = 394, + tISO = 395, + tENDISO = 396, + tENDSEC = 397, + tDATA = 398, + tHEADER = 399, + tFILE_DESCRIPTION = 400, + tFILE_SCHEMA = 401, + tFILE_NAME = 402, + tMANIFOLD_SOLID_BREP = 403, + tCLOSED_SHELL = 404, + tADVANCED_BREP_SHAPE_REPRESENTATION = 405, + tFACE_BOUND = 406, + tCYLINDRICAL_SURFACE = 407, + tCONICAL_SURFACE = 408, + tCIRCLE = 409, + tTRIMMED_CURVE = 410, + tGEOMETRIC_SET = 411, + tCOMPOSITE_CURVE_SEGMENT = 412, + tCONTINUOUS = 413, + tCOMPOSITE_CURVE = 414, + tTOROIDAL_SURFACE = 415, + tPRODUCT_DEFINITION = 416, + tPRODUCT_DEFINITION_SHAPE = 417, + tSHAPE_DEFINITION_REPRESENTATION = 418, + tELLIPSE = 419, + tSolid = 420, + tEndSolid = 421, + tVertex = 422, + tFacet = 423, + tNormal = 424, + tOuter = 425, + tLoopSTL = 426, + tEndLoop = 427, + tEndFacet = 428, + tAFFECTDIVIDE = 429, + tAFFECTTIMES = 430, + tAFFECTMINUS = 431, + tAFFECTPLUS = 432, + tOR = 433, + tAND = 434, + tAPPROXEQUAL = 435, + tNOTEQUAL = 436, + tEQUAL = 437, + tGREATEROREQUAL = 438, + tLESSOREQUAL = 439, + tCROSSPRODUCT = 440, + UNARYPREC = 441, + tMINUSMINUS = 442, + tPLUSPLUS = 443 + }; +#endif +#define tDOUBLE 258 +#define tSTRING 259 +#define tBIGSTR 260 +#define tEND 261 +#define tAFFECT 262 +#define tDOTS 263 +#define tPi 264 +#define tMPI_Rank 265 +#define tMPI_Size 266 +#define tExp 267 +#define tLog 268 +#define tLog10 269 +#define tSqrt 270 +#define tSin 271 +#define tAsin 272 +#define tCos 273 +#define tAcos 274 +#define tTan 275 +#define tRand 276 +#define tAtan 277 +#define tAtan2 278 +#define tSinh 279 +#define tCosh 280 +#define tTanh 281 +#define tFabs 282 +#define tFloor 283 +#define tCeil 284 +#define tFmod 285 +#define tModulo 286 +#define tHypot 287 +#define tPrintf 288 +#define tSprintf 289 +#define tStrCat 290 +#define tStrPrefix 291 +#define tBoundingBox 292 +#define tDraw 293 +#define tPoint 294 +#define tCircle 295 +#define tEllipse 296 +#define tLine 297 +#define tSurface 298 +#define tSpline 299 +#define tVolume 300 +#define tCharacteristic 301 +#define tLength 302 +#define tParametric 303 +#define tElliptic 304 +#define tPlane 305 +#define tRuled 306 +#define tTriangulation 307 +#define tTransfinite 308 +#define tComplex 309 +#define tPhysical 310 +#define tUsing 311 +#define tBump 312 +#define tProgression 313 +#define tPlugin 314 +#define tRotate 315 +#define tTranslate 316 +#define tSymmetry 317 +#define tDilate 318 +#define tExtrude 319 +#define tDuplicata 320 +#define tLoop 321 +#define tRecombine 322 +#define tDelete 323 +#define tCoherence 324 +#define tIntersect 325 +#define tAttractor 326 +#define tLayers 327 +#define tScalarPoint 328 +#define tVectorPoint 329 +#define tTensorPoint 330 +#define tScalarLine 331 +#define tVectorLine 332 +#define tTensorLine 333 +#define tScalarTriangle 334 +#define tVectorTriangle 335 +#define tTensorTriangle 336 +#define tScalarQuadrangle 337 +#define tVectorQuadrangle 338 +#define tTensorQuadrangle 339 +#define tScalarTetrahedron 340 +#define tVectorTetrahedron 341 +#define tTensorTetrahedron 342 +#define tScalarHexahedron 343 +#define tVectorHexahedron 344 +#define tTensorHexahedron 345 +#define tScalarPrism 346 +#define tVectorPrism 347 +#define tTensorPrism 348 +#define tScalarPyramid 349 +#define tVectorPyramid 350 +#define tTensorPyramid 351 +#define tText2D 352 +#define tText3D 353 +#define tInterpolationMatrix 354 +#define tCombine 355 +#define tBSpline 356 +#define tBezier 357 +#define tNurbs 358 +#define tOrder 359 +#define tWith 360 +#define tBounds 361 +#define tKnots 362 +#define tColor 363 +#define tColorTable 364 +#define tFor 365 +#define tIn 366 +#define tEndFor 367 +#define tIf 368 +#define tEndIf 369 +#define tExit 370 +#define tReturn 371 +#define tCall 372 +#define tFunction 373 +#define tTrimmed 374 +#define tShow 375 +#define tHide 376 +#define tB_SPLINE_SURFACE_WITH_KNOTS 377 +#define tB_SPLINE_CURVE_WITH_KNOTS 378 +#define tCARTESIAN_POINT 379 +#define tTRUE 380 +#define tFALSE 381 +#define tUNSPECIFIED 382 +#define tU 383 +#define tV 384 +#define tEDGE_CURVE 385 +#define tVERTEX_POINT 386 +#define tORIENTED_EDGE 387 +#define tPLANE 388 +#define tFACE_OUTER_BOUND 389 +#define tEDGE_LOOP 390 +#define tADVANCED_FACE 391 +#define tVECTOR 392 +#define tDIRECTION 393 +#define tAXIS2_PLACEMENT_3D 394 +#define tISO 395 +#define tENDISO 396 +#define tENDSEC 397 +#define tDATA 398 +#define tHEADER 399 +#define tFILE_DESCRIPTION 400 +#define tFILE_SCHEMA 401 +#define tFILE_NAME 402 +#define tMANIFOLD_SOLID_BREP 403 +#define tCLOSED_SHELL 404 +#define tADVANCED_BREP_SHAPE_REPRESENTATION 405 +#define tFACE_BOUND 406 +#define tCYLINDRICAL_SURFACE 407 +#define tCONICAL_SURFACE 408 +#define tCIRCLE 409 +#define tTRIMMED_CURVE 410 +#define tGEOMETRIC_SET 411 +#define tCOMPOSITE_CURVE_SEGMENT 412 +#define tCONTINUOUS 413 +#define tCOMPOSITE_CURVE 414 +#define tTOROIDAL_SURFACE 415 +#define tPRODUCT_DEFINITION 416 +#define tPRODUCT_DEFINITION_SHAPE 417 +#define tSHAPE_DEFINITION_REPRESENTATION 418 +#define tELLIPSE 419 +#define tSolid 420 +#define tEndSolid 421 +#define tVertex 422 +#define tFacet 423 +#define tNormal 424 +#define tOuter 425 +#define tLoopSTL 426 +#define tEndLoop 427 +#define tEndFacet 428 +#define tAFFECTDIVIDE 429 +#define tAFFECTTIMES 430 +#define tAFFECTMINUS 431 +#define tAFFECTPLUS 432 +#define tOR 433 +#define tAND 434 +#define tAPPROXEQUAL 435 +#define tNOTEQUAL 436 +#define tEQUAL 437 +#define tGREATEROREQUAL 438 +#define tLESSOREQUAL 439 +#define tCROSSPRODUCT 440 +#define UNARYPREC 441 +#define tMINUSMINUS 442 +#define tPLUSPLUS 443 + + + + +#if ! defined (YYSTYPE) && ! defined (YYSTYPE_IS_DECLARED) +#line 79 "Gmsh.y" +typedef union YYSTYPE { char *c; int i; unsigned int u; @@ -7,191 +418,14 @@ typedef union { Shape s; List_T *l; } YYSTYPE; -#define tDOUBLE 257 -#define tSTRING 258 -#define tBIGSTR 259 -#define tEND 260 -#define tAFFECT 261 -#define tDOTS 262 -#define tPi 263 -#define tMPI_Rank 264 -#define tMPI_Size 265 -#define tExp 266 -#define tLog 267 -#define tLog10 268 -#define tSqrt 269 -#define tSin 270 -#define tAsin 271 -#define tCos 272 -#define tAcos 273 -#define tTan 274 -#define tRand 275 -#define tAtan 276 -#define tAtan2 277 -#define tSinh 278 -#define tCosh 279 -#define tTanh 280 -#define tFabs 281 -#define tFloor 282 -#define tCeil 283 -#define tFmod 284 -#define tModulo 285 -#define tHypot 286 -#define tPrintf 287 -#define tSprintf 288 -#define tStrCat 289 -#define tStrPrefix 290 -#define tBoundingBox 291 -#define tDraw 292 -#define tPoint 293 -#define tCircle 294 -#define tEllipse 295 -#define tLine 296 -#define tSurface 297 -#define tSpline 298 -#define tVolume 299 -#define tCharacteristic 300 -#define tLength 301 -#define tParametric 302 -#define tElliptic 303 -#define tPlane 304 -#define tRuled 305 -#define tTriangulation 306 -#define tTransfinite 307 -#define tComplex 308 -#define tPhysical 309 -#define tUsing 310 -#define tBump 311 -#define tProgression 312 -#define tPlugin 313 -#define tRotate 314 -#define tTranslate 315 -#define tSymmetry 316 -#define tDilate 317 -#define tExtrude 318 -#define tDuplicata 319 -#define tLoop 320 -#define tRecombine 321 -#define tDelete 322 -#define tCoherence 323 -#define tIntersect 324 -#define tAttractor 325 -#define tLayers 326 -#define tScalarPoint 327 -#define tVectorPoint 328 -#define tTensorPoint 329 -#define tScalarLine 330 -#define tVectorLine 331 -#define tTensorLine 332 -#define tScalarTriangle 333 -#define tVectorTriangle 334 -#define tTensorTriangle 335 -#define tScalarQuadrangle 336 -#define tVectorQuadrangle 337 -#define tTensorQuadrangle 338 -#define tScalarTetrahedron 339 -#define tVectorTetrahedron 340 -#define tTensorTetrahedron 341 -#define tScalarHexahedron 342 -#define tVectorHexahedron 343 -#define tTensorHexahedron 344 -#define tScalarPrism 345 -#define tVectorPrism 346 -#define tTensorPrism 347 -#define tScalarPyramid 348 -#define tVectorPyramid 349 -#define tTensorPyramid 350 -#define tText2D 351 -#define tText3D 352 -#define tCombine 353 -#define tBSpline 354 -#define tBezier 355 -#define tNurbs 356 -#define tOrder 357 -#define tWith 358 -#define tBounds 359 -#define tKnots 360 -#define tColor 361 -#define tColorTable 362 -#define tFor 363 -#define tIn 364 -#define tEndFor 365 -#define tIf 366 -#define tEndIf 367 -#define tExit 368 -#define tReturn 369 -#define tCall 370 -#define tFunction 371 -#define tTrimmed 372 -#define tShow 373 -#define tHide 374 -#define tB_SPLINE_SURFACE_WITH_KNOTS 375 -#define tB_SPLINE_CURVE_WITH_KNOTS 376 -#define tCARTESIAN_POINT 377 -#define tTRUE 378 -#define tFALSE 379 -#define tUNSPECIFIED 380 -#define tU 381 -#define tV 382 -#define tEDGE_CURVE 383 -#define tVERTEX_POINT 384 -#define tORIENTED_EDGE 385 -#define tPLANE 386 -#define tFACE_OUTER_BOUND 387 -#define tEDGE_LOOP 388 -#define tADVANCED_FACE 389 -#define tVECTOR 390 -#define tDIRECTION 391 -#define tAXIS2_PLACEMENT_3D 392 -#define tISO 393 -#define tENDISO 394 -#define tENDSEC 395 -#define tDATA 396 -#define tHEADER 397 -#define tFILE_DESCRIPTION 398 -#define tFILE_SCHEMA 399 -#define tFILE_NAME 400 -#define tMANIFOLD_SOLID_BREP 401 -#define tCLOSED_SHELL 402 -#define tADVANCED_BREP_SHAPE_REPRESENTATION 403 -#define tFACE_BOUND 404 -#define tCYLINDRICAL_SURFACE 405 -#define tCONICAL_SURFACE 406 -#define tCIRCLE 407 -#define tTRIMMED_CURVE 408 -#define tGEOMETRIC_SET 409 -#define tCOMPOSITE_CURVE_SEGMENT 410 -#define tCONTINUOUS 411 -#define tCOMPOSITE_CURVE 412 -#define tTOROIDAL_SURFACE 413 -#define tPRODUCT_DEFINITION 414 -#define tPRODUCT_DEFINITION_SHAPE 415 -#define tSHAPE_DEFINITION_REPRESENTATION 416 -#define tELLIPSE 417 -#define tSolid 418 -#define tEndSolid 419 -#define tVertex 420 -#define tFacet 421 -#define tNormal 422 -#define tOuter 423 -#define tLoopSTL 424 -#define tEndLoop 425 -#define tEndFacet 426 -#define tAFFECTPLUS 427 -#define tAFFECTMINUS 428 -#define tAFFECTTIMES 429 -#define tAFFECTDIVIDE 430 -#define tOR 431 -#define tAND 432 -#define tEQUAL 433 -#define tNOTEQUAL 434 -#define tAPPROXEQUAL 435 -#define tLESSOREQUAL 436 -#define tGREATEROREQUAL 437 -#define tCROSSPRODUCT 438 -#define tPLUSPLUS 439 -#define tMINUSMINUS 440 -#define UNARYPREC 441 - +/* Line 1252 of yacc.c. */ +#line 423 "Gmsh.tab.hpp" +# define yystype YYSTYPE /* obsolescent; will be withdrawn */ +# define YYSTYPE_IS_DECLARED 1 +# define YYSTYPE_IS_TRIVIAL 1 +#endif extern YYSTYPE yylval; + + + diff --git a/Parser/Gmsh.y b/Parser/Gmsh.y index fc7c584cce861990cf38d74a9c5c450af066742b..cb71672f034f98615318a1e0c892adcec216cca0 100644 --- a/Parser/Gmsh.y +++ b/Parser/Gmsh.y @@ -1,5 +1,5 @@ %{ -// $Id: Gmsh.y,v 1.179 2004-10-15 02:30:51 geuzaine Exp $ +// $Id: Gmsh.y,v 1.180 2004-10-20 14:38:59 remacle Exp $ // // Copyright (C) 1997-2004 C. Geuzaine, J.-F. Remacle // @@ -109,7 +109,7 @@ int PrintListOfDouble (char *format, List_T *list, char *buffer); %token tScalarHexahedron tVectorHexahedron tTensorHexahedron %token tScalarPrism tVectorPrism tTensorPrism %token tScalarPyramid tVectorPyramid tTensorPyramid -%token tText2D tText3D tCombine +%token tText2D tText3D tInterpolationMatrix tCombine %token tBSpline tBezier tNurbs tOrder tWith tBounds tKnots %token tColor tColorTable tFor tIn tEndFor tIf tEndIf tExit %token tReturn tCall tFunction tTrimmed tShow tHide @@ -477,6 +477,7 @@ Views : | Views TensorPyramid | Views Text2D | Views Text3D + | Views InterpolationMatrix ; ScalarPointValues : @@ -1267,6 +1268,12 @@ Text3D : } ; +InterpolationMatrix : + tInterpolationMatrix ListOfListOfDouble tEND + { + View -> adaptive = new Adaptive_Post_View ( View , $2 ); + } +; // A F F E C T A T I O N diff --git a/Parser/Gmsh.yy.cpp b/Parser/Gmsh.yy.cpp index cef475984c7d4fb6fdb6a6c22afd95c2dae7604a..31e6b9cf1c72b8736897824a2dc479ee2746c9e8 100644 --- a/Parser/Gmsh.yy.cpp +++ b/Parser/Gmsh.yy.cpp @@ -2,7 +2,7 @@ /* A lexical scanner generated by flex */ /* Scanner skeleton version: - * $Header: /cvsroot/gmsh/Parser/Gmsh.yy.cpp,v 1.203 2004-10-16 22:14:52 geuzaine Exp $ + * $Header: /cvsroot/gmsh/Parser/Gmsh.yy.cpp,v 1.204 2004-10-20 14:38:59 remacle Exp $ */ #define FLEX_SCANNER @@ -10,7 +10,7 @@ #define YY_FLEX_MINOR_VERSION 5 #include <stdio.h> - +#include <errno.h> /* cfront 1.2 defines "c_plusplus" instead of "__cplusplus" */ #ifdef c_plusplus @@ -23,7 +23,9 @@ #ifdef __cplusplus #include <stdlib.h> +#ifndef _WIN32 #include <unistd.h> +#endif /* Use prototypes in function declarations. */ #define YY_USE_PROTOS @@ -63,6 +65,7 @@ #define YY_PROTO(proto) () #endif + /* Returned upon end-of-file. */ #define YY_NULL 0 @@ -283,126 +286,128 @@ static void yy_fatal_error YY_PROTO(( yyconst char msg[] )); *yy_cp = '\0'; \ yy_c_buf_p = yy_cp; -#define YY_NUM_RULES 209 -#define YY_END_OF_BUFFER 210 -static yyconst short int yy_accept[1053] = +#define YY_NUM_RULES 210 +#define YY_END_OF_BUFFER 211 +static yyconst short int yy_accept[1072] = { 0, - 0, 0, 210, 208, 1, 1, 208, 5, 208, 208, - 6, 208, 208, 208, 208, 208, 203, 18, 2, 208, - 13, 208, 207, 207, 207, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 207, 207, 207, 207, 207, - 207, 208, 208, 0, 0, 26, 202, 22, 16, 23, - 14, 24, 15, 0, 205, 0, 0, 0, 0, 3, - 4, 17, 20, 204, 203, 0, 28, 25, 29, 207, - 207, 207, 207, 207, 207, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 207, 207, 207, 207, 207, - - 207, 207, 207, 207, 207, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 207, 207, 76, 75, 207, - 207, 207, 207, 207, 207, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 91, 207, 207, 207, 207, - 207, 207, 207, 138, 141, 126, 123, 132, 135, 129, - 144, 207, 207, 207, 207, 207, 207, 207, 147, 148, - 140, 143, 128, 207, 125, 134, 207, 137, 131, 146, - 207, 207, 207, 207, 139, 142, 127, 124, 133, 136, - 130, 145, 207, 207, 207, 207, 207, 207, 207, 207, - - 207, 207, 21, 27, 0, 0, 19, 0, 154, 155, - 156, 157, 204, 0, 0, 206, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 47, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 207, 207, 60, 207, 207, - 207, 207, 207, 207, 71, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 207, 207, 82, 207, 207, - 207, 207, 207, 207, 207, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 207, 207, 207, 207, 207, - - 207, 207, 105, 207, 207, 207, 207, 207, 207, 207, - 207, 118, 207, 207, 207, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 207, 207, 0, 0, 0, - 205, 0, 0, 204, 207, 207, 207, 207, 30, 207, - 207, 207, 32, 34, 207, 207, 207, 207, 207, 40, - 207, 207, 207, 207, 207, 207, 55, 207, 44, 207, - 207, 207, 207, 207, 207, 46, 172, 207, 207, 207, - 59, 207, 207, 207, 0, 207, 207, 207, 207, 67, - 207, 207, 207, 68, 207, 70, 207, 207, 207, 73, - 207, 0, 207, 207, 166, 207, 207, 80, 207, 81, - - 207, 207, 207, 207, 207, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 207, 102, 207, 207, 207, - 207, 207, 113, 106, 207, 207, 104, 207, 207, 207, - 207, 207, 207, 117, 207, 207, 207, 207, 207, 207, - 207, 122, 207, 207, 207, 207, 197, 10, 9, 8, - 207, 11, 12, 207, 207, 207, 207, 0, 0, 0, - 204, 207, 207, 207, 207, 207, 207, 207, 36, 207, - 207, 207, 207, 207, 207, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 52, 207, 207, 207, 207, 207, - 207, 207, 207, 0, 207, 207, 207, 66, 207, 207, - - 207, 69, 207, 207, 207, 74, 0, 207, 78, 207, - 207, 83, 207, 207, 207, 207, 88, 207, 89, 170, - 207, 207, 207, 92, 207, 93, 94, 207, 207, 207, - 207, 207, 101, 207, 207, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 120, 207, 207, 207, 207, - 207, 207, 194, 207, 207, 196, 201, 207, 0, 0, - 207, 207, 207, 207, 31, 33, 35, 207, 207, 207, - 39, 207, 42, 207, 185, 207, 207, 207, 207, 207, - 207, 49, 207, 207, 207, 207, 207, 56, 57, 207, - 207, 207, 207, 0, 178, 207, 207, 65, 207, 207, - - 207, 207, 207, 207, 207, 207, 171, 0, 207, 84, - 79, 207, 207, 207, 85, 207, 207, 207, 207, 98, - 97, 207, 207, 103, 100, 207, 107, 207, 111, 207, - 207, 207, 207, 207, 207, 207, 207, 207, 167, 207, - 121, 207, 207, 207, 7, 195, 193, 0, 0, 207, - 207, 207, 207, 37, 207, 41, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 207, 207, 45, 51, 207, - 207, 207, 207, 161, 0, 62, 207, 207, 63, 207, - 207, 207, 207, 207, 207, 207, 0, 207, 207, 207, - 207, 207, 207, 207, 207, 207, 207, 207, 110, 207, - - 108, 207, 207, 207, 207, 207, 207, 119, 207, 207, - 198, 207, 0, 0, 207, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 0, 61, 64, 207, 207, 207, - 207, 207, 72, 207, 0, 207, 207, 86, 87, 207, - 207, 207, 90, 207, 207, 207, 207, 109, 207, 207, - 207, 207, 207, 207, 199, 200, 0, 0, 207, 207, - 207, 207, 38, 207, 207, 207, 207, 207, 207, 207, - 207, 207, 50, 207, 168, 58, 207, 160, 0, 207, - 207, 207, 174, 207, 207, 0, 77, 207, 207, 207, - - 207, 207, 99, 207, 112, 207, 207, 207, 116, 207, - 207, 0, 0, 207, 207, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 207, 54, 207, 53, 159, - 0, 164, 207, 207, 207, 207, 0, 207, 207, 207, - 96, 207, 207, 207, 207, 207, 207, 207, 0, 0, - 207, 207, 207, 207, 207, 207, 207, 43, 207, 207, - 207, 207, 207, 207, 0, 207, 207, 173, 207, 0, - 207, 207, 207, 95, 207, 207, 207, 115, 207, 207, - 153, 0, 153, 207, 207, 207, 207, 207, 207, 207, - 179, 207, 207, 207, 207, 0, 207, 207, 207, 176, - - 207, 207, 207, 207, 207, 207, 207, 162, 152, 207, - 165, 152, 207, 207, 207, 207, 207, 207, 207, 207, - 0, 207, 207, 187, 207, 158, 207, 207, 207, 186, - 114, 207, 207, 207, 207, 207, 207, 207, 207, 48, - 0, 207, 207, 207, 207, 207, 207, 207, 207, 207, - 207, 149, 189, 183, 207, 0, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 207, 207, 207, 177, 163, - 175, 207, 207, 207, 184, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 169, 207, 207, 207, 207, - 207, 190, 207, 207, 207, 207, 207, 182, 181, 207, - - 207, 207, 207, 207, 207, 207, 207, 207, 207, 207, - 207, 207, 207, 207, 207, 207, 207, 207, 207, 207, - 207, 207, 188, 207, 207, 207, 207, 207, 191, 207, - 207, 151, 207, 207, 207, 207, 207, 207, 150, 207, - 207, 207, 207, 207, 207, 207, 207, 192, 207, 207, - 180, 0 + 0, 0, 211, 209, 1, 1, 209, 5, 209, 209, + 6, 209, 209, 209, 209, 209, 204, 18, 2, 209, + 13, 209, 208, 208, 208, 208, 208, 208, 208, 208, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 208, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 208, + 208, 209, 209, 0, 0, 26, 203, 22, 16, 23, + 14, 24, 15, 0, 206, 0, 0, 0, 0, 3, + 4, 17, 20, 205, 204, 0, 28, 25, 29, 208, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 208, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 208, + + 208, 208, 208, 208, 208, 208, 208, 208, 208, 208, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 208, + 208, 208, 208, 208, 208, 208, 208, 208, 76, 75, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 208, + 208, 208, 208, 208, 208, 208, 91, 208, 208, 208, + 208, 208, 208, 208, 138, 141, 126, 123, 132, 135, + 129, 144, 208, 208, 208, 208, 208, 208, 208, 147, + 148, 140, 143, 128, 208, 125, 134, 208, 137, 131, + 146, 208, 208, 208, 208, 139, 142, 127, 124, 133, + 136, 130, 145, 208, 208, 208, 208, 208, 208, 208, + + 208, 208, 208, 21, 27, 0, 0, 19, 0, 155, + 156, 157, 158, 205, 0, 0, 207, 208, 208, 208, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 208, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 208, + 208, 208, 208, 208, 208, 47, 208, 208, 208, 208, + 208, 208, 208, 208, 208, 208, 208, 208, 60, 208, + 208, 208, 208, 208, 208, 71, 208, 208, 208, 208, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 82, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 208, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 208, + + 208, 208, 208, 208, 105, 208, 208, 208, 208, 208, + 208, 208, 208, 118, 208, 208, 208, 208, 208, 208, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 0, + 0, 0, 206, 0, 0, 205, 208, 208, 208, 208, + 30, 208, 208, 208, 32, 34, 208, 208, 208, 208, + 208, 40, 208, 208, 208, 208, 208, 208, 55, 208, + 44, 208, 208, 208, 208, 208, 208, 46, 173, 208, + 208, 208, 59, 208, 208, 208, 0, 208, 208, 208, + 208, 67, 208, 208, 208, 68, 208, 70, 208, 208, + 208, 73, 208, 208, 0, 208, 208, 167, 208, 208, + + 80, 208, 81, 208, 208, 208, 208, 208, 208, 208, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 102, + 208, 208, 208, 208, 208, 113, 106, 208, 208, 104, + 208, 208, 208, 208, 208, 208, 117, 208, 208, 208, + 208, 208, 208, 208, 122, 208, 208, 208, 208, 198, + 10, 9, 8, 208, 11, 12, 208, 208, 208, 208, + 0, 0, 0, 205, 208, 208, 208, 208, 208, 208, + 208, 36, 208, 208, 208, 208, 208, 208, 208, 208, + 208, 208, 208, 208, 208, 208, 208, 52, 208, 208, + 208, 208, 208, 208, 208, 208, 0, 208, 208, 208, + + 66, 208, 208, 208, 69, 208, 208, 208, 74, 208, + 0, 208, 78, 208, 208, 83, 208, 208, 208, 208, + 88, 208, 89, 171, 208, 208, 208, 92, 208, 93, + 94, 208, 208, 208, 208, 208, 101, 208, 208, 208, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 120, + 208, 208, 208, 208, 208, 208, 195, 208, 208, 197, + 202, 208, 0, 0, 208, 208, 208, 208, 31, 33, + 35, 208, 208, 208, 39, 208, 42, 208, 186, 208, + 208, 208, 208, 208, 208, 49, 208, 208, 208, 208, + 208, 56, 57, 208, 208, 208, 208, 0, 179, 208, + + 208, 65, 208, 208, 208, 208, 208, 208, 208, 208, + 172, 208, 0, 208, 84, 79, 208, 208, 208, 85, + 208, 208, 208, 208, 98, 97, 208, 208, 103, 100, + 208, 107, 208, 111, 208, 208, 208, 208, 208, 208, + 208, 208, 208, 168, 208, 121, 208, 208, 208, 7, + 196, 194, 0, 0, 208, 208, 208, 208, 37, 208, + 41, 208, 208, 208, 208, 208, 208, 208, 208, 208, + 208, 208, 45, 51, 208, 208, 208, 208, 162, 0, + 62, 208, 208, 63, 208, 208, 208, 208, 208, 208, + 208, 208, 0, 208, 208, 208, 208, 208, 208, 208, + + 208, 208, 208, 208, 110, 208, 108, 208, 208, 208, + 208, 208, 208, 119, 208, 208, 199, 208, 0, 0, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 208, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 208, + 0, 61, 64, 208, 208, 208, 208, 208, 72, 208, + 208, 0, 208, 208, 86, 87, 208, 208, 208, 90, + 208, 208, 208, 208, 109, 208, 208, 208, 208, 208, + 208, 200, 201, 0, 0, 208, 208, 208, 208, 38, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 50, + 208, 169, 58, 208, 161, 0, 208, 208, 208, 175, + + 208, 208, 208, 0, 77, 208, 208, 208, 208, 208, + 99, 208, 112, 208, 208, 208, 116, 208, 208, 0, + 0, 208, 208, 208, 208, 208, 208, 208, 208, 208, + 208, 208, 208, 208, 54, 208, 53, 160, 0, 165, + 208, 208, 208, 208, 208, 0, 208, 208, 208, 96, + 208, 208, 208, 208, 208, 208, 208, 0, 0, 208, + 208, 208, 208, 208, 208, 208, 43, 208, 208, 208, + 208, 208, 208, 0, 208, 208, 174, 208, 208, 0, + 208, 208, 208, 95, 208, 208, 208, 115, 208, 208, + 154, 0, 154, 208, 208, 208, 208, 208, 208, 208, + + 180, 208, 208, 208, 208, 0, 208, 208, 208, 208, + 177, 208, 208, 208, 208, 208, 208, 208, 163, 153, + 208, 166, 153, 208, 208, 208, 208, 208, 208, 208, + 208, 0, 208, 208, 188, 208, 208, 159, 208, 208, + 208, 187, 114, 208, 208, 208, 208, 208, 208, 208, + 208, 48, 0, 208, 208, 208, 208, 208, 208, 208, + 208, 208, 208, 208, 150, 190, 184, 208, 0, 208, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 208, + 208, 208, 178, 164, 176, 208, 208, 208, 208, 185, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 208, + + 208, 170, 208, 208, 208, 208, 208, 208, 191, 208, + 208, 208, 208, 208, 183, 208, 182, 208, 208, 208, + 208, 208, 208, 149, 208, 208, 208, 208, 208, 208, + 208, 208, 208, 208, 208, 208, 208, 208, 208, 208, + 208, 189, 208, 208, 208, 208, 208, 192, 208, 208, + 152, 208, 208, 208, 208, 208, 208, 151, 208, 208, + 208, 208, 208, 208, 208, 208, 193, 208, 208, 181, + 0 } ; static yyconst int yy_ec[256] = @@ -449,247 +454,251 @@ static yyconst int yy_meta[78] = 3, 3, 3, 3, 3, 1, 1 } ; -static yyconst short int yy_base[1058] = +static yyconst short int yy_base[1077] = { 0, - 0, 0, 1317, 52, 53, 1318, 58, 55, 72, 75, + 0, 0, 1336, 52, 53, 1337, 58, 55, 72, 75, 59, 69, 82, 83, 106, 116, 129, 67, 84, 108, 114, 137, 127, 122, 173, 143, 192, 190, 89, 212, - 217, 135, 144, 213, 223, 156, 222, 244, 249, 294, - 353, 157, 395, 232, 252, 248, 159, 257, 165, 186, - 189, 272, 284, 1278, 1278, 1318, 329, 1318, 1318, 1318, - 1318, 1318, 1318, 1302, 358, 1301, 1300, 94, 1299, 1318, - 1318, 1318, 1318, 391, 400, 340, 1318, 1318, 1318, 0, - 1272, 1264, 1271, 1275, 1242, 1252, 1245, 258, 1238, 1260, - 1226, 1230, 1237, 1257, 1256, 1258, 153, 1260, 107, 1235, - - 1242, 1225, 256, 1248, 1249, 1228, 1227, 1236, 1221, 1255, - 1249, 1256, 1221, 1227, 225, 1254, 1244, 1226, 1213, 1212, - 1208, 1211, 1235, 1248, 1217, 1205, 1231, 0, 1199, 1203, - 1229, 1191, 1201, 1200, 43, 1225, 1229, 1206, 1192, 1226, - 1203, 1232, 1217, 1187, 1179, 0, 86, 134, 271, 1189, - 109, 1182, 1189, 1225, 0, 0, 0, 0, 0, 0, - 0, 1184, 1184, 300, 1179, 1178, 1177, 1181, 0, 0, - 0, 0, 0, 1201, 0, 0, 1209, 0, 0, 0, - 1177, 272, 1180, 256, 0, 0, 0, 0, 0, 0, - 0, 0, 1177, 1168, 1182, 1182, 1170, 1161, 1165, 1162, - - 1169, 1162, 1318, 1318, 1191, 1185, 1318, 434, 1318, 1318, - 1318, 1318, 446, 455, 461, 466, 1189, 1201, 1182, 1181, - 1154, 323, 1158, 1157, 1152, 1157, 1178, 1157, 1152, 1149, - 1170, 1186, 1169, 1171, 1177, 1176, 1146, 1144, 1144, 1137, - 1150, 1147, 1137, 325, 1142, 1175, 1170, 1142, 1145, 1123, - 1133, 1165, 1160, 72, 1132, 349, 1121, 0, 1122, 1160, - 1159, 1118, 1121, 1130, 0, 1130, 1146, 1154, 1125, 1115, - 1167, 1122, 1107, 1147, 1119, 1116, 1117, 1156, 1105, 1137, - 1118, 1097, 1114, 1137, 1109, 1126, 1135, 1110, 1092, 1096, - 1101, 1094, 1101, 1092, 1097, 1099, 1088, 1081, 1099, 1094, - - 1109, 1075, 1088, 1086, 1085, 1074, 361, 1086, 1079, 1102, - 1103, 1080, 1074, 320, 1073, 1092, 1091, 1063, 1074, 342, - 1076, 1065, 432, 1067, 1073, 1068, 1057, 1082, 1085, 472, - 490, 499, 504, 509, 1080, 1085, 1082, 1104, 0, 1055, - 1059, 1066, 0, 1100, 1064, 1055, 1078, 1057, 1057, 0, - 1082, 1074, 1080, 1069, 1080, 1068, 0, 1034, 0, 1052, - 1041, 1034, 1033, 1040, 1037, 0, 0, 1071, 1027, 1026, - 0, 1035, 1043, 1053, 1059, 1062, 1024, 1024, 1031, 0, - 1016, 1035, 1034, 0, 1016, 0, 1013, 1053, 1052, 0, - 1010, 1063, 1010, 1008, 0, 1008, 1005, 0, 1059, 0, - - 1043, 298, 1010, 1002, 1032, 1001, 1039, 1022, 1003, 1005, - 1008, 1003, 992, 993, 990, 991, 0, 995, 989, 986, - 1000, 1025, 0, 0, 989, 988, 0, 999, 982, 997, - 992, 1014, 1009, 0, 976, 980, 980, 984, 1002, 1011, - 976, 0, 986, 972, 971, 965, 0, 0, 0, 0, - 978, 0, 0, 981, 964, 976, 974, 996, 999, 514, - 519, 994, 999, 996, 973, 954, 958, 957, 0, 966, - 955, 985, 949, 273, 973, 986, 986, 970, 987, 983, - 948, 955, 952, 951, 962, 941, 948, 959, 946, 945, - 946, 354, 956, 955, 970, 356, 928, 0, 940, 404, - - 511, 0, 934, 949, 950, 0, 976, 921, 0, 920, - 929, 0, 948, 934, 925, 919, 0, 939, 0, 0, - 955, 925, 926, 0, 915, 0, 0, 921, 921, 923, - 911, 918, 0, 922, 916, 901, 900, 913, 914, 897, - 938, 936, 375, 906, 907, 0, 920, 913, 904, 905, - 893, 895, 0, 898, 893, 0, 0, 880, 915, 925, - 913, 921, 922, 908, 0, 0, 930, 876, 889, 906, - 0, 879, 0, 909, 0, 890, 907, 903, 896, 875, - 866, 0, 871, 882, 877, 858, 898, 0, 0, 878, - 884, 889, 898, 887, 0, 187, 865, 0, 868, 884, - - 877, 892, 895, 892, 853, 875, 0, 898, 859, 0, - 0, 878, 849, 836, 0, 882, 866, 839, 856, 0, - 0, 838, 846, 0, 0, 877, 0, 847, 0, 846, - 846, 833, 875, 871, 838, 845, 825, 840, 0, 843, - 0, 837, 826, 831, 0, 0, 0, 845, 856, 843, - 859, 853, 849, 0, 819, 0, 854, 824, 856, 837, - 835, 827, 844, 834, 819, 820, 820, 0, 0, 833, - 801, 828, 830, 0, 856, 0, 798, 812, 0, 820, - 820, 820, 825, 829, 796, 826, 843, 803, 828, 794, - 798, 825, 801, 783, 788, 780, 784, 818, 0, 786, - - 0, 770, 808, 792, 778, 771, 778, 0, 799, 768, - 0, 782, 797, 805, 795, 782, 802, 806, 762, 778, - 802, 789, 794, 796, 781, 795, 754, 748, 757, 51, - 102, 153, 175, 230, 266, 0, 0, 270, 294, 336, - 355, 371, 0, 376, 394, 353, 382, 0, 0, 383, - 413, 382, 0, 388, 398, 425, 383, 0, 407, 432, - 408, 413, 440, 454, 0, 0, 450, 463, 452, 473, - 479, 486, 0, 513, 476, 491, 514, 493, 500, 521, - 484, 488, 0, 494, 0, 0, 522, 0, 537, 525, - 513, 515, 0, 521, 508, 548, 0, 518, 533, 534, - - 510, 500, 0, 533, 0, 524, 523, 499, 0, 500, - 538, 529, 544, 531, 533, 551, 548, 549, 534, 535, - 507, 542, 547, 557, 543, 550, 0, 518, 0, 0, - 570, 0, 538, 557, 566, 549, 576, 555, 567, 566, - 0, 533, 560, 554, 558, 545, 542, 565, 0, 576, - 603, 578, 591, 591, 583, 579, 580, 0, 589, 593, - 585, 601, 581, 563, 619, 609, 596, 0, 608, 622, - 603, 609, 608, 0, 609, 601, 598, 0, 580, 602, - 1318, 0, 0, 607, 619, 680, 620, 604, 621, 619, - 0, 612, 630, 613, 597, 640, 620, 616, 617, 1318, - - 629, 634, 626, 621, 636, 638, 604, 0, 1318, 618, - 0, 0, 632, 642, 647, 635, 628, 648, 631, 623, - 666, 634, 651, 0, 667, 0, 663, 664, 673, 0, - 0, 656, 661, 655, 680, 664, 680, 681, 669, 0, - 695, 675, 675, 664, 672, 678, 691, 687, 669, 674, - 693, 0, 672, 0, 694, 709, 698, 689, 702, 696, - 693, 703, 708, 716, 702, 685, 694, 713, 1318, 0, - 0, 697, 701, 690, 0, 702, 715, 700, 698, 717, - 720, 719, 711, 708, 722, 0, 720, 720, 723, 726, - 716, 708, 731, 710, 711, 719, 727, 0, 0, 722, - - 726, 725, 733, 737, 741, 739, 730, 744, 736, 724, - 738, 752, 749, 739, 741, 746, 738, 743, 741, 743, - 742, 749, 0, 759, 760, 761, 748, 753, 0, 755, - 751, 0, 751, 752, 768, 755, 774, 762, 0, 757, - 758, 770, 779, 766, 762, 769, 775, 0, 770, 772, - 0, 1318, 807, 810, 813, 816, 819 + 220, 135, 144, 237, 235, 156, 241, 254, 265, 310, + 369, 157, 411, 186, 224, 222, 159, 267, 165, 246, + 189, 258, 281, 1297, 1297, 1337, 345, 1337, 1337, 1337, + 1337, 1337, 1337, 1321, 374, 1320, 1319, 94, 1318, 1337, + 1337, 1337, 1337, 407, 416, 356, 1337, 1337, 1337, 0, + 1291, 1283, 1290, 1294, 1261, 1271, 1264, 255, 1257, 1279, + 1245, 1249, 1256, 1276, 1275, 1277, 153, 1279, 107, 1254, + + 1261, 1244, 181, 1267, 1268, 1247, 1246, 1255, 1240, 1274, + 1268, 1275, 1240, 1246, 235, 1273, 1263, 1245, 1232, 1231, + 1227, 1230, 1254, 1267, 1236, 1224, 1245, 1249, 0, 1217, + 1221, 1247, 1209, 1219, 1218, 43, 1243, 1247, 1224, 1210, + 1244, 1221, 1250, 1235, 1205, 1197, 0, 86, 134, 211, + 1207, 109, 1200, 1207, 1243, 0, 0, 0, 0, 0, + 0, 0, 1202, 1202, 256, 1197, 1196, 1195, 1199, 0, + 0, 0, 0, 0, 1219, 0, 0, 1227, 0, 0, + 0, 1195, 268, 1198, 302, 0, 0, 0, 0, 0, + 0, 0, 0, 1195, 1186, 1200, 1200, 1188, 1179, 1183, + + 1180, 1187, 1180, 1337, 1337, 1209, 1203, 1337, 450, 1337, + 1337, 1337, 1337, 462, 471, 477, 482, 1207, 1219, 1200, + 1199, 1172, 304, 1176, 1175, 1170, 1175, 1196, 1175, 1170, + 1167, 1188, 1204, 1187, 1189, 1195, 1194, 1164, 1162, 1162, + 1155, 1168, 1165, 1155, 274, 1160, 1193, 1188, 1160, 1163, + 1141, 1151, 1183, 1178, 72, 1150, 308, 1139, 0, 1140, + 1178, 1177, 1136, 1139, 1148, 0, 1148, 1164, 1172, 1143, + 1133, 1168, 1184, 1139, 1124, 1164, 1136, 1133, 1134, 1173, + 1122, 1154, 1135, 1114, 1131, 1154, 1126, 1143, 1152, 1127, + 1109, 1113, 1118, 1111, 1118, 1109, 1114, 1116, 1105, 1098, + + 1116, 1111, 1126, 1092, 1105, 1103, 1102, 1091, 312, 1103, + 1096, 1119, 1120, 1097, 1091, 196, 1090, 1109, 1108, 1080, + 1091, 326, 1093, 1082, 448, 1084, 1090, 1085, 1074, 1099, + 1102, 488, 506, 515, 520, 525, 1097, 1102, 1099, 1121, + 0, 1072, 1076, 1083, 0, 1117, 1081, 1072, 1095, 1074, + 1074, 0, 1099, 1091, 1097, 1086, 1097, 1085, 0, 1051, + 0, 1069, 1058, 1051, 1050, 1057, 1054, 0, 0, 1088, + 1044, 1043, 0, 1052, 1060, 1070, 1076, 1079, 1041, 1041, + 1048, 0, 1033, 1052, 1051, 0, 1033, 0, 1030, 1070, + 1069, 0, 1027, 1054, 1079, 1026, 1024, 0, 1024, 1021, + + 0, 1075, 0, 1059, 236, 1026, 1018, 1048, 1017, 1055, + 1038, 1019, 1021, 1024, 1019, 1008, 1009, 1006, 1007, 0, + 1011, 1005, 1002, 1016, 1041, 0, 0, 1005, 1004, 0, + 1015, 998, 1013, 1008, 1030, 1025, 0, 992, 996, 996, + 1000, 1018, 1027, 992, 0, 1002, 988, 987, 981, 0, + 0, 0, 0, 994, 0, 0, 997, 980, 992, 990, + 1012, 1015, 530, 535, 1010, 1015, 1012, 989, 970, 974, + 973, 0, 982, 971, 1001, 965, 289, 989, 1002, 1002, + 986, 1003, 999, 964, 971, 968, 967, 978, 957, 964, + 975, 962, 961, 962, 329, 972, 971, 986, 264, 944, + + 0, 956, 340, 356, 0, 950, 965, 966, 0, 967, + 991, 936, 0, 935, 944, 0, 963, 949, 940, 934, + 0, 954, 0, 0, 970, 940, 941, 0, 930, 0, + 0, 936, 936, 938, 926, 933, 0, 937, 931, 916, + 915, 928, 929, 912, 953, 951, 358, 921, 922, 0, + 935, 928, 919, 920, 908, 910, 0, 913, 908, 0, + 0, 895, 930, 940, 928, 936, 937, 923, 0, 0, + 945, 891, 904, 921, 0, 894, 0, 924, 0, 905, + 922, 918, 911, 890, 881, 0, 886, 897, 892, 873, + 913, 0, 0, 893, 899, 904, 913, 902, 0, 322, + + 880, 0, 883, 899, 892, 907, 910, 907, 868, 890, + 0, 892, 912, 873, 0, 0, 892, 863, 850, 0, + 896, 880, 853, 870, 0, 0, 852, 860, 0, 0, + 891, 0, 861, 0, 860, 860, 847, 889, 885, 852, + 859, 839, 854, 0, 857, 0, 851, 840, 845, 0, + 0, 0, 859, 870, 857, 873, 867, 863, 0, 833, + 0, 868, 838, 870, 851, 849, 841, 858, 848, 833, + 834, 834, 0, 0, 847, 815, 842, 844, 0, 870, + 0, 812, 826, 0, 834, 834, 834, 839, 843, 810, + 840, 836, 856, 816, 841, 807, 811, 838, 814, 796, + + 801, 793, 797, 831, 0, 799, 0, 783, 821, 805, + 791, 784, 791, 0, 812, 781, 0, 795, 810, 818, + 808, 795, 815, 819, 775, 790, 812, 797, 800, 84, + 97, 178, 156, 230, 259, 283, 319, 345, 352, 360, + 388, 0, 0, 368, 378, 389, 388, 390, 0, 400, + 403, 421, 371, 391, 0, 0, 395, 420, 389, 0, + 390, 397, 427, 384, 0, 408, 437, 410, 415, 421, + 435, 0, 0, 430, 451, 440, 482, 476, 484, 0, + 486, 450, 468, 499, 504, 511, 532, 495, 499, 0, + 504, 0, 0, 532, 0, 547, 535, 522, 523, 0, + + 529, 516, 524, 557, 0, 527, 542, 543, 519, 509, + 0, 542, 0, 533, 532, 508, 0, 509, 547, 538, + 553, 540, 542, 560, 557, 558, 543, 544, 516, 551, + 556, 566, 552, 559, 0, 527, 0, 0, 579, 0, + 547, 566, 575, 558, 569, 586, 565, 577, 576, 0, + 543, 570, 564, 568, 555, 552, 575, 0, 586, 613, + 588, 601, 601, 593, 589, 590, 0, 599, 603, 595, + 611, 591, 573, 629, 619, 606, 0, 618, 609, 633, + 614, 620, 619, 0, 620, 612, 609, 0, 591, 613, + 1337, 0, 0, 618, 630, 690, 631, 615, 632, 631, + + 0, 623, 641, 624, 608, 651, 631, 627, 628, 635, + 1337, 641, 646, 638, 633, 648, 650, 616, 0, 1337, + 630, 0, 0, 644, 654, 659, 647, 640, 660, 643, + 635, 682, 660, 673, 0, 656, 680, 0, 676, 682, + 691, 0, 0, 674, 674, 668, 693, 677, 693, 694, + 682, 0, 708, 688, 688, 691, 678, 686, 692, 705, + 701, 683, 688, 707, 0, 686, 0, 708, 723, 713, + 704, 718, 718, 712, 708, 718, 723, 731, 717, 700, + 709, 728, 1337, 0, 0, 710, 713, 717, 706, 0, + 718, 731, 716, 714, 733, 736, 722, 736, 728, 727, + + 741, 0, 739, 739, 742, 745, 742, 736, 726, 749, + 728, 729, 737, 745, 0, 735, 0, 741, 745, 744, + 752, 756, 760, 0, 758, 749, 763, 755, 743, 757, + 771, 768, 758, 760, 765, 757, 762, 760, 762, 761, + 768, 0, 778, 779, 780, 767, 772, 0, 774, 770, + 0, 770, 771, 787, 774, 793, 781, 0, 776, 777, + 789, 798, 785, 781, 788, 794, 0, 789, 791, 0, + 1337, 826, 829, 832, 835, 838 } ; -static yyconst short int yy_def[1058] = +static yyconst short int yy_def[1077] = { 0, - 1052, 1, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - - 1053, 1053, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052, 1052, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1052, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1052, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1052, 1052, 1052, - 1052, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1052, 1053, 1053, 1053, 1053, 1053, 1053, - - 1053, 1053, 1053, 1053, 1053, 1053, 1052, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1052, 1052, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1052, 1053, 1053, 1053, 1053, 1053, 1053, - - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1052, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1052, 1052, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1052, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1052, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1052, 1052, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1052, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1052, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1052, 1052, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1052, 1053, - 1053, 1053, 1053, 1053, 1053, 1052, 1053, 1053, 1053, 1053, - - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1052, 1052, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1052, 1053, 1053, 1053, 1053, 1053, 1052, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1054, 1052, - 1055, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1052, 1053, 1053, 1053, 1053, 1052, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1052, 1056, 1053, 1053, 1053, 1057, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1052, 1053, 1053, 1053, 1052, - - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1052, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1052, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1052, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1052, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1052, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, 1053, - 1053, 0, 1052, 1052, 1052, 1052, 1052 + 1071, 1, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + 1071, 1071, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + + 1072, 1072, 1072, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1071, + 1071, 1071, 1071, 1071, 1071, 1071, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1071, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1071, 1072, 1072, 1072, 1072, 1072, + + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1071, 1071, 1071, 1071, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1071, 1072, 1072, 1072, + + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1071, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1071, 1071, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1071, 1072, 1072, + + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1071, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1071, 1071, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1071, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1071, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1071, 1071, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1071, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1071, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1071, 1071, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1071, 1072, 1072, 1072, 1072, + + 1072, 1072, 1072, 1071, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1071, + 1071, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1071, 1072, + 1072, 1072, 1072, 1072, 1072, 1071, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1073, 1071, 1074, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1071, 1072, 1072, 1072, 1072, 1072, 1071, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1071, 1075, 1072, 1072, 1072, 1076, 1072, 1072, 1072, 1072, + + 1072, 1072, 1072, 1072, 1072, 1071, 1072, 1072, 1072, 1072, + 1071, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1071, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1071, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1071, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1071, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1071, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, 1072, + 0, 1071, 1071, 1071, 1071, 1071 } ; -static yyconst short int yy_nxt[1396] = +static yyconst short int yy_nxt[1415] = { 0, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17, 17, 17, 17, 17, 18, 19, @@ -699,155 +708,157 @@ static yyconst short int yy_nxt[1396] = 32, 32, 32, 32, 45, 46, 32, 32, 32, 32, 47, 32, 48, 49, 32, 32, 32, 50, 32, 32, 51, 32, 32, 32, 32, 52, 53, 54, 54, 56, - 54, 58, 375, 54, 54, 57, 57, 57, 57, 57, - 59, 60, 54, 62, 54, 55, 55, 54, 55, 278, + 54, 58, 377, 54, 54, 57, 57, 57, 57, 57, + 59, 60, 54, 62, 54, 55, 55, 54, 55, 280, - 54, 55, 55, 61, 63, 211, 279, 54, 54, 54, - 55, 784, 55, 376, 81, 55, 123, 64, 55, 65, + 54, 55, 55, 61, 63, 212, 281, 54, 54, 54, + 55, 785, 55, 378, 81, 55, 123, 64, 55, 65, 65, 65, 65, 65, 70, 55, 55, 55, 71, 77, - 206, 54, 83, 54, 66, 78, 290, 72, 785, 54, + 207, 54, 83, 54, 66, 78, 292, 72, 786, 54, 74, 54, 75, 75, 75, 75, 75, 81, 67, 68, - 69, 55, 81, 82, 54, 291, 76, 55, 79, 55, - 81, 297, 54, 89, 73, 83, 104, 237, 81, 81, - 83, 90, 55, 84, 105, 238, 91, 298, 83, 85, - 55, 81, 81, 76, 81, 92, 83, 83, 234, 235, - 81, 93, 292, 86, 87, 88, 94, 106, 81, 83, - - 83, 107, 83, 786, 95, 293, 130, 96, 83, 108, - 97, 81, 109, 116, 81, 81, 83, 81, 110, 787, - 98, 117, 197, 99, 183, 139, 111, 100, 112, 83, - 101, 102, 83, 83, 200, 83, 103, 81, 81, 124, - 118, 676, 81, 202, 131, 677, 136, 81, 81, 201, - 119, 120, 113, 121, 114, 83, 83, 81, 127, 122, - 83, 137, 140, 132, 115, 83, 83, 133, 788, 81, - 125, 134, 128, 81, 81, 83, 135, 81, 142, 129, - 789, 316, 81, 257, 143, 126, 138, 83, 141, 258, - 194, 83, 83, 259, 144, 83, 317, 54, 196, 150, - - 83, 145, 146, 151, 147, 204, 790, 148, 224, 54, - 149, 198, 152, 242, 195, 55, 243, 244, 153, 81, - 199, 791, 313, 245, 154, 155, 225, 55, 156, 294, - 314, 572, 157, 158, 295, 159, 160, 83, 514, 515, - 573, 161, 57, 57, 57, 57, 57, 203, 340, 215, - 215, 162, 163, 216, 216, 216, 216, 216, 164, 165, - 304, 792, 166, 167, 341, 342, 305, 168, 169, 170, - 436, 65, 65, 65, 65, 65, 364, 378, 81, 591, - 379, 437, 793, 171, 172, 208, 428, 173, 592, 365, - 174, 175, 176, 177, 178, 179, 83, 443, 794, 429, - - 180, 795, 444, 181, 213, 213, 213, 213, 213, 445, - 796, 74, 208, 75, 75, 75, 75, 75, 214, 182, - 81, 797, 184, 596, 597, 185, 186, 76, 600, 187, - 635, 798, 799, 188, 189, 636, 190, 191, 83, 800, - 801, 601, 192, 330, 330, 214, 802, 331, 331, 331, - 331, 331, 803, 804, 76, 805, 806, 807, 193, 213, - 213, 213, 213, 213, 333, 333, 808, 809, 334, 334, - 334, 334, 334, 332, 216, 216, 216, 216, 216, 216, - 216, 216, 216, 216, 448, 331, 331, 331, 331, 331, - 810, 811, 449, 812, 813, 814, 450, 815, 451, 452, - - 332, 816, 453, 331, 331, 331, 331, 331, 460, 460, - 817, 818, 461, 461, 461, 461, 461, 334, 334, 334, - 334, 334, 334, 334, 334, 334, 334, 461, 461, 461, - 461, 461, 461, 461, 461, 461, 461, 602, 819, 821, - 822, 823, 824, 825, 826, 827, 828, 603, 829, 830, - 831, 832, 604, 833, 820, 834, 835, 836, 837, 838, + 69, 55, 81, 82, 54, 293, 76, 55, 79, 55, + 81, 299, 54, 89, 73, 83, 104, 238, 81, 81, + 83, 90, 55, 84, 105, 239, 91, 300, 83, 85, + 55, 81, 81, 76, 81, 92, 83, 83, 235, 236, + 81, 93, 294, 86, 87, 88, 94, 106, 81, 83, + + 83, 107, 83, 787, 95, 295, 131, 96, 83, 108, + 97, 81, 109, 116, 81, 81, 83, 81, 110, 788, + 98, 117, 198, 99, 184, 140, 111, 100, 112, 83, + 101, 102, 83, 83, 201, 83, 103, 81, 243, 124, + 118, 244, 245, 203, 195, 81, 439, 81, 246, 81, + 119, 120, 113, 121, 114, 83, 127, 440, 137, 122, + 81, 128, 81, 83, 115, 83, 81, 83, 132, 296, + 125, 81, 197, 138, 297, 129, 518, 519, 83, 81, + 83, 141, 130, 54, 83, 126, 196, 133, 143, 83, + 81, 134, 81, 258, 144, 135, 789, 83, 139, 259, + + 136, 55, 205, 260, 145, 225, 54, 142, 83, 202, + 83, 146, 147, 790, 148, 151, 306, 149, 315, 152, + 150, 199, 307, 226, 55, 366, 316, 318, 153, 342, + 200, 600, 601, 204, 154, 81, 380, 431, 367, 381, + 155, 156, 319, 791, 157, 343, 344, 576, 158, 159, + 432, 160, 161, 83, 595, 792, 577, 162, 57, 57, + 57, 57, 57, 596, 604, 216, 216, 163, 164, 217, + 217, 217, 217, 217, 165, 166, 681, 605, 167, 168, + 682, 446, 606, 169, 170, 171, 447, 65, 65, 65, + 65, 65, 607, 448, 81, 793, 794, 608, 795, 172, + + 173, 209, 796, 174, 797, 798, 175, 176, 177, 178, + 179, 180, 83, 640, 799, 800, 181, 801, 641, 182, + 214, 214, 214, 214, 214, 802, 803, 74, 209, 75, + 75, 75, 75, 75, 215, 183, 81, 804, 185, 805, + 806, 186, 187, 76, 807, 188, 808, 809, 810, 189, + 190, 811, 191, 192, 83, 812, 813, 814, 193, 332, + 332, 215, 815, 333, 333, 333, 333, 333, 816, 817, + 76, 818, 819, 820, 194, 214, 214, 214, 214, 214, + 335, 335, 821, 822, 336, 336, 336, 336, 336, 334, + 217, 217, 217, 217, 217, 217, 217, 217, 217, 217, + + 451, 333, 333, 333, 333, 333, 823, 825, 452, 826, + 824, 827, 453, 829, 454, 455, 334, 830, 456, 333, + 333, 333, 333, 333, 463, 463, 831, 828, 464, 464, + 464, 464, 464, 336, 336, 336, 336, 336, 336, 336, + 336, 336, 336, 464, 464, 464, 464, 464, 464, 464, + 464, 464, 464, 832, 833, 834, 835, 836, 837, 838, 839, 840, 841, 842, 843, 844, 845, 846, 847, 848, 849, 850, 851, 852, 853, 854, 855, 856, 857, 858, 859, 860, 861, 862, 863, 864, 865, 866, 867, 868, 869, 870, 871, 872, 873, 874, 875, 876, 877, 878, - 879, 880, 882, 881, 881, 884, 881, 881, 881, 881, - 881, 881, 881, 881, 881, 881, 885, 886, 887, 888, - 889, 881, 881, 881, 881, 881, 890, 891, 892, 893, - 894, 895, 896, 897, 898, 899, 900, 901, 902, 903, - 904, 905, 906, 907, 908, 910, 911, 913, 914, 915, - 916, 881, 917, 918, 919, 920, 921, 922, 923, 924, - 925, 926, 927, 928, 929, 930, 931, 932, 933, 934, - 935, 936, 937, 938, 939, 940, 941, 942, 881, 881, - 909, 909, 943, 909, 909, 909, 909, 909, 909, 909, - 909, 909, 909, 944, 945, 946, 947, 948, 909, 909, - - 909, 909, 909, 949, 950, 951, 952, 953, 954, 955, - 956, 957, 958, 959, 960, 961, 962, 963, 964, 965, - 966, 967, 968, 969, 970, 971, 972, 973, 909, 974, - 975, 976, 977, 978, 979, 980, 981, 982, 983, 984, + 879, 880, 881, 882, 883, 884, 885, 886, 887, 888, + 889, 890, 892, 891, 891, 894, 891, 891, 891, 891, + 891, 891, 891, 891, 891, 891, 895, 896, 897, 898, + 899, 891, 891, 891, 891, 891, 900, 901, 902, 903, + 904, 905, 906, 907, 908, 909, 910, 911, 912, 913, + 914, 915, 916, 917, 918, 919, 921, 922, 924, 925, + 926, 891, 927, 928, 929, 930, 931, 932, 933, 934, + 935, 936, 937, 938, 939, 940, 941, 942, 943, 944, + 945, 946, 947, 948, 949, 950, 951, 952, 891, 891, + 920, 920, 953, 920, 920, 920, 920, 920, 920, 920, + + 920, 920, 920, 954, 955, 956, 957, 958, 920, 920, + 920, 920, 920, 959, 960, 961, 962, 963, 964, 965, + 966, 967, 968, 969, 970, 971, 972, 973, 974, 975, + 976, 977, 978, 979, 980, 981, 982, 983, 920, 984, 985, 986, 987, 988, 989, 990, 991, 992, 993, 994, - 995, 996, 997, 998, 999, 909, 909, 1000, 1001, 1002, - 1003, 1004, 1005, 1006, 1007, 1008, 1009, 1010, 1011, 1012, + 995, 996, 997, 998, 999, 1000, 1001, 1002, 1003, 1004, + 1005, 1006, 1007, 1008, 1009, 920, 920, 1010, 1011, 1012, 1013, 1014, 1015, 1016, 1017, 1018, 1019, 1020, 1021, 1022, 1023, 1024, 1025, 1026, 1027, 1028, 1029, 1030, 1031, 1032, 1033, 1034, 1035, 1036, 1037, 1038, 1039, 1040, 1041, 1042, - 1043, 1044, 1045, 1046, 1047, 1048, 1049, 1050, 1051, 80, - 881, 783, 881, 883, 782, 883, 909, 781, 909, 912, - 780, 912, 779, 778, 777, 776, 775, 774, 773, 772, + 1043, 1044, 1045, 1046, 1047, 1048, 1049, 1050, 1051, 1052, + 1053, 1054, 1055, 1056, 1057, 1058, 1059, 1060, 1061, 1062, + 1063, 1064, 1065, 1066, 1067, 1068, 1069, 1070, 80, 891, + 784, 891, 893, 783, 893, 920, 782, 920, 923, 781, + 923, 780, 779, 778, 777, 776, 775, 774, 773, 772, 771, 770, 769, 768, 767, 766, 765, 764, 763, 762, 761, 760, 759, 758, 757, 756, 755, 754, 753, 752, 751, 750, 749, 748, 747, 746, 745, 744, 743, 742, 741, 740, 739, 738, 737, 736, 735, 734, 733, 732, 731, 730, 729, 728, 727, 726, 725, 724, 723, 722, + 721, 720, 719, 718, 717, 716, 715, 714, 713, 712, 711, 710, 709, 708, 707, 706, 705, 704, 703, 702, - 701, 700, 699, 698, 697, 696, 695, 694, 693, 692, - 691, 690, 689, 688, 687, 686, 685, 684, 683, 682, - 681, 680, 679, 678, 675, 674, 673, 672, 671, 670, + 691, 690, 689, 688, 687, 686, 685, 684, 683, 680, + 679, 678, 677, 676, 675, 674, 673, 672, 671, 670, 669, 668, 667, 666, 665, 664, 663, 662, 661, 660, 659, 658, 657, 656, 655, 654, 653, 652, 651, 650, - 649, 648, 647, 646, 645, 644, 643, 642, 641, 640, - 639, 638, 637, 634, 633, 632, 631, 630, 629, 628, + 649, 648, 647, 646, 645, 644, 643, 642, 639, 638, + 637, 636, 635, 634, 633, 632, 631, 630, 629, 628, 627, 626, 625, 624, 623, 622, 621, 620, 619, 618, - 617, 616, 615, 614, 613, 612, 611, 610, 609, 608, - 607, 606, 605, 599, 598, 595, 594, 593, 590, 589, + 617, 616, 615, 614, 613, 612, 611, 610, 609, 603, + 602, 599, 598, 597, 594, 593, 592, 591, 590, 589, 588, 587, 586, 585, 584, 583, 582, 581, 580, 579, - 578, 577, 576, 575, 574, 571, 570, 569, 568, 567, + 578, 575, 574, 573, 572, 571, 570, 569, 568, 567, 566, 565, 564, 563, 562, 561, 560, 559, 558, 557, 556, 555, 554, 553, 552, 551, 550, 549, 548, 547, 546, 545, 544, 543, 542, 541, 540, 539, 538, 537, 536, 535, 534, 533, 532, 531, 530, 529, 528, 527, - 526, 525, 524, 523, 522, 521, 520, 519, 518, 517, - 516, 513, 512, 511, 510, 509, 508, 507, 506, 505, + 526, 525, 524, 523, 522, 521, 520, 517, 516, 515, + 514, 513, 512, 511, 510, 509, 508, 507, 506, 505, + 504, 503, 502, 501, 500, 499, 498, 497, 496, 495, 494, 493, 492, 491, 490, 489, 488, 487, 486, 485, - 484, 483, 482, 481, 480, 479, 478, 477, 476, 475, 474, 473, 472, 471, 470, 469, 468, 467, 466, 465, - 464, 463, 462, 459, 458, 457, 456, 455, 454, 447, - 446, 442, 441, 440, 439, 438, 435, 434, 433, 432, - 431, 430, 427, 426, 425, 424, 423, 422, 421, 420, + 462, 461, 460, 459, 458, 457, 450, 449, 445, 444, + 443, 442, 441, 438, 437, 436, 435, 434, 433, 430, + 429, 428, 427, 426, 425, 424, 423, 422, 421, 420, 419, 418, 417, 416, 415, 414, 413, 412, 411, 410, 409, 408, 407, 406, 405, 404, 403, 402, 401, 400, 399, 398, 397, 396, 395, 394, 393, 392, 391, 390, - 389, 388, 387, 386, 385, 384, 383, 382, 381, 380, - 377, 374, 373, 372, 371, 370, 369, 368, 367, 366, + 389, 388, 387, 386, 385, 384, 383, 382, 379, 376, + 375, 374, 373, 372, 371, 370, 369, 368, 365, 364, 363, 362, 361, 360, 359, 358, 357, 356, 355, 354, - 353, 352, 351, 350, 349, 348, 347, 346, 345, 344, - 343, 339, 338, 337, 336, 335, 329, 328, 327, 326, - 325, 324, 323, 322, 321, 320, 319, 318, 315, 312, - 311, 310, 309, 308, 307, 306, 303, 302, 301, 300, - 299, 296, 289, 288, 287, 286, 285, 284, 283, 282, - 281, 280, 277, 276, 275, 274, 273, 272, 271, 270, - 269, 268, 267, 266, 265, 264, 263, 262, 261, 260, - 256, 255, 254, 253, 252, 251, 250, 249, 248, 247, - 246, 241, 240, 239, 236, 233, 232, 231, 230, 229, - - 228, 227, 226, 223, 222, 221, 220, 219, 218, 217, - 212, 210, 209, 207, 206, 205, 1052, 3, 1052, 1052, - 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052 + 353, 352, 351, 350, 349, 348, 347, 346, 345, 341, + 340, 339, 338, 337, 331, 330, 329, 328, 327, 326, + 325, 324, 323, 322, 321, 320, 317, 314, 313, 312, + 311, 310, 309, 308, 305, 304, 303, 302, 301, 298, + 291, 290, 289, 288, 287, 286, 285, 284, 283, 282, + 279, 278, 277, 276, 275, 274, 273, 272, 271, 270, + 269, 268, 267, 266, 265, 264, 263, 262, 261, 257, + 256, 255, 254, 253, 252, 251, 250, 249, 248, 247, + 242, 241, 240, 237, 234, 233, 232, 231, 230, 229, + 228, 227, 224, 223, 222, 221, 220, 219, 218, 213, + 211, 210, 208, 207, 206, 1071, 3, 1071, 1071, 1071, + 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + + 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + 1071, 1071, 1071, 1071 } ; -static yyconst short int yy_chk[1396] = +static yyconst short int yy_chk[1415] = { 0, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, @@ -857,152 +868,154 @@ static yyconst short int yy_chk[1396] = 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, 4, 5, 7, - 8, 10, 254, 7, 11, 9, 9, 9, 9, 9, - 12, 13, 18, 14, 12, 4, 5, 9, 8, 135, + 8, 10, 255, 7, 11, 9, 9, 9, 9, 9, + 12, 13, 18, 14, 12, 4, 5, 9, 8, 136, - 10, 7, 11, 13, 14, 68, 135, 13, 14, 19, - 18, 730, 12, 254, 29, 9, 29, 15, 10, 15, + 10, 7, 11, 13, 14, 68, 136, 13, 14, 19, + 18, 730, 12, 255, 29, 9, 29, 15, 10, 15, 15, 15, 15, 15, 16, 13, 14, 19, 16, 20, - 68, 15, 29, 20, 15, 21, 147, 16, 731, 21, + 68, 15, 29, 20, 15, 21, 148, 16, 731, 21, 17, 16, 17, 17, 17, 17, 17, 24, 15, 15, - 15, 20, 23, 23, 17, 147, 17, 21, 22, 16, - 32, 151, 22, 24, 16, 24, 26, 99, 26, 33, - 23, 24, 17, 23, 26, 99, 24, 151, 32, 23, + 15, 20, 23, 23, 17, 148, 17, 21, 22, 16, + 32, 152, 22, 24, 16, 24, 26, 99, 26, 33, + 23, 24, 17, 23, 26, 99, 24, 152, 32, 23, 22, 36, 42, 17, 47, 24, 26, 33, 97, 97, - 49, 24, 148, 23, 23, 23, 25, 26, 25, 36, - - 42, 26, 47, 732, 25, 148, 33, 25, 49, 26, - 25, 50, 26, 28, 51, 28, 25, 27, 27, 733, - 25, 28, 47, 25, 42, 36, 27, 25, 27, 50, - 25, 25, 51, 28, 49, 27, 25, 30, 34, 30, - 28, 596, 31, 51, 34, 596, 35, 37, 35, 50, - 28, 28, 27, 28, 27, 30, 34, 44, 31, 28, - 31, 35, 37, 34, 27, 37, 35, 34, 734, 38, - 30, 34, 31, 46, 39, 44, 34, 45, 38, 31, - 735, 184, 48, 115, 38, 30, 35, 38, 37, 115, - 44, 46, 39, 115, 38, 45, 184, 52, 46, 39, - - 48, 38, 38, 39, 38, 53, 738, 38, 88, 53, - 38, 48, 39, 103, 45, 52, 103, 103, 39, 40, - 48, 739, 182, 103, 40, 40, 88, 53, 40, 149, - 182, 474, 40, 40, 149, 40, 40, 40, 402, 402, - 474, 40, 57, 57, 57, 57, 57, 52, 222, 76, - 76, 40, 40, 76, 76, 76, 76, 76, 40, 40, - 164, 740, 40, 40, 222, 222, 164, 40, 41, 41, - 314, 65, 65, 65, 65, 65, 244, 256, 41, 492, - 256, 314, 741, 41, 41, 65, 307, 41, 492, 244, - 41, 41, 41, 41, 41, 41, 41, 320, 742, 307, - - 41, 744, 320, 41, 74, 74, 74, 74, 74, 320, - 745, 75, 65, 75, 75, 75, 75, 75, 74, 41, - 43, 746, 43, 496, 496, 43, 43, 75, 500, 43, - 543, 747, 750, 43, 43, 543, 43, 43, 43, 751, - 752, 500, 43, 208, 208, 74, 754, 208, 208, 208, - 208, 208, 755, 756, 75, 757, 759, 760, 43, 213, - 213, 213, 213, 213, 214, 214, 761, 762, 214, 214, - 214, 214, 214, 213, 215, 215, 215, 215, 215, 216, - 216, 216, 216, 216, 323, 330, 330, 330, 330, 330, - 763, 764, 323, 767, 768, 769, 323, 770, 323, 323, - - 213, 770, 323, 331, 331, 331, 331, 331, 332, 332, - 771, 772, 332, 332, 332, 332, 332, 333, 333, 333, - 333, 333, 334, 334, 334, 334, 334, 460, 460, 460, - 460, 460, 461, 461, 461, 461, 461, 501, 774, 775, - 776, 777, 778, 779, 780, 781, 782, 501, 784, 787, - 789, 790, 501, 791, 774, 792, 794, 795, 796, 798, - 799, 800, 801, 802, 804, 806, 807, 808, 810, 811, - 812, 813, 814, 815, 816, 817, 818, 819, 820, 821, - 822, 823, 824, 825, 826, 828, 831, 833, 834, 835, - 836, 837, 838, 839, 840, 842, 843, 844, 845, 846, - - 847, 848, 850, 851, 851, 852, 851, 851, 851, 851, - 851, 851, 851, 851, 851, 851, 853, 854, 855, 856, - 857, 851, 851, 851, 851, 851, 859, 860, 861, 862, - 863, 864, 865, 866, 867, 869, 870, 871, 872, 873, - 875, 876, 877, 879, 880, 884, 885, 887, 888, 889, - 890, 851, 892, 893, 894, 895, 896, 897, 898, 899, - 901, 902, 903, 904, 905, 906, 907, 910, 913, 914, - 915, 916, 917, 918, 919, 920, 921, 922, 851, 851, - 886, 886, 923, 886, 886, 886, 886, 886, 886, 886, - 886, 886, 886, 925, 927, 928, 929, 932, 886, 886, - - 886, 886, 886, 933, 934, 935, 936, 937, 938, 939, - 941, 942, 943, 944, 945, 946, 947, 948, 949, 950, - 951, 953, 955, 956, 957, 958, 959, 960, 886, 961, - 962, 963, 964, 965, 966, 967, 968, 972, 973, 974, - 976, 977, 978, 979, 980, 981, 982, 983, 984, 985, - 987, 988, 989, 990, 991, 886, 886, 992, 993, 994, - 995, 996, 997, 1000, 1001, 1002, 1003, 1004, 1005, 1006, - 1007, 1008, 1009, 1010, 1011, 1012, 1013, 1014, 1015, 1016, - 1017, 1018, 1019, 1020, 1021, 1022, 1024, 1025, 1026, 1027, - 1028, 1030, 1031, 1033, 1034, 1035, 1036, 1037, 1038, 1040, - - 1041, 1042, 1043, 1044, 1045, 1046, 1047, 1049, 1050, 1053, - 1054, 729, 1054, 1055, 728, 1055, 1056, 727, 1056, 1057, - 726, 1057, 725, 724, 723, 722, 721, 720, 719, 718, - 717, 716, 715, 714, 713, 712, 710, 709, 707, 706, - 705, 704, 703, 702, 700, 698, 697, 696, 695, 694, - 693, 692, 691, 690, 689, 688, 687, 686, 685, 684, - 683, 682, 681, 680, 678, 677, 675, 673, 672, 671, - 670, 667, 666, 665, 664, 663, 662, 661, 660, 659, - 658, 657, 655, 653, 652, 651, 650, 649, 648, 644, - 643, 642, 640, 638, 637, 636, 635, 634, 633, 632, - - 631, 630, 628, 626, 623, 622, 619, 618, 617, 616, - 614, 613, 612, 609, 608, 606, 605, 604, 603, 602, - 601, 600, 599, 597, 594, 593, 592, 591, 590, 587, - 586, 585, 584, 583, 581, 580, 579, 578, 577, 576, - 574, 572, 570, 569, 568, 567, 564, 563, 562, 561, - 560, 559, 558, 555, 554, 552, 551, 550, 549, 548, - 547, 545, 544, 542, 541, 540, 539, 538, 537, 536, - 535, 534, 532, 531, 530, 529, 528, 525, 523, 522, - 521, 518, 516, 515, 514, 513, 511, 510, 508, 507, - 505, 504, 503, 499, 497, 495, 494, 493, 491, 490, - - 489, 488, 487, 486, 485, 484, 483, 482, 481, 480, - 479, 478, 477, 476, 475, 473, 472, 471, 470, 468, - 467, 466, 465, 464, 463, 462, 459, 458, 457, 456, - 455, 454, 451, 446, 445, 444, 443, 441, 440, 439, - 438, 437, 436, 435, 433, 432, 431, 430, 429, 428, - 426, 425, 422, 421, 420, 419, 418, 416, 415, 414, - 413, 412, 411, 410, 409, 408, 407, 406, 405, 404, - 403, 401, 399, 397, 396, 394, 393, 392, 391, 389, - 388, 387, 385, 383, 382, 381, 379, 378, 377, 376, - 375, 374, 373, 372, 370, 369, 368, 365, 364, 363, - - 362, 361, 360, 358, 356, 355, 354, 353, 352, 351, - 349, 348, 347, 346, 345, 344, 342, 341, 340, 338, - 337, 336, 335, 329, 328, 327, 326, 325, 324, 322, - 321, 319, 318, 317, 316, 315, 313, 312, 311, 310, - 309, 308, 306, 305, 304, 303, 302, 301, 300, 299, - 298, 297, 296, 295, 294, 293, 292, 291, 290, 289, - 288, 287, 286, 285, 284, 283, 282, 281, 280, 279, - 278, 277, 276, 275, 274, 273, 272, 271, 270, 269, - 268, 267, 266, 264, 263, 262, 261, 260, 259, 257, - 255, 253, 252, 251, 250, 249, 248, 247, 246, 245, - - 243, 242, 241, 240, 239, 238, 237, 236, 235, 234, - 233, 232, 231, 230, 229, 228, 227, 226, 225, 224, - 223, 221, 220, 219, 218, 217, 206, 205, 202, 201, - 200, 199, 198, 197, 196, 195, 194, 193, 183, 181, - 177, 174, 168, 167, 166, 165, 163, 162, 154, 153, - 152, 150, 145, 144, 143, 142, 141, 140, 139, 138, - 137, 136, 134, 133, 132, 131, 130, 129, 127, 126, - 125, 124, 123, 122, 121, 120, 119, 118, 117, 116, - 114, 113, 112, 111, 110, 109, 108, 107, 106, 105, - 104, 102, 101, 100, 98, 96, 95, 94, 93, 92, - - 91, 90, 89, 87, 86, 85, 84, 83, 82, 81, - 69, 67, 66, 64, 55, 54, 3, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, 1052, - 1052, 1052, 1052, 1052, 1052 - + 49, 24, 149, 23, 23, 23, 25, 26, 25, 36, + + 42, 26, 47, 732, 25, 149, 33, 25, 49, 26, + 25, 44, 26, 28, 51, 28, 25, 27, 27, 733, + 25, 28, 47, 25, 42, 36, 27, 25, 27, 44, + 25, 25, 51, 28, 49, 27, 25, 30, 103, 30, + 28, 103, 103, 51, 44, 31, 316, 46, 103, 45, + 28, 28, 27, 28, 27, 30, 31, 316, 35, 28, + 35, 31, 34, 31, 27, 46, 37, 45, 34, 150, + 30, 50, 46, 35, 150, 31, 405, 405, 35, 38, + 34, 37, 31, 52, 37, 30, 45, 34, 38, 50, + 39, 34, 48, 115, 38, 34, 734, 38, 35, 115, + + 34, 52, 53, 115, 38, 88, 53, 37, 39, 50, + 48, 38, 38, 735, 38, 39, 165, 38, 183, 39, + 38, 48, 165, 88, 53, 245, 183, 185, 39, 223, + 48, 499, 499, 52, 39, 40, 257, 309, 245, 257, + 40, 40, 185, 736, 40, 223, 223, 477, 40, 40, + 309, 40, 40, 40, 495, 737, 477, 40, 57, 57, + 57, 57, 57, 495, 503, 76, 76, 40, 40, 76, + 76, 76, 76, 76, 40, 40, 600, 503, 40, 40, + 600, 322, 504, 40, 41, 41, 322, 65, 65, 65, + 65, 65, 504, 322, 41, 738, 739, 504, 740, 41, + + 41, 65, 741, 41, 744, 745, 41, 41, 41, 41, + 41, 41, 41, 547, 746, 747, 41, 748, 547, 41, + 74, 74, 74, 74, 74, 750, 751, 75, 65, 75, + 75, 75, 75, 75, 74, 41, 43, 752, 43, 753, + 754, 43, 43, 75, 757, 43, 758, 759, 761, 43, + 43, 762, 43, 43, 43, 763, 764, 766, 43, 209, + 209, 74, 767, 209, 209, 209, 209, 209, 768, 769, + 75, 770, 771, 774, 43, 214, 214, 214, 214, 214, + 215, 215, 775, 776, 215, 215, 215, 215, 215, 214, + 216, 216, 216, 216, 216, 217, 217, 217, 217, 217, + + 325, 332, 332, 332, 332, 332, 777, 778, 325, 779, + 777, 781, 325, 782, 325, 325, 214, 783, 325, 333, + 333, 333, 333, 333, 334, 334, 784, 781, 334, 334, + 334, 334, 334, 335, 335, 335, 335, 335, 336, 336, + 336, 336, 336, 463, 463, 463, 463, 463, 464, 464, + 464, 464, 464, 785, 786, 787, 788, 789, 791, 794, + 796, 797, 798, 799, 801, 802, 803, 804, 806, 807, + 808, 809, 810, 812, 814, 815, 816, 818, 819, 820, + 821, 822, 823, 824, 825, 826, 827, 828, 829, 830, + 831, 832, 833, 834, 836, 839, 841, 842, 843, 844, + + 845, 846, 847, 848, 849, 851, 852, 853, 854, 855, + 856, 857, 859, 860, 860, 861, 860, 860, 860, 860, + 860, 860, 860, 860, 860, 860, 862, 863, 864, 865, + 866, 860, 860, 860, 860, 860, 868, 869, 870, 871, + 872, 873, 874, 875, 876, 878, 879, 880, 881, 882, + 883, 885, 886, 887, 889, 890, 894, 895, 897, 898, + 899, 860, 900, 902, 903, 904, 905, 906, 907, 908, + 909, 910, 912, 913, 914, 915, 916, 917, 918, 921, + 924, 925, 926, 927, 928, 929, 930, 931, 860, 860, + 896, 896, 932, 896, 896, 896, 896, 896, 896, 896, + + 896, 896, 896, 933, 934, 936, 937, 939, 896, 896, + 896, 896, 896, 940, 941, 944, 945, 946, 947, 948, + 949, 950, 951, 953, 954, 955, 956, 957, 958, 959, + 960, 961, 962, 963, 964, 966, 968, 969, 896, 970, + 971, 972, 973, 974, 975, 976, 977, 978, 979, 980, + 981, 982, 986, 987, 988, 989, 991, 992, 993, 994, + 995, 996, 997, 998, 999, 896, 896, 1000, 1001, 1003, + 1004, 1005, 1006, 1007, 1008, 1009, 1010, 1011, 1012, 1013, + 1014, 1016, 1018, 1019, 1020, 1021, 1022, 1023, 1025, 1026, + 1027, 1028, 1029, 1030, 1031, 1032, 1033, 1034, 1035, 1036, + + 1037, 1038, 1039, 1040, 1041, 1043, 1044, 1045, 1046, 1047, + 1049, 1050, 1052, 1053, 1054, 1055, 1056, 1057, 1059, 1060, + 1061, 1062, 1063, 1064, 1065, 1066, 1068, 1069, 1072, 1073, + 729, 1073, 1074, 728, 1074, 1075, 727, 1075, 1076, 726, + 1076, 725, 724, 723, 722, 721, 720, 719, 718, 716, + 715, 713, 712, 711, 710, 709, 708, 706, 704, 703, + 702, 701, 700, 699, 698, 697, 696, 695, 694, 693, + 692, 691, 690, 689, 688, 687, 686, 685, 683, 682, + 680, 678, 677, 676, 675, 672, 671, 670, 669, 668, + 667, 666, 665, 664, 663, 662, 660, 658, 657, 656, + + 655, 654, 653, 649, 648, 647, 645, 643, 642, 641, + 640, 639, 638, 637, 636, 635, 633, 631, 628, 627, + 624, 623, 622, 621, 619, 618, 617, 614, 613, 612, + 610, 609, 608, 607, 606, 605, 604, 603, 601, 598, + 597, 596, 595, 594, 591, 590, 589, 588, 587, 585, + 584, 583, 582, 581, 580, 578, 576, 574, 573, 572, + 571, 568, 567, 566, 565, 564, 563, 562, 559, 558, + 556, 555, 554, 553, 552, 551, 549, 548, 546, 545, + 544, 543, 542, 541, 540, 539, 538, 536, 535, 534, + 533, 532, 529, 527, 526, 525, 522, 520, 519, 518, + + 517, 515, 514, 512, 511, 510, 508, 507, 506, 502, + 500, 498, 497, 496, 494, 493, 492, 491, 490, 489, + 488, 487, 486, 485, 484, 483, 482, 481, 480, 479, + 478, 476, 475, 474, 473, 471, 470, 469, 468, 467, + 466, 465, 462, 461, 460, 459, 458, 457, 454, 449, + 448, 447, 446, 444, 443, 442, 441, 440, 439, 438, + 436, 435, 434, 433, 432, 431, 429, 428, 425, 424, + 423, 422, 421, 419, 418, 417, 416, 415, 414, 413, + 412, 411, 410, 409, 408, 407, 406, 404, 402, 400, + 399, 397, 396, 395, 394, 393, 391, 390, 389, 387, + + 385, 384, 383, 381, 380, 379, 378, 377, 376, 375, + 374, 372, 371, 370, 367, 366, 365, 364, 363, 362, + 360, 358, 357, 356, 355, 354, 353, 351, 350, 349, + 348, 347, 346, 344, 343, 342, 340, 339, 338, 337, + 331, 330, 329, 328, 327, 326, 324, 323, 321, 320, + 319, 318, 317, 315, 314, 313, 312, 311, 310, 308, + 307, 306, 305, 304, 303, 302, 301, 300, 299, 298, + 297, 296, 295, 294, 293, 292, 291, 290, 289, 288, + 287, 286, 285, 284, 283, 282, 281, 280, 279, 278, + 277, 276, 275, 274, 273, 272, 271, 270, 269, 268, + + 267, 265, 264, 263, 262, 261, 260, 258, 256, 254, + 253, 252, 251, 250, 249, 248, 247, 246, 244, 243, + 242, 241, 240, 239, 238, 237, 236, 235, 234, 233, + 232, 231, 230, 229, 228, 227, 226, 225, 224, 222, + 221, 220, 219, 218, 207, 206, 203, 202, 201, 200, + 199, 198, 197, 196, 195, 194, 184, 182, 178, 175, + 169, 168, 167, 166, 164, 163, 155, 154, 153, 151, + 146, 145, 144, 143, 142, 141, 140, 139, 138, 137, + 135, 134, 133, 132, 131, 130, 128, 127, 126, 125, + 124, 123, 122, 121, 120, 119, 118, 117, 116, 114, + + 113, 112, 111, 110, 109, 108, 107, 106, 105, 104, + 102, 101, 100, 98, 96, 95, 94, 93, 92, 91, + 90, 89, 87, 86, 85, 84, 83, 82, 81, 69, + 67, 66, 64, 55, 54, 3, 1071, 1071, 1071, 1071, + 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + + 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, 1071, + 1071, 1071, 1071, 1071 } ; static yy_state_type yy_last_accepting_state; @@ -1019,7 +1032,7 @@ char *yytext; #line 1 "Gmsh.l" #define INITIAL 0 #line 2 "Gmsh.l" -// $Id: Gmsh.yy.cpp,v 1.203 2004-10-16 22:14:52 geuzaine Exp $ +// $Id: Gmsh.yy.cpp,v 1.204 2004-10-20 14:38:59 remacle Exp $ // // Copyright (C) 1997-2004 C. Geuzaine, J.-F. Remacle // @@ -1080,7 +1093,7 @@ void skipline(void); && ferror( yyin ) ) \ YY_FATAL_ERROR( "input in flex scanner failed" ); -#line 1084 "Gmsh.yy.cpp" +#line 1097 "Gmsh.yy.cpp" /* Macros after this point can all be overridden by user definitions in * section 1. @@ -1180,9 +1193,20 @@ YY_MALLOC_DECL YY_FATAL_ERROR( "input in flex scanner failed" ); \ result = n; \ } \ - else if ( ((result = fread( buf, 1, max_size, yyin )) == 0) \ - && ferror( yyin ) ) \ - YY_FATAL_ERROR( "input in flex scanner failed" ); + else \ + { \ + errno=0; \ + while ( (result = fread(buf, 1, max_size, yyin))==0 && ferror(yyin)) \ + { \ + if( errno != EINTR) \ + { \ + YY_FATAL_ERROR( "input in flex scanner failed" ); \ + break; \ + } \ + errno=0; \ + clearerr(yyin); \ + } \ + } #endif /* No semi-colon after return; correct usage is to write "yyterminate();" - @@ -1234,7 +1258,7 @@ YY_DECL #line 80 "Gmsh.l" -#line 1238 "Gmsh.yy.cpp" +#line 1262 "Gmsh.yy.cpp" if ( yy_init ) { @@ -1285,13 +1309,13 @@ yy_match: while ( yy_chk[yy_base[yy_current_state] + yy_c] != yy_current_state ) { yy_current_state = (int) yy_def[yy_current_state]; - if ( yy_current_state >= 1053 ) + if ( yy_current_state >= 1072 ) yy_c = yy_meta[(unsigned int) yy_c]; } yy_current_state = yy_nxt[yy_base[yy_current_state] + (unsigned int) yy_c]; ++yy_cp; } - while ( yy_base[yy_current_state] != 1318 ); + while ( yy_base[yy_current_state] != 1337 ); yy_find_action: yy_act = yy_accept[yy_current_state]; @@ -2059,301 +2083,306 @@ return tText3D; YY_BREAK case 149: YY_RULE_SETUP -#line 253 "Gmsh.l" -return tCARTESIAN_POINT; +#line 251 "Gmsh.l" +return tInterpolationMatrix; YY_BREAK case 150: YY_RULE_SETUP #line 254 "Gmsh.l" -return tB_SPLINE_SURFACE_WITH_KNOTS; +return tCARTESIAN_POINT; YY_BREAK case 151: YY_RULE_SETUP #line 255 "Gmsh.l" -return tB_SPLINE_CURVE_WITH_KNOTS; +return tB_SPLINE_SURFACE_WITH_KNOTS; YY_BREAK case 152: YY_RULE_SETUP #line 256 "Gmsh.l" -return tUNSPECIFIED; +return tB_SPLINE_CURVE_WITH_KNOTS; YY_BREAK case 153: YY_RULE_SETUP #line 257 "Gmsh.l" -return tCONTINUOUS; +return tUNSPECIFIED; YY_BREAK case 154: YY_RULE_SETUP #line 258 "Gmsh.l" -return tFALSE; +return tCONTINUOUS; YY_BREAK case 155: YY_RULE_SETUP #line 259 "Gmsh.l" -return tTRUE; +return tFALSE; YY_BREAK case 156: YY_RULE_SETUP #line 260 "Gmsh.l" -return tU; +return tTRUE; YY_BREAK case 157: YY_RULE_SETUP #line 261 "Gmsh.l" -return tV; +return tU; YY_BREAK case 158: YY_RULE_SETUP #line 262 "Gmsh.l" -return tORIENTED_EDGE; +return tV; YY_BREAK case 159: YY_RULE_SETUP #line 263 "Gmsh.l" -return tEDGE_CURVE; +return tORIENTED_EDGE; YY_BREAK case 160: YY_RULE_SETUP #line 264 "Gmsh.l" -return tEDGE_LOOP; +return tEDGE_CURVE; YY_BREAK case 161: YY_RULE_SETUP #line 265 "Gmsh.l" -return tELLIPSE; +return tEDGE_LOOP; YY_BREAK case 162: YY_RULE_SETUP #line 266 "Gmsh.l" -return tVERTEX_POINT; +return tELLIPSE; YY_BREAK case 163: YY_RULE_SETUP #line 267 "Gmsh.l" -return tFACE_OUTER_BOUND; +return tVERTEX_POINT; YY_BREAK case 164: YY_RULE_SETUP #line 268 "Gmsh.l" -return tFACE_BOUND; +return tFACE_OUTER_BOUND; YY_BREAK case 165: YY_RULE_SETUP #line 269 "Gmsh.l" -return tADVANCED_FACE; +return tFACE_BOUND; YY_BREAK case 166: YY_RULE_SETUP #line 270 "Gmsh.l" -return tLine; +return tADVANCED_FACE; YY_BREAK case 167: YY_RULE_SETUP #line 271 "Gmsh.l" -return tVECTOR; +return tLine; YY_BREAK case 168: YY_RULE_SETUP #line 272 "Gmsh.l" -return tDIRECTION; +return tVECTOR; YY_BREAK case 169: YY_RULE_SETUP #line 273 "Gmsh.l" -return tAXIS2_PLACEMENT_3D; +return tDIRECTION; YY_BREAK case 170: YY_RULE_SETUP #line 274 "Gmsh.l" -return tPLANE; +return tAXIS2_PLACEMENT_3D; YY_BREAK case 171: YY_RULE_SETUP #line 275 "Gmsh.l" -return tHEADER; +return tPLANE; YY_BREAK case 172: YY_RULE_SETUP #line 276 "Gmsh.l" -return tDATA; +return tHEADER; YY_BREAK case 173: YY_RULE_SETUP #line 277 "Gmsh.l" -return tFILE_SCHEMA; +return tDATA; YY_BREAK case 174: YY_RULE_SETUP #line 278 "Gmsh.l" -return tFILE_NAME; +return tFILE_SCHEMA; YY_BREAK case 175: YY_RULE_SETUP #line 279 "Gmsh.l" -return tFILE_DESCRIPTION; +return tFILE_NAME; YY_BREAK case 176: YY_RULE_SETUP #line 280 "Gmsh.l" -return tISO; +return tFILE_DESCRIPTION; YY_BREAK case 177: YY_RULE_SETUP #line 281 "Gmsh.l" -return tENDISO; +return tISO; YY_BREAK case 178: YY_RULE_SETUP #line 282 "Gmsh.l" -return tENDSEC; +return tENDISO; YY_BREAK case 179: YY_RULE_SETUP #line 283 "Gmsh.l" -return tCLOSED_SHELL; +return tENDSEC; YY_BREAK case 180: YY_RULE_SETUP #line 284 "Gmsh.l" -return tADVANCED_BREP_SHAPE_REPRESENTATION; +return tCLOSED_SHELL; YY_BREAK case 181: YY_RULE_SETUP #line 285 "Gmsh.l" -return tMANIFOLD_SOLID_BREP; +return tADVANCED_BREP_SHAPE_REPRESENTATION; YY_BREAK case 182: YY_RULE_SETUP #line 286 "Gmsh.l" -return tCYLINDRICAL_SURFACE; +return tMANIFOLD_SOLID_BREP; YY_BREAK case 183: YY_RULE_SETUP #line 287 "Gmsh.l" -return tCONICAL_SURFACE; +return tCYLINDRICAL_SURFACE; YY_BREAK case 184: YY_RULE_SETUP #line 288 "Gmsh.l" -return tTOROIDAL_SURFACE; +return tCONICAL_SURFACE; YY_BREAK case 185: YY_RULE_SETUP #line 289 "Gmsh.l" -return tCIRCLE; +return tTOROIDAL_SURFACE; YY_BREAK case 186: YY_RULE_SETUP #line 290 "Gmsh.l" -return tTRIMMED_CURVE; +return tCIRCLE; YY_BREAK case 187: YY_RULE_SETUP #line 291 "Gmsh.l" -return tGEOMETRIC_SET; +return tTRIMMED_CURVE; YY_BREAK case 188: YY_RULE_SETUP #line 292 "Gmsh.l" -return tCOMPOSITE_CURVE_SEGMENT; +return tGEOMETRIC_SET; YY_BREAK case 189: YY_RULE_SETUP #line 293 "Gmsh.l" -return tCOMPOSITE_CURVE; +return tCOMPOSITE_CURVE_SEGMENT; YY_BREAK case 190: YY_RULE_SETUP #line 294 "Gmsh.l" -return tPRODUCT_DEFINITION; +return tCOMPOSITE_CURVE; YY_BREAK case 191: YY_RULE_SETUP #line 295 "Gmsh.l" -return tPRODUCT_DEFINITION_SHAPE; +return tPRODUCT_DEFINITION; YY_BREAK case 192: YY_RULE_SETUP #line 296 "Gmsh.l" -return tSHAPE_DEFINITION_REPRESENTATION; +return tPRODUCT_DEFINITION_SHAPE; YY_BREAK case 193: YY_RULE_SETUP -#line 298 "Gmsh.l" -return tVertex; +#line 297 "Gmsh.l" +return tSHAPE_DEFINITION_REPRESENTATION; YY_BREAK case 194: YY_RULE_SETUP #line 299 "Gmsh.l" -return tFacet; +return tVertex; YY_BREAK case 195: YY_RULE_SETUP #line 300 "Gmsh.l" -return tNormal; +return tFacet; YY_BREAK case 196: YY_RULE_SETUP #line 301 "Gmsh.l" -return tOuter; +return tNormal; YY_BREAK case 197: YY_RULE_SETUP #line 302 "Gmsh.l" -return tLoopSTL; +return tOuter; YY_BREAK case 198: YY_RULE_SETUP #line 303 "Gmsh.l" -return tEndLoop; +return tLoopSTL; YY_BREAK case 199: YY_RULE_SETUP #line 304 "Gmsh.l" -return tEndFacet; +return tEndLoop; YY_BREAK case 200: YY_RULE_SETUP #line 305 "Gmsh.l" -{skipline();return tEndSolid;} +return tEndFacet; YY_BREAK case 201: YY_RULE_SETUP #line 306 "Gmsh.l" -{skipline();return tSolid;} +{skipline();return tEndSolid;} YY_BREAK case 202: YY_RULE_SETUP -#line 308 "Gmsh.l" -{yylval.d = (double)atoi((char*)(yytext+1)); return tDOUBLE;} +#line 307 "Gmsh.l" +{skipline();return tSolid;} YY_BREAK case 203: -#line 311 "Gmsh.l" +YY_RULE_SETUP +#line 309 "Gmsh.l" +{yylval.d = (double)atoi((char*)(yytext+1)); return tDOUBLE;} + YY_BREAK case 204: #line 312 "Gmsh.l" case 205: #line 313 "Gmsh.l" case 206: +#line 314 "Gmsh.l" +case 207: YY_RULE_SETUP -#line 313 "Gmsh.l" +#line 314 "Gmsh.l" {yylval.d = atof((char *)yytext); return tDOUBLE;} YY_BREAK -case 207: +case 208: YY_RULE_SETUP -#line 315 "Gmsh.l" +#line 316 "Gmsh.l" {yylval.c = strsave((char*)yytext); return tSTRING;} YY_BREAK -case 208: +case 209: YY_RULE_SETUP -#line 317 "Gmsh.l" +#line 318 "Gmsh.l" return yytext[0]; YY_BREAK -case 209: +case 210: YY_RULE_SETUP -#line 319 "Gmsh.l" +#line 320 "Gmsh.l" ECHO; YY_BREAK -#line 2357 "Gmsh.yy.cpp" +#line 2386 "Gmsh.yy.cpp" case YY_STATE_EOF(INITIAL): yyterminate(); @@ -2645,7 +2674,7 @@ static yy_state_type yy_get_previous_state() while ( yy_chk[yy_base[yy_current_state] + yy_c] != yy_current_state ) { yy_current_state = (int) yy_def[yy_current_state]; - if ( yy_current_state >= 1053 ) + if ( yy_current_state >= 1072 ) yy_c = yy_meta[(unsigned int) yy_c]; } yy_current_state = yy_nxt[yy_base[yy_current_state] + (unsigned int) yy_c]; @@ -2680,11 +2709,11 @@ yy_state_type yy_current_state; while ( yy_chk[yy_base[yy_current_state] + yy_c] != yy_current_state ) { yy_current_state = (int) yy_def[yy_current_state]; - if ( yy_current_state >= 1053 ) + if ( yy_current_state >= 1072 ) yy_c = yy_meta[(unsigned int) yy_c]; } yy_current_state = yy_nxt[yy_base[yy_current_state] + (unsigned int) yy_c]; - yy_is_jam = (yy_current_state == 1052); + yy_is_jam = (yy_current_state == 1071); return yy_is_jam ? 0 : yy_current_state; } @@ -2917,11 +2946,15 @@ YY_BUFFER_STATE b; } +#ifndef _WIN32 +#include <unistd.h> +#else #ifndef YY_ALWAYS_INTERACTIVE #ifndef YY_NEVER_INTERACTIVE extern int isatty YY_PROTO(( int )); #endif #endif +#endif #ifdef YY_USE_PROTOS void yy_init_buffer( YY_BUFFER_STATE b, FILE *file ) @@ -3239,7 +3272,7 @@ int main() return 0; } #endif -#line 319 "Gmsh.l" +#line 320 "Gmsh.l" #undef yywrap diff --git a/Plugin/Plugin.cpp b/Plugin/Plugin.cpp index cd3b0f2a79346465a66894b89c0e07e11bba53d6..c96deed5922fb2db93e30fa5d05cb9cb6d53c94e 100644 --- a/Plugin/Plugin.cpp +++ b/Plugin/Plugin.cpp @@ -1,4 +1,4 @@ -// $Id: Plugin.cpp,v 1.58 2004-08-11 13:28:30 remacle Exp $ +// $Id: Plugin.cpp,v 1.59 2004-10-20 14:38:59 remacle Exp $ // // Copyright (C) 1997-2004 C. Geuzaine, J.-F. Remacle // @@ -155,8 +155,8 @@ GMSH_PluginManager *GMSH_PluginManager::instance() void GMSH_PluginManager::registerDefaultPlugins() { // SOLVE PLUGINS - // allPlugins.insert(std::pair < char *, GMSH_Plugin * > - // ("StructuralSolver", GMSH_RegisterStructuralSolverPlugin())); + allPlugins.insert(std::pair < char *, GMSH_Plugin * > + ("StructuralSolver", GMSH_RegisterStructuralSolverPlugin())); // POST PLUGINS allPlugins.insert(std::pair < char *, GMSH_Plugin * > ("StreamLines", GMSH_RegisterStreamLinesPlugin())); diff --git a/Plugin/StructuralSolver.cpp b/Plugin/StructuralSolver.cpp index 0d2c0a5d3c6157a0fabd5cc02aa8a1c96ac0c4e0..11bbbdda20c8dd917d95d323b721ad715da7e088 100644 --- a/Plugin/StructuralSolver.cpp +++ b/Plugin/StructuralSolver.cpp @@ -59,8 +59,13 @@ Structural_BeamSection:: Structural_BeamSection( const char *direct, std::string void Structural_BeamSection :: computeGeometricalProperties () { - xc=yc=area=0.0; + xc=yc=area=Iy=Iz=0.0; List_T *surfaces = Tree2List (m.Surfaces); + + double M[3][3] = {{1,.5,.5}, + {.5,1,.5}, + {.5,.5,1}}; + for (int i=0;i<List_Nbr(surfaces);++i) { Surface *s; @@ -70,7 +75,7 @@ void Structural_BeamSection :: computeGeometricalProperties () { Simplex *simp; List_Read(triangles,j,&simp); - Vertex v = *simp->V[0]+*simp->V[1]+*simp->V[2]; + Vertex v = (*simp->V[0]+*simp->V[1]+*simp->V[2])*0.333333333333333333; double A = simp->surfsimpl(); area+=A; xc += v.Pos.X*A; @@ -78,10 +83,30 @@ void Structural_BeamSection :: computeGeometricalProperties () } xc/=area; yc/=area; + for(int j=0;j<List_Nbr(triangles);++j) + { + Simplex *simp; + List_Read(triangles,j,&simp); + double A = simp->surfsimpl(); + { + double dy[3] = {simp->V[0]->Pos.Y-yc,simp->V[1]->Pos.Y-yc,simp->V[2]->Pos.Y-yc}; + Iy+= A * + dy[0] * (M[0][0] * dy[0] + M[0][1] * dy[1] + M[0][2] * dy[2]) + + dy[1] * (M[1][0] * dy[0] + M[1][1] * dy[1] + M[1][2] * dy[2]) + + dy[2] * (M[2][0] * dy[0] + M[2][1] * dy[1] + M[2][2] * dy[2]); + } + { + double dy[3] = {simp->V[0]->Pos.X-xc,simp->V[1]->Pos.X-xc,simp->V[2]->Pos.X-xc}; + Iz+= A * + dy[0] * (M[0][0] * dy[0] + M[0][1] * dy[1] + M[0][2] * dy[2]) + + dy[1] * (M[1][0] * dy[0] + M[1][1] * dy[1] + M[1][2] * dy[2]) + + dy[2] * (M[2][0] * dy[0] + M[2][1] * dy[1] + M[2][2] * dy[2]); + } + } List_Delete(triangles); } List_Delete(surfaces); - printf("%s %g %g %g\n",name.c_str(),area,xc,yc); + printf("%s %g %g %g %g %g\n",name.c_str(),area,xc,yc,Iy,Iz); } void Structural_Texture::setup () @@ -367,10 +392,10 @@ StructuralSolver :: ~StructuralSolver () #endif } -Structural_BeamSection * StructuralSolver :: GetBeamSection (const std::string & name) +Structural_BeamSection * StructuralSolver :: GetBeamSection (const std::string & name) const { - std::list<struct Structural_BeamSection* > :: iterator it = beam_sections.begin(); - std::list<struct Structural_BeamSection* > :: iterator ite = beam_sections.end(); + std::list<struct Structural_BeamSection* > :: const_iterator it = beam_sections.begin(); + std::list<struct Structural_BeamSection* > :: const_iterator ite = beam_sections.end(); for (;it!=ite;++it) { @@ -379,6 +404,17 @@ Structural_BeamSection * StructuralSolver :: GetBeamSection (const std::string & } return 0; } +Structural_Material StructuralSolver :: GetMaterial (const std::string & name) const +{ + std::list<struct Structural_Material > :: const_iterator it = materials.begin(); + std::list<struct Structural_Material > :: const_iterator ite = materials.end(); + + for (;it!=ite;++it) + { + if ((*it).name == name) + return *it; + } +} #define BEAM_SECTION_ 3 @@ -557,6 +593,20 @@ void StructuralSolver :: addPhysicalPoint (int id) #endif } +static PhysicalGroup * getPhysical ( int Num , int Dim ) +{ + PhysicalGroup *p; + for(int i = 0; i < List_Nbr(THEM->PhysicalGroups); i++) + { + List_Read(THEM->PhysicalGroups, i, &p); + if(p->Typ == MSH_PHYSICAL_POINT && Dim == 0 && p->Num == Num) return p; + if(p->Typ == MSH_PHYSICAL_LINE && Dim == 1 && p->Num == Num) return p; + if(p->Typ == MSH_PHYSICAL_SURFACE && Dim == 2 && p->Num == Num) return p; + if(p->Typ == MSH_PHYSICAL_VOLUME && Dim == 3 && p->Num == Num) return p; + } + return 0; +} + void StructuralSolver :: writeSolverFile ( const char *geom_file ) const { char name[256]; @@ -569,8 +619,11 @@ void StructuralSolver :: writeSolverFile ( const char *geom_file ) const { const PhysicalLineInfo &i = (*it).second; int id = (*it).first; - fprintf(f,"BEAM PHYSICAL %d SECTION %s MATERIAL %s LOADS %g %g %g %g %g %g %g %g %g \n", - id,i.section.c_str(),i.material.c_str(),i.fx1,i.fy1,i.fx2,i.fy2,i.fz1,i.fz2,i.dirz[0],i.dirz[1],i.dirz[2]); + if (getPhysical ( id , 1 )) + { + fprintf(f,"BEAM PHYSICAL %d SECTION %s MATERIAL %s LOADS %g %g %g %g %g %g %g %g %g \n", + id,i.section.c_str(),i.material.c_str(),i.fx1,i.fy1,i.fx2,i.fy2,i.fz1,i.fz2,i.dirz[0],i.dirz[1],i.dirz[2]); + } } } { @@ -580,7 +633,46 @@ void StructuralSolver :: writeSolverFile ( const char *geom_file ) const { const PhysicalPointInfo &i = (*it).second; int id = (*it).first; - fprintf(f,"NODE %d %g %d %g %d %g %d %g \n",id,i.angle,i.disp[0],i.val[0],i.disp[1],i.val[1],i.disp[2],i.val[2]); + if (getPhysical ( id , 0 )) + { + fprintf(f,"NODE %d %g %d %g %d %g %d %g \n",id,i.angle,i.disp[0],i.val[0],i.disp[1],i.val[1],i.disp[2],i.val[2]); + } + } + } + fclose(f); + sprintf(name,"%s.m",geom_file); + f = fopen(name,"w"); + { + std::map<int,struct PhysicalLineInfo> :: const_iterator it = lines.begin(); + std::map<int,struct PhysicalLineInfo > :: const_iterator ite = lines.end(); + for (;it!=ite;++it) + { + const PhysicalLineInfo &i = (*it).second; + int id = (*it).first; + if (getPhysical ( id , 1 )) + { + Structural_BeamSection* bs = GetBeamSection (i.section); + Structural_Material mt = GetMaterial (i.material); + fprintf(f,"111 %d %g %g %g %g %g %g %g %g %g %g %g %g %g %g %g %g\n", + id, // physical id + bs->area, bs->Iy, bs->Iz, bs->J,// section info + mt.par[0],mt.par[1],mt.par[2],// material info + i.fx1,i.fy1,i.fx2,i.fy2,i.fz1,i.fz2,// lineic loads + i.dirz[0],i.dirz[1],i.dirz[2]); // direction + } + } + } + { + std::map<int,struct PhysicalPointInfo> :: const_iterator it = points.begin(); + std::map<int,struct PhysicalPointInfo > :: const_iterator ite = points.end(); + for (;it!=ite;++it) + { + const PhysicalPointInfo &i = (*it).second; + int id = (*it).first; + if (getPhysical ( id , 0 )) + { + fprintf(f,"222 %d %g %d %g %d %g %d %g \n",id,i.angle,i.disp[0],i.val[0],i.disp[1],i.val[1],i.disp[2],i.val[2]); + } } } fclose(f); @@ -823,11 +915,11 @@ bool StructuralSolver :: GL_enhancePoint ( Vertex *v) const double offset = 0.3 * CTX.gl_fontsize * CTX.pixel_equiv_x; const double l = sqrt (dv[0]*dv[0]+dv[1]*dv[1]); - const double kk = (CTX.max[0]-CTX.min[0])*.1*l / (MAX_FORCE); + const double kk = (CTX.max[0]-CTX.min[0])*.1 / (MAX_FORCE); if (l != 0.0) { glColor4ubv((GLubyte *) & CTX.color.text); - Draw_Vector (CTX.vector_type, 0, 0.5*CTX.arrow_rel_head_radius, + Draw_Vector (CTX.vector_type, 0, CTX.arrow_rel_head_radius, CTX.arrow_rel_stem_length, 0.5*CTX.arrow_rel_stem_radius, v->Pos.X-dv[0]*kk, v->Pos.Y-dv[1]*kk, v->Pos.Z-dv[2]*kk, dv[0]*kk, dv[1]*kk, dv[2]*kk, NULL, CTX.geom.light); diff --git a/Plugin/StructuralSolver.h b/Plugin/StructuralSolver.h index 3c19f2f9a53f611a27bc2a18c7aed76bd0f4c746..25d6eff3f2f9b0b4bac91608aa56a10f0fc238ae 100644 --- a/Plugin/StructuralSolver.h +++ b/Plugin/StructuralSolver.h @@ -54,7 +54,7 @@ struct Structural_Texture struct Structural_BeamSection { Mesh m; - double xc,yc,area,Iy,Iz; + double xc,yc,area,Iy,Iz,J; std::string name; Structural_BeamSection ( const char *direct, std::string _name ); ~Structural_BeamSection(); @@ -104,7 +104,8 @@ class StructuralSolver : public GMSH_Solve_Plugin #endif double MAX_FORCE; double MAX_DISPLACEMENT; - Structural_BeamSection* GetBeamSection (const std::string & name); + Structural_BeamSection* GetBeamSection (const std::string & name) const ; + Structural_Material GetMaterial (const std::string & name) const ; public: StructuralSolver(); virtual ~StructuralSolver();